From 6478404062acd79ccebe75ccd5d4b6bcc3db3bee Mon Sep 17 00:00:00 2001 From: FloWuenne Date: Tue, 3 Dec 2024 23:12:13 -0500 Subject: [PATCH 1/2] Updated Supp Figure 5 and added celltype analysis markdown R1-1 and Figure 3 R2-4. --- analysis/figures.Figure3.Rmd | 175 ++++++-- ...mentary_figure_5.molkart_spatial_plots.Rmd | 151 ++++++- analysis/molkart.celltype_analysis.Rmd | 273 ++++++++++++ review/all_cell_types_per_region_final.csv | 397 ++++++++++++++++++ 4 files changed, 956 insertions(+), 40 deletions(-) create mode 100644 analysis/molkart.celltype_analysis.Rmd create mode 100644 review/all_cell_types_per_region_final.csv diff --git a/analysis/figures.Figure3.Rmd b/analysis/figures.Figure3.Rmd index 6b1ea2e..164fe70 100644 --- a/analysis/figures.Figure3.Rmd +++ b/analysis/figures.Figure3.Rmd @@ -20,27 +20,89 @@ source("./code/functions.R") # Load data ```{r} -abs_counts <- fread("./data/Traditional_IF_absolute_cell_counts.csv") -colnames(abs_counts) <- gsub(" ","_",colnames(abs_counts)) -abs_counts <- abs_counts %>% - pivot_longer(cols = Endo_Pre:BZ_2d, - names_to = "sample", - values_to = "cell_count") %>% - separate(sample, into = c("region","timepoint"), sep = "_") %>% - subset(timepoint != "Pre") - -# Replace abbreviations with full labels -abs_counts$region <- gsub("Endo","Endocard",abs_counts$region) -abs_counts$region <- gsub("Core","Infarct core",abs_counts$region) -abs_counts$region <- gsub("Epi","Epicard",abs_counts$region) -abs_counts$region <- gsub("BZ","Border zone",abs_counts$region) -abs_counts$region <- factor(abs_counts$region, levels = c("Endocard","Infarct core","Epicard","Border zone")) - -abs_counts$timepoint <- gsub("1d","24h",abs_counts$timepoint) -abs_counts$timepoint <- gsub("2d","2 days",abs_counts$timepoint) -abs_counts$timepoint <- factor(abs_counts$timepoint, levels = c("Pre","4h","24h","2 days")) - -abs_plot <- ggplot(abs_counts,aes(timepoint,cell_count)) + +data_path <- "./data/seqIF_regions_annotations/" +cell_locations <- + list.files(path = paste(data_path,"cell_locations",sep=""),pattern = "*.csv") %>% + setNames(., .) %>% + map_df(~fread(paste(paste(data_path,"cell_locations",sep=""),.,sep="/"), select= c("CellID","ROI")), + .id = "sample") %>% + mutate("fov" = gsub("annotated_|.csv","",sample)) + +region_measurements_full <- + list.files(path = paste(data_path,"ROI_measurements",sep=""),pattern = "*.txt") %>% + setNames(., .) %>% + map_df(~fread(paste(paste(data_path,"ROI_measurements",sep=""),.,sep="/")), + .id = "sample") %>% + mutate("fov" = gsub(".txt","",sample)) +colnames(region_measurements_full) <- gsub(" ","_",colnames(region_measurements_full)) +colnames(region_measurements_full) <- gsub("\\^","",colnames(region_measurements_full)) +colnames(region_measurements_full) <- gsub("\\µ","u",colnames(region_measurements_full)) + +## Sum all individual annotations per sample and region +region_measurements <- region_measurements_full %>% + mutate("Area_um2" = if_else(fov %in% c("24h_86","4h_97"),Area_um2 * 0.235^2,Area_um2)) %>% ## Images that were post-registered using palom need to be size corrected, as their final pixel resolution is different + group_by(fov,Name) %>% + summarise("total_area_um2" = sum(Area_um2)) %>% + ungroup() +``` + +## Pixie output + +```{r} +pixie_cell_out <- fread("../data/SeqIF/pixie_cell_masks_0.05/cell_table_size_normalized_cell_labels.csv") +pixie_cell_out <- pixie_cell_out %>% + separate(fov,into = c("time","sample"), remove = FALSE) %>% + subset(cell_meta_cluster != "background") %>% + mutate("CellID" = label) +``` + +## Merge data + +```{r} +annotated_cells <- left_join(pixie_cell_out,cell_locations, by = c("fov","CellID")) +annotated_cells <- annotated_cells %>% + subset(ROI != "Background") + +## Set factor level for time +annotated_cells$time <- factor(annotated_cells$time, + levels = c("Control","4h","24h","48h")) +``` + + +```{r} +## Let's plot the number of cells per cell-type per sample +cells_per_region <- annotated_cells %>% + subset(!ROI %in% c("Unclassified","Ignore")) %>% + subset(!ROI %in% c("PathAnnotationObject","papillary_muscle","Lumen","Background", + "Ignore","RV_ignore","myocardium_control","remote_endocardium")) %>% + group_by(ROI,fov,time,cell_meta_cluster) %>% + tally() + +cells_per_region_sub <- cells_per_region %>% +subset(grepl("Macro|Mono|Leuko|Neutro",cell_meta_cluster)) + +## Normalize cell numbers for area +region_measurements$ROI <- region_measurements$Name +cells_per_region_norm <- left_join(cells_per_region_sub,region_measurements, by = c("fov","ROI")) +cells_per_region_norm <- cells_per_region_norm %>% + mutate("cells_per_mm2" = n / total_area_um2 * 1000000) ## Normalize to square mm +``` + + +```{r} +ccr2_monomacro <- cells_per_region_norm %>% + subset(cell_meta_cluster == "Mono / Macros Ccr2+") %>% + subset(time %in% c("4h","24h","48h")) + +ccr2_monomacro$ROI <- gsub("border_zone","Border zone",ccr2_monomacro$ROI) +ccr2_monomacro$ROI <- gsub("infarct_core","Infarct core",ccr2_monomacro$ROI) +ccr2_monomacro$ROI <- gsub("Epicardium","Epicardium",ccr2_monomacro$ROI) +ccr2_monomacro$ROI <- gsub("Endocardium","Endocardium",ccr2_monomacro$ROI) + +ccr2_monomacro$ROI <- factor(ccr2_monomacro$ROI, + levels = c("Endocardium","Infarct core","Epicardium","Border zone")) + +seqIF_ccr2_relquant <- ggplot(ccr2_monomacro,aes(x = time,y = cells_per_mm2)) + stat_summary( fun.y = mean, geom = "bar", @@ -48,18 +110,69 @@ abs_plot <- ggplot(abs_counts,aes(timepoint,cell_count)) + size = 0.3, color = "black", fill = "lightgrey") + - labs(y = "Absolute cell number") + - geom_beeswarm(size = 2 , pch = 21, color = "black", aes(fill = region)) + - facet_grid(.~ region) + + geom_beeswarm(size = 2, pch = 21, color = "black", aes(fill = ROI)) + + labs(x = "Time", + y = expression("Cells /"~mm^2)) + + #expression(paste("Mo / M",phi," per "~mm^2)) + facet_grid(. ~ ROI) + + scale_fill_manual(values = c("#337272","#f0f0f0","#b062c2","#2c95c5")) + theme(axis.title = element_text(face="bold"), legend.position = "none") + - scale_fill_manual(values = c("#337272","#f0f0f0","#b062c2","#2c95c5")) + theme(panel.border = element_rect(color = "black", fill = NA, size = 0.75)) + theme(axis.text.x = element_text(angle = 45, hjust = 1), - axis.title.x = element_blank()) - -save_plot(filename = "./plots/Figure_3.tradIF-absolute_cell_counts.pdf", - plot = abs_plot, - base_asp = 1.8, - base_height = 3) + axis.title.x = element_blank()) +seqIF_ccr2_relquant + +save_plot(filename = "./plots/Figure_3.SeqIF-absolute_cell_counts.pdf", + plot = seqIF_ccr2_relquant, + base_asp = 1.8, + base_height = 3) +``` + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + ``` diff --git a/analysis/figures.supplementary_figure_5.molkart_spatial_plots.Rmd b/analysis/figures.supplementary_figure_5.molkart_spatial_plots.Rmd index 9429ca5..467329a 100644 --- a/analysis/figures.supplementary_figure_5.molkart_spatial_plots.Rmd +++ b/analysis/figures.supplementary_figure_5.molkart_spatial_plots.Rmd @@ -92,8 +92,8 @@ sample_plots <- lapply(sample_names, function(sample) { scale_color_manual(values = named_colors ) + theme(legend.position = "right", - legend.title = element_text(size = 20), - legend.text = element_text(size = 16)) + # Hide legend or adjust as needed + legend.title = element_text(size = 15), + legend.text = element_text(size = 14)) + # Hide legend or adjust as needed guides(color = guide_legend(title = "Cell types",override.aes = list(size = 6))) + labs(title = "") @@ -104,28 +104,28 @@ sample_plots <- lapply(sample_names, function(sample) { title = "Control", y = "Replicate 1") + theme(plot.tag = element_text(size = 20, face = "bold"), - plot.title = element_text(hjust=0.5, size = 20, face = "bold"), - axis.title.y = element_text(size = 20,angle = 90, face = "bold") + plot.title = element_text(hjust=0.5, size = 15, face = "bold"), + axis.title.y = element_text(size = 15,angle = 90, face = "bold") ) } else if(sample == "sample_4h_r1_s1"){ p <- p + labs(title = "4 hours") + theme(plot.tag = element_text(size = 20, face = "bold"), - plot.title = element_text(hjust=0.5, size = 20, face = "bold")) + plot.title = element_text(hjust=0.5, size = 15, face = "bold")) } else if(sample == "sample_2d_r1_s1"){ p <- p + labs(title = "2 days") + theme(plot.tag = element_text(size = 20, face = "bold"), - plot.title = element_text(hjust=0.5, size = 20, face = "bold")) + plot.title = element_text(hjust=0.5, size = 15, face = "bold")) } else if(sample == "sample_4d_r1_s1"){ p <- p + labs(title = "4 days") + theme(plot.tag = element_text(size = 20, face = "bold"), - plot.title = element_text(hjust=0.5, size = 20, face = "bold")) + plot.title = element_text(hjust=0.5, size = 15, face = "bold")) } else if (sample == "sample_control_r2_s1"){ p <- p + labs(y = "Replicate 2") + - theme(axis.title.y = element_text(size = 20,angle = 90, face = "bold") + theme(axis.title.y = element_text(size = 15,angle = 90, face = "bold") ) } @@ -195,10 +195,143 @@ ct_time_barplot ``` + +## C) Dotplot for subclustering of immune cell types + +```{r} +immune_cells <- subset(seurat_object, + anno_cell_type_lvl2 %in% c("Myeloid_cells","Lymphoid_cells")) +``` + +```{r} +library(viridis) +immune_cells_dotplot <- DotPlot(immune_cells, + features = c("Csf3r","Ccl2","C1qa","Arg1","Cd3e","Ighm","Cd74"), + group.by = "anno_cell_type_lvl3") + + RotatedAxis() + + scale_colour_viridis(option="magma") + + geom_point(aes(size=pct.exp), shape = 21, colour="black", stroke=0.5) + + guides(size=guide_legend(override.aes=list(shape=21, colour="black", fill="black"))) + + labs(tags = "c") + theme(plot.tag = element_text(size = 20, face = "bold")) +immune_cells_dotplot +``` + + +## D) Spatial plot for immune subclustering + +```{r} +## Perform similar rotation correction on images as in main Supplementary Figure 5 +metadata <- immune_cells@meta.data + +## Set sample order for patchwork +sample_names <- c("sample_4h_r1_s1", + "sample_2d_r1_s1", + "sample_4h_r2_s2", + "sample_2d_r2_s1") + +new_metadata <- data.frame() +# For each sample in sample_names, apply a rotation function to x and y positions in metadata +for(sample in sample_names){ + meta_sub <- subset(metadata,sample_ID == sample) + if(sample == "sample_control_r1_s1"){ # rotate 90 degrees counter clockwise + y_orig <- meta_sub$Y_centroid + x_orig <- meta_sub$X_centroid + meta_sub$X_centroid <- y_orig * -1 + meta_sub$Y_centroid <- x_orig + }else if(sample == "sample_control_r2_s1"){ # rotate 90 degrees counter clockwise + meta_sub$X_centroid <- meta_sub$X_centroid * -1 + meta_sub$Y_centroid <- meta_sub$Y_centroid * 1 + }else if(sample == "sample_4h_r1_s1"){ # rotate 90 degrees counter clockwise + meta_sub$X_centroid <- meta_sub$X_centroid * -1 + meta_sub$Y_centroid <- meta_sub$Y_centroid * 1 + }else if(sample == "sample_4h_r2_s2"){ # rotate 90 degrees counter clockwise + y_orig <- meta_sub$Y_centroid + x_orig <- meta_sub$X_centroid + meta_sub$X_centroid <- y_orig * -1 + meta_sub$Y_centroid <- x_orig + }else if(sample == "sample_2d_r1_s1"){ # rotate 90 degrees counter clockwise + meta_sub$X_centroid <- meta_sub$X_centroid * -1 + meta_sub$Y_centroid <- meta_sub$Y_centroid * -1 + }else if(sample == "sample_4d_r2_s1"){ # rotate 90 degrees counter clockwise + y_orig <- meta_sub$Y_centroid + meta_sub$Y_centroid <- meta_sub$X_centroid * -1 + meta_sub$X_centroid <- y_orig * 1 + } + new_metadata <- rbind(new_metadata,meta_sub) +} +new_metadata +``` + + +```{r} +## Make a spatial plot for each sample and organize them using patchwork +sample_plots <- lapply(sample_names, function(sample) { + meta_sub <- subset(new_metadata,sample_ID == sample) + meta_sub$anno_cell_type_lvl3 <- gsub("_"," ",meta_sub$anno_cell_type_lvl3) + + # Generate the plot + ## Add a line of blank space on top of the plot + p <- ggplot(meta_sub, aes(x = X_centroid, + y = Y_centroid, + color = anno_cell_type_lvl3)) + + dark_theme_void() + + geom_point(size = 0.4) + + theme(legend.position = "right", + legend.title = element_text(size = 15), + legend.text = element_text(size = 14)) + # Hide legend or adjust as needed + guides(color = guide_legend(title = "Immune cell types", + override.aes = list(size = 6))) + + labs(title = "") + + ## Manually add tags and titles to plots for visual improvements + if(sample == "sample_control_r1_s1"){ + p <- p + + labs(tag = "a", + title = "Control", + y = "Replicate 1") + + theme(plot.tag = element_text(size = 20, face = "bold"), + plot.title = element_text(hjust=0.5, size = 15, face = "bold"), + axis.title.y = element_text(size = 15,angle = 90, face = "bold") + ) + } else if(sample == "sample_4h_r1_s1"){ + p <- p + + labs(title = "4 hours") + + theme(plot.tag = element_text(size = 20, face = "bold"), + plot.title = element_text(hjust=0.5, size = 15, face = "bold")) + + labs(tags = "d") + theme(plot.tag = element_text(size = 20, face = "bold")) + } else if(sample == "sample_2d_r1_s1"){ + p <- p + + labs(title = "2 days") + + theme(plot.tag = element_text(size = 20, face = "bold"), + plot.title = element_text(hjust=0.5, size = 15, face = "bold")) + } else if(sample == "sample_4d_r1_s1"){ + p <- p + + labs(title = "4 days") + + theme(plot.tag = element_text(size = 20, face = "bold"), + plot.title = element_text(hjust=0.5, size = 15, face = "bold")) + } else if (sample == "sample_control_r2_s1"){ + p <- p + + labs(y = "Replicate 2") + + theme(axis.title.y = element_text(size = 15,angle = 90, face = "bold") + ) + } + + + # Return the plot + return(p) +}) + +spatial_plot_immune_cells <- wrap_plots(sample_plots,ncol = 2, nrows = 2) + plot_layout(guides = "collect") & theme(legend.position = 'right') +spatial_plot_immune_cells +``` + + + ## Merge plots ```{r} -wrapped_plots <- (sample_plots_arranged / ct_time_barplot) + plot_layout(nrow = 2, ncol = 1) +wrapped_plots <- sample_plots_arranged / ct_time_barplot / (immune_cells_dotplot | spatial_plot_immune_cells) + + plot_layout(nrow = 3, ncol = 1) wrapped_plots save_plot(wrapped_plots, diff --git a/analysis/molkart.celltype_analysis.Rmd b/analysis/molkart.celltype_analysis.Rmd new file mode 100644 index 0000000..76fb2d7 --- /dev/null +++ b/analysis/molkart.celltype_analysis.Rmd @@ -0,0 +1,273 @@ +--- +title: "molkart.celltype_analysis" +author: "FloWuenne" +date: "2024-09-08" +output: workflowr::wflow_html +editor_options: + chunk_output_type: inline +--- + +```{r} +library(Seurat) +library(here) +library(patchwork) +library(Nebulosa) +library(here) +library(reactable) +library(ggdark) + +source("../code/functions.R") +``` + +# Introduction + +In this analsysis, we will perform more granular analysis of the cell types we identified in Molecular Cartography and describe what kind of cells are present in the tissue. + +# Load data + +First we load our processed Seurat object that contains all cells and cell-type annotations. + +```{r} +seurat_object <- readRDS(file = "../output/molkart/molkart.seurat_object.rds") + +immune_cells <- subset(seurat_object, + anno_cell_type_lvl2 %in% c("Myeloid_cells","Lymphoid_cells")) +``` + +Next, let's plot a UMAP plot for all three levels of cell-type annotation we did. + +```{r} +celltypes_lvl3 <- DimPlot(seurat_object, reduction = "umap", label = TRUE, repel = TRUE,raster=FALSE, group.by = "anno_cell_type_lvl3") + NoLegend() + + labs (title = "Level 3 cell type annotations") + +celltypes_lvl3 +``` + +# Subcluster immune cells + +```{r} +# Identify variable features +immune_cells <- SCTransform(immune_cells,verbose = FALSE) + +# Rerun PCA and UMAP +immune_cells <- RunPCA(immune_cells, approx=FALSE) + +# Run UMAP +immune_cells <- RunUMAP(immune_cells, dims = 1:25) + +# Subcluster the cells in immune_cells +immune_cells <- FindNeighbors(immune_cells, dims = 1:25, verbose = FALSE) +immune_cells <- FindClusters(immune_cells, verbose = FALSE, resolution = 0.2) + +# Plot the UMAP with the new clusters +DimPlot(immune_cells, reduction = "umap", label = TRUE, repel = TRUE) + +subcluster_umap <- DimPlot(immune_cells, reduction = "umap", label = TRUE, repel = TRUE, group.by = "anno_cell_type_lvl3") +``` + +```{r} +immune_cells <- PrepSCTFindMarkers(immune_cells) +finegrained_markers <- FindAllMarkers(immune_cells, only.pos = TRUE, min.pct = 0.25, logfc.threshold = 0.25) +top3_markers_immunecells <- finegrained_markers %>% + group_by(cluster) %>% + top_n(2, avg_log2FC) +``` + +```{r} +# Show marker table using an interactive table viewer like reactable +reactable::reactable(finegrained_markers,sortable = TRUE, + searchable = TRUE, defaultPageSize = 10) +``` + +Let's visualize expression of "marker genes" for different immune cell types using Nebulosa: + +```{r} +## Plot defined markers for each cell type (Let's make two separate plots for nicer rendering in workflowR pages) +plot_density(immune_cells, c("Csf3r","Ccl2","C1qa","Arg1")) +``` + +```{r} +plot_density(immune_cells,c("Cd3e","Ighm","Cd74")) +``` + + +Let's also plot a heatmap for markers for these more fine grained cell types: + +```{r} +library(viridis) +immune_cells_dotplot <- DotPlot(immune_cells, + features = c("Csf3r","Ccl2","C1qa","Arg1","Cd3e","Ighm","Cd74"), + group.by = "anno_cell_type_lvl3") + + RotatedAxis() + + scale_colour_viridis(option="magma") + + geom_point(aes(size=pct.exp), shape = 21, colour="black", stroke=0.5) + + guides(size=guide_legend(override.aes=list(shape=21, colour="black", fill="black"))) +immune_cells_dotplot +``` + +# Spatial plot of subclustering results for immune cells + +```{r} +## Perform similar rotation correction on images as in main Supplementary Figure 5 +metadata <- immune_cells@meta.data + +## Set sample order for patchwork +sample_names <- c("sample_4h_r1_s1", + "sample_2d_r1_s1", + "sample_4h_r2_s2", + "sample_2d_r2_s1") + +new_metadata <- data.frame() +# For each sample in sample_names, apply a rotation function to x and y positions in metadata +for(sample in sample_names){ + meta_sub <- subset(metadata,sample_ID == sample) + if(sample == "sample_control_r1_s1"){ # rotate 90 degrees counter clockwise + y_orig <- meta_sub$Y_centroid + x_orig <- meta_sub$X_centroid + meta_sub$X_centroid <- y_orig * -1 + meta_sub$Y_centroid <- x_orig + }else if(sample == "sample_control_r2_s1"){ # rotate 90 degrees counter clockwise + meta_sub$X_centroid <- meta_sub$X_centroid * -1 + meta_sub$Y_centroid <- meta_sub$Y_centroid * 1 + }else if(sample == "sample_4h_r1_s1"){ # rotate 90 degrees counter clockwise + meta_sub$X_centroid <- meta_sub$X_centroid * -1 + meta_sub$Y_centroid <- meta_sub$Y_centroid * 1 + }else if(sample == "sample_4h_r2_s2"){ # rotate 90 degrees counter clockwise + y_orig <- meta_sub$Y_centroid + x_orig <- meta_sub$X_centroid + meta_sub$X_centroid <- y_orig * -1 + meta_sub$Y_centroid <- x_orig + }else if(sample == "sample_2d_r1_s1"){ # rotate 90 degrees counter clockwise + meta_sub$X_centroid <- meta_sub$X_centroid * -1 + meta_sub$Y_centroid <- meta_sub$Y_centroid * -1 + }else if(sample == "sample_4d_r2_s1"){ # rotate 90 degrees counter clockwise + y_orig <- meta_sub$Y_centroid + meta_sub$Y_centroid <- meta_sub$X_centroid * -1 + meta_sub$X_centroid <- y_orig * 1 + } + new_metadata <- rbind(new_metadata,meta_sub) +} +new_metadata +``` + + +```{r} +## Make a spatial plot for each sample and organize them using patchwork +sample_plots <- lapply(sample_names, function(sample) { + meta_sub <- subset(new_metadata,sample_ID == sample) + meta_sub$anno_cell_type_lvl3 <- gsub("_"," ",meta_sub$anno_cell_type_lvl3) + + # Generate the plot + ## Add a line of blank space on top of the plot + p <- ggplot(meta_sub, aes(x = X_centroid, + y = Y_centroid, + color = anno_cell_type_lvl3)) + + dark_theme_void() + + geom_point(size = 0.6) + + theme(legend.position = "right", + legend.title = element_text(size = 20), + legend.text = element_text(size = 16)) + # Hide legend or adjust as needed + guides(color = guide_legend(title = "Cell types",override.aes = list(size = 6))) + + labs(title = "") + + ## Manually add tags and titles to plots for visual improvements + if(sample == "sample_control_r1_s1"){ + p <- p + + labs(tag = "a", + title = "Control", + y = "Replicate 1") + + theme(plot.tag = element_text(size = 20, face = "bold"), + plot.title = element_text(hjust=0.5, size = 20, face = "bold"), + axis.title.y = element_text(size = 20,angle = 90, face = "bold") + ) + } else if(sample == "sample_4h_r1_s1"){ + p <- p + + labs(title = "4 hours") + + theme(plot.tag = element_text(size = 20, face = "bold"), + plot.title = element_text(hjust=0.5, size = 20, face = "bold")) + } else if(sample == "sample_2d_r1_s1"){ + p <- p + + labs(title = "2 days") + + theme(plot.tag = element_text(size = 20, face = "bold"), + plot.title = element_text(hjust=0.5, size = 20, face = "bold")) + } else if(sample == "sample_4d_r1_s1"){ + p <- p + + labs(title = "4 days") + + theme(plot.tag = element_text(size = 20, face = "bold"), + plot.title = element_text(hjust=0.5, size = 20, face = "bold")) + } else if (sample == "sample_control_r2_s1"){ + p <- p + + labs(y = "Replicate 2") + + theme(axis.title.y = element_text(size = 20,angle = 90, face = "bold") + ) + } + + + # Return the plot + return(p) +}) + +spatial_plot_immune_cells <- wrap_plots(sample_plots,ncol = 2, nrows = 2) + plot_layout(guides = "collect") & theme(legend.position = 'right') +spatial_plot_immune_cells +``` +# Temporal changes in immune cell subclusters (R3-8) + +```{r} +cell_type_proportions_per_sample <- seurat_object@meta.data %>% + group_by(anno_cell_type_lvl3,timepoint,sample_ID) %>% + tally() %>% + ungroup() %>% + group_by(timepoint,sample_ID) %>% + mutate("percent" = n / sum(n) * 100) %>% + ungroup() + +## Check that percentage sum up to 100 per sample +percent_check <- cell_type_proportions_per_sample %>% + group_by(sample_ID) %>% + summarise("sum" = sum(percent)) + +## Replace underscores in cell names with spaces +cell_type_proportions_per_sample$anno_cell_type_lvl3 <- gsub("_"," ",cell_type_proportions_per_sample$anno_cell_type_lvl3) + +## Set order of cell types in plot from most abundant to least abundant +mean_percent <- cell_type_proportions_per_sample %>% + group_by(timepoint,anno_cell_type_lvl3) %>% + summarise("mean_percent" = mean(percent)) %>% + ungroup() %>% + group_by(timepoint) %>% + arrange(desc(mean_percent)) + +cell_type_proportions_per_sample$anno_cell_type_lvl3 <- factor(cell_type_proportions_per_sample$anno_cell_type_lvl3, + levels = subset(mean_percent,timepoint == "control")$anno_cell_type_lvl3) + +## Calculate mean cell number per timepoint +mean_percent <- cell_type_proportions_per_sample %>% + mutate("anno_cell_type_lvl3" = if_else(grepl("Myeloid cells",anno_cell_type_lvl3),"Myeloid_cells",anno_cell_type_lvl3)) %>% ## Merge myeloid cells into one group for calculations + group_by(timepoint,anno_cell_type_lvl3) %>% + summarise("mean_percent" = mean(percent)) %>% + ungroup() + +## Subset for only immune cells +cell_type_proportions_per_sample <- cell_type_proportions_per_sample %>% + filter(anno_cell_type_lvl3 %in% c("DC Cd74","Lymphoid cells Cd3e","Mono/Macros Arg1+","Mono/Macros C1qa","Mono/Macros Ccl2", + "Neutrophils Csf3r")) + +ct_time_barplot <- ggplot(cell_type_proportions_per_sample,aes(timepoint,percent,fill = anno_cell_type_lvl3)) + + geom_bar(position='dodge', stat='summary', fun='mean', color = "black") + + # Add points for each fill group on top of bars + geom_point(position=position_dodge(width=0.9), aes(group=anno_cell_type_lvl3), size=2.5, shape=21, fill="white", color="black") + + #scale_fill_manual(values = named_colors, name = "Cell types") + + labs(x = " Timepoint", + y = "% total cells", + fill = "Cell types") + + theme_minimal() + + theme(legend.text=element_text(size=18), + legend.title = element_text(size=20), + legend.position = "right", + axis.title = element_text(size=18), + axis.text = element_text(size=18)) + + +ct_time_barplot <- ct_time_barplot + theme(plot.tag = element_text(size = 20, face = "bold")) +ct_time_barplot +``` diff --git a/review/all_cell_types_per_region_final.csv b/review/all_cell_types_per_region_final.csv new file mode 100644 index 0000000..84d65cc --- /dev/null +++ b/review/all_cell_types_per_region_final.csv @@ -0,0 +1,397 @@ +final_cell_type,region_name,timepoint,mean_count,se_count +Cardiomyocytes,All,Control,2766.182822745041,211.76770709274467 +Cardiomyocytes,All,4h,2398.677543351754,166.17041719996584 +Cardiomyocytes,All,24h,1881.700507983594,295.12850372512924 +Cardiomyocytes,All,48h,1391.945677457304,113.75149259181477 +Cardiomyocytes,"Near-Infarct +Endocardial Region",Control,3543.7502762411677,298.6926302628546 +Cardiomyocytes,"Near-Infarct +Endocardial Region",4h,3166.182766758962,172.23992632429005 +Cardiomyocytes,"Near-Infarct +Endocardial Region",24h,2652.6773902843315,165.59144599225462 +Cardiomyocytes,"Near-Infarct +Endocardial Region",48h,2319.0010457457647,387.3989656361293 +Cardiomyocytes,"Remote +Endocardial Region",Control,3543.7502762411677,298.6926302628546 +Cardiomyocytes,"Remote +Endocardial Region",4h,5290.592783948997,88.44820269118645 +Cardiomyocytes,"Remote +Endocardial Region",24h,4069.7549058952945,332.4852191611578 +Cardiomyocytes,"Remote +Endocardial Region",48h,3569.539808836306,744.9379150062673 +Cardiomyocytes,Infarct Core,Control,2531.4555419607273,158.0403238177466 +Cardiomyocytes,Infarct Core,4h,1524.4106961830544,575.0573323010161 +Cardiomyocytes,Infarct Core,24h,484.1210698325119,375.9244835900313 +Cardiomyocytes,Infarct Core,48h,62.764353757944576,19.466878427433787 +Cardiomyocytes,Border zone,Control,2488.3449331382276,180.4353398397135 +Cardiomyocytes,Border zone,4h,1801.7247704163342,253.92765866656111 +Cardiomyocytes,Border zone,24h,1161.485419993659,150.1085138033546 +Cardiomyocytes,Border zone,48h,604.5999432603792,48.47870428281254 +Cardiomyocytes,"Near-Infarct +Epicardial Region",Control,3497.227287429357,96.13461425345379 +Cardiomyocytes,"Near-Infarct +Epicardial Region",4h,3116.51900434212,864.5605666149992 +Cardiomyocytes,"Near-Infarct +Epicardial Region",24h,2445.5858974413604,392.68077505614156 +Cardiomyocytes,"Near-Infarct +Epicardial Region",48h,393.88224055416015,20.294241206273597 +Cardiomyocytes Ankrd1+,All,Control,20.542948541971388,17.272677326547985 +Cardiomyocytes Ankrd1+,All,4h,743.8995676672047,370.6435972612261 +Cardiomyocytes Ankrd1+,All,24h,817.095944154433,210.0820333409424 +Cardiomyocytes Ankrd1+,All,48h,743.3669591004123,53.509437644004144 +Cardiomyocytes Ankrd1+,"Near-Infarct +Endocardial Region",Control,21.25952057529774,16.02930331535508 +Cardiomyocytes Ankrd1+,"Near-Infarct +Endocardial Region",4h,238.44231759588422,177.16278577412191 +Cardiomyocytes Ankrd1+,"Near-Infarct +Endocardial Region",24h,190.56284471750416,114.18699549591645 +Cardiomyocytes Ankrd1+,"Near-Infarct +Endocardial Region",48h,143.70193085495117,20.23477705103265 +Cardiomyocytes Ankrd1+,"Remote +Endocardial Region",Control,21.25952057529774,16.02930331535508 +Cardiomyocytes Ankrd1+,"Remote +Endocardial Region",4h,21.63575049334648,4.560877688342724 +Cardiomyocytes Ankrd1+,"Remote +Endocardial Region",24h,25.91237454414174,2.984040559472715 +Cardiomyocytes Ankrd1+,"Remote +Endocardial Region",48h,0.0,0.0 +Cardiomyocytes Ankrd1+,Infarct Core,Control,10.436803916124875,7.9748687689206 +Cardiomyocytes Ankrd1+,Infarct Core,4h,1556.4470785627632,637.5263087371828 +Cardiomyocytes Ankrd1+,Infarct Core,24h,2559.9310089731816,371.8100618186049 +Cardiomyocytes Ankrd1+,Infarct Core,48h,2214.8483666606508,474.52772760284796 +Cardiomyocytes Ankrd1+,Border zone,Control,10.67076592936323,8.798135132615164 +Cardiomyocytes Ankrd1+,Border zone,4h,1267.238578406937,571.748676505978 +Cardiomyocytes Ankrd1+,Border zone,24h,1488.217498642845,97.05128505763217 +Cardiomyocytes Ankrd1+,Border zone,48h,1468.7229644605545,67.66361260019926 +Cardiomyocytes Ankrd1+,"Near-Infarct +Epicardial Region",Control,59.488206786825394,35.3526344852786 +Cardiomyocytes Ankrd1+,"Near-Infarct +Epicardial Region",4h,1156.8442762918296,935.173931483081 +Cardiomyocytes Ankrd1+,"Near-Infarct +Epicardial Region",24h,1737.36959376351,469.2078890305836 +Cardiomyocytes Ankrd1+,"Near-Infarct +Epicardial Region",48h,2919.830856885488,909.446136430349 +Endocardial cells,All,Control,29.850805731512292,3.0084689249009657 +Endocardial cells,All,4h,32.9247302712768,2.1583201022733713 +Endocardial cells,All,24h,43.58262638508211,5.299937621979026 +Endocardial cells,All,48h,50.75201317265421,7.531379009058077 +Endocardial cells,"Near-Infarct +Endocardial Region",Control,623.2008354883427,131.4525762558767 +Endocardial cells,"Near-Infarct +Endocardial Region",4h,366.03730123545745,7.4760355829031075 +Endocardial cells,"Near-Infarct +Endocardial Region",24h,536.5376251582583,66.82615244549388 +Endocardial cells,"Near-Infarct +Endocardial Region",48h,540.2906937608384,12.842155280716554 +Endocardial cells,"Remote +Endocardial Region",Control,623.2008354883427,131.4525762558767 +Endocardial cells,"Remote +Endocardial Region",4h,509.9414834722355,48.91991773713414 +Endocardial cells,"Remote +Endocardial Region",24h,472.834841980172,20.124338690212113 +Endocardial cells,"Remote +Endocardial Region",48h,388.4153034403312,48.45645613871479 +Endocardial cells,Infarct Core,Control,3.723262733152041,0.0 +Endocardial cells,Infarct Core,4h,0.0,0.0 +Endocardial cells,Infarct Core,24h,0.0,0.0 +Endocardial cells,Infarct Core,48h,1.923537594979611,0.0 +Endocardial cells,Border zone,Control,33.63191430820273,13.848069683978233 +Endocardial cells,Border zone,4h,39.76165382287171,0.1894690722129084 +Endocardial cells,Border zone,24h,15.74417449916523,5.966224864174639 +Endocardial cells,Border zone,48h,31.521041907638242,0.5188648647318548 +Endocardial cells,"Near-Infarct +Epicardial Region",Control,0.0,0.0 +Endocardial cells,"Near-Infarct +Epicardial Region",4h,0.0,0.0 +Endocardial cells,"Near-Infarct +Epicardial Region",24h,0.0,0.0 +Endocardial cells,"Near-Infarct +Epicardial Region",48h,0.0,0.0 +Endothelial cells,All,Control,700.6511222601393,212.62866014547683 +Endothelial cells,All,4h,463.59354026093933,57.552975393365415 +Endothelial cells,All,24h,480.502729188884,73.95294191316964 +Endothelial cells,All,48h,814.4191068507431,271.18152772899487 +Endothelial cells,"Near-Infarct +Endocardial Region",Control,530.2844473771587,216.7981886380764 +Endothelial cells,"Near-Infarct +Endocardial Region",4h,403.71026537909614,79.80416860692407 +Endothelial cells,"Near-Infarct +Endocardial Region",24h,360.6861405920717,93.37066831651468 +Endothelial cells,"Near-Infarct +Endocardial Region",48h,919.0256588536154,346.1380652034334 +Endothelial cells,"Remote +Endocardial Region",Control,530.2844473771587,216.7981886380764 +Endothelial cells,"Remote +Endocardial Region",4h,490.334561779103,158.51060481103974 +Endothelial cells,"Remote +Endocardial Region",24h,449.816485362995,214.8010620201375 +Endothelial cells,"Remote +Endocardial Region",48h,912.5110362754788,277.5878949915775 +Endothelial cells,Infarct Core,Control,621.719289767218,142.54188727489765 +Endothelial cells,Infarct Core,4h,239.09735315374303,45.27926514289857 +Endothelial cells,Infarct Core,24h,137.11655918067302,0.8340882784897302 +Endothelial cells,Infarct Core,48h,455.9469712393095,141.44857446014313 +Endothelial cells,Border zone,Control,644.466636509317,185.42706143752014 +Endothelial cells,Border zone,4h,365.2662218478569,42.36230071645138 +Endothelial cells,Border zone,24h,370.7649989456832,92.936361041123 +Endothelial cells,Border zone,48h,743.0083824152414,212.97678180946178 +Endothelial cells,"Near-Infarct +Epicardial Region",Control,729.4697028436245,183.9451783881445 +Endothelial cells,"Near-Infarct +Epicardial Region",4h,593.566326917386,33.39937449527821 +Endothelial cells,"Near-Infarct +Epicardial Region",24h,697.5909324571401,110.17403892284068 +Endothelial cells,"Near-Infarct +Epicardial Region",48h,1093.6315647456713,260.62493289041714 +Fibroblasts,All,Control,233.46950402616957,70.01820240401037 +Fibroblasts,All,4h,215.51325181158774,21.32339702284403 +Fibroblasts,All,24h,244.16087265663194,32.95960733654633 +Fibroblasts,All,48h,443.53955604589123,109.69794224942827 +Fibroblasts,"Near-Infarct +Endocardial Region",Control,514.76586921681,93.19566165497507 +Fibroblasts,"Near-Infarct +Endocardial Region",4h,287.41046601768414,51.08599547395517 +Fibroblasts,"Near-Infarct +Endocardial Region",24h,246.4924148124752,39.9170197684787 +Fibroblasts,"Near-Infarct +Endocardial Region",48h,642.3939816815606,123.83193570510285 +Fibroblasts,"Remote +Endocardial Region",Control,514.76586921681,93.19566165497507 +Fibroblasts,"Remote +Endocardial Region",4h,800.3279952624252,151.48282867228244 +Fibroblasts,"Remote +Endocardial Region",24h,465.9787227278762,179.37454791951336 +Fibroblasts,"Remote +Endocardial Region",48h,1207.0051997337491,337.1105022266719 +Fibroblasts,Infarct Core,Control,179.14721098708958,76.52136136817492 +Fibroblasts,Infarct Core,4h,117.50019602008933,11.314726213740753 +Fibroblasts,Infarct Core,24h,107.22213763622514,26.86434602856328 +Fibroblasts,Infarct Core,48h,401.16833787876715,90.9979006883049 +Fibroblasts,Border zone,Control,235.04001346454308,66.16648111786965 +Fibroblasts,Border zone,4h,171.8717145403034,23.187638611174066 +Fibroblasts,Border zone,24h,185.8756920779835,43.92683703208566 +Fibroblasts,Border zone,48h,390.1110718221983,31.72182892554423 +Fibroblasts,"Near-Infarct +Epicardial Region",Control,538.2830785001153,137.7708139616415 +Fibroblasts,"Near-Infarct +Epicardial Region",4h,287.0476415583088,26.43520914802332 +Fibroblasts,"Near-Infarct +Epicardial Region",24h,341.87775631363564,42.41366936300869 +Fibroblasts,"Near-Infarct +Epicardial Region",48h,652.1673351675498,172.83949672569958 +Macrophages Trem2+,All,Control,6.548146289915624,3.206054790915073 +Macrophages Trem2+,All,4h,6.562999876112368,0.43738790612741724 +Macrophages Trem2+,All,24h,11.184374380838033,4.775818552653377 +Macrophages Trem2+,All,48h,132.63636185596187,4.251281330907602 +Macrophages Trem2+,"Near-Infarct +Endocardial Region",Control,3.505537173872143,0.0 +Macrophages Trem2+,"Near-Infarct +Endocardial Region",4h,9.70900600549485,3.8728601177079662 +Macrophages Trem2+,"Near-Infarct +Endocardial Region",24h,13.022646695712893,5.385061773554123 +Macrophages Trem2+,"Near-Infarct +Endocardial Region",48h,46.89063174242358,17.258514829483133 +Macrophages Trem2+,"Remote +Endocardial Region",Control,3.505537173872143,0.0 +Macrophages Trem2+,"Remote +Endocardial Region",4h,27.52214775307559,16.13889921640642 +Macrophages Trem2+,"Remote +Endocardial Region",24h,10.548152680103001,0.9160143122315132 +Macrophages Trem2+,"Remote +Endocardial Region",48h,137.88151132852238,42.89300987660012 +Macrophages Trem2+,Infarct Core,Control,6.728372911741453,3.494495536079664 +Macrophages Trem2+,Infarct Core,4h,2.831458900263079,0.8577512830447037 +Macrophages Trem2+,Infarct Core,24h,2.903060646257525,0.18827038924192085 +Macrophages Trem2+,Infarct Core,48h,68.69233878188285,14.981546599730224 +Macrophages Trem2+,Border zone,Control,6.86337263700518,1.432958195427713 +Macrophages Trem2+,Border zone,4h,5.767233107146622,1.2366933973947587 +Macrophages Trem2+,Border zone,24h,8.70946247781573,3.9890729988547564 +Macrophages Trem2+,Border zone,48h,187.8258539250741,8.860088953692566 +Macrophages Trem2+,"Near-Infarct +Epicardial Region",Control,22.082754666663963,4.957908032168239 +Macrophages Trem2+,"Near-Infarct +Epicardial Region",4h,4.696577199103317,1.7010319989850933 +Macrophages Trem2+,"Near-Infarct +Epicardial Region",24h,64.10761812910738,14.69872054211024 +Macrophages Trem2+,"Near-Infarct +Epicardial Region",48h,154.4949982838975,68.88108176667349 +Macrophages Trem2-,All,Control,6.406074572062274,3.8483268290949377 +Macrophages Trem2-,All,4h,5.236652378347652,2.2931764966665713 +Macrophages Trem2-,All,24h,7.380477252144256,1.7264178721181507 +Macrophages Trem2-,All,48h,7.5083325491321915,2.289742046406962 +Macrophages Trem2-,"Near-Infarct +Endocardial Region",Control,12.279466272096439,5.268391924352153 +Macrophages Trem2-,"Near-Infarct +Endocardial Region",4h,9.910705724747729,1.7615860508260397 +Macrophages Trem2-,"Near-Infarct +Endocardial Region",24h,2.9320467010545266,0.8867457600248585 +Macrophages Trem2-,"Near-Infarct +Endocardial Region",48h,4.93868615215674,0.0 +Macrophages Trem2-,"Remote +Endocardial Region",Control,12.279466272096439,5.268391924352153 +Macrophages Trem2-,"Remote +Endocardial Region",4h,14.423833662230987,3.040585125561816 +Macrophages Trem2-,"Remote +Endocardial Region",24h,17.196250488501768,0.0 +Macrophages Trem2-,"Remote +Endocardial Region",48h,24.996974066295323,0.0 +Macrophages Trem2-,Infarct Core,Control,7.523517487160493,3.5776093287682977 +Macrophages Trem2-,Infarct Core,4h,1.778195342184094,0.9887122952967438 +Macrophages Trem2-,Infarct Core,24h,1.0859161028062414,0.0 +Macrophages Trem2-,Infarct Core,48h,0.0,0.0 +Macrophages Trem2-,Border zone,Control,8.093536333052548,2.0478959810687933 +Macrophages Trem2-,Border zone,4h,5.7463122473181105,0.8435636941391443 +Macrophages Trem2-,Border zone,24h,4.372115873015362,0.6854442830142528 +Macrophages Trem2-,Border zone,48h,2.4401231394003493,0.6092713238363436 +Macrophages Trem2-,"Near-Infarct +Epicardial Region",Control,7.293619657295879,2.218498868900915 +Macrophages Trem2-,"Near-Infarct +Epicardial Region",4h,11.982180800472896,0.0 +Macrophages Trem2-,"Near-Infarct +Epicardial Region",24h,0.0,0.0 +Macrophages Trem2-,"Near-Infarct +Epicardial Region",48h,0.0,0.0 +Mono / Macros Ccr2+,All,Control,9.320883263900091,3.5540219024256885 +Mono / Macros Ccr2+,All,4h,33.873421615871365,8.893653322685978 +Mono / Macros Ccr2+,All,24h,244.14373201735629,115.35424603164532 +Mono / Macros Ccr2+,All,48h,410.369987791625,16.09878481008951 +Mono / Macros Ccr2+,"Near-Infarct +Endocardial Region",Control,3.507554406580931,0.0020172327087881747 +Mono / Macros Ccr2+,"Near-Infarct +Endocardial Region",4h,111.93583591611846,22.295519502979875 +Mono / Macros Ccr2+,"Near-Infarct +Endocardial Region",24h,1163.8637291337218,419.1991992232416 +Mono / Macros Ccr2+,"Near-Infarct +Endocardial Region",48h,808.2470438409803,31.32960202566568 +Mono / Macros Ccr2+,"Remote +Endocardial Region",Control,3.507554406580931,0.0020172327087881747 +Mono / Macros Ccr2+,"Remote +Endocardial Region",4h,8.732209393896401,0.0 +Mono / Macros Ccr2+,"Remote +Endocardial Region",24h,332.0727760687881,274.7519411071155 +Mono / Macros Ccr2+,"Remote +Endocardial Region",48h,289.85974311191796,229.86700535280917 +Mono / Macros Ccr2+,Infarct Core,Control,9.940119847438652,3.047760055602147 +Mono / Macros Ccr2+,Infarct Core,4h,30.054706134126874,18.21246043081662 +Mono / Macros Ccr2+,Infarct Core,24h,153.24025139261693,53.87892798584586 +Mono / Macros Ccr2+,Infarct Core,48h,676.9666467130246,31.138899198620148 +Mono / Macros Ccr2+,Border zone,Control,12.092840507485425,7.140162932940596 +Mono / Macros Ccr2+,Border zone,4h,62.86251337038672,11.379107577751908 +Mono / Macros Ccr2+,Border zone,24h,312.5536830672868,99.12464448283706 +Mono / Macros Ccr2+,Border zone,48h,807.0038651889871,96.63336075015285 +Mono / Macros Ccr2+,"Near-Infarct +Epicardial Region",Control,19.16088556764815,7.095269209939924 +Mono / Macros Ccr2+,"Near-Infarct +Epicardial Region",4h,41.04963839837396,21.85681080410873 +Mono / Macros Ccr2+,"Near-Infarct +Epicardial Region",24h,370.21265020572287,134.1479172900699 +Mono / Macros Ccr2+,"Near-Infarct +Epicardial Region",48h,798.5960711261203,66.98623906984238 +Neutrophils,All,Control,1.0895489177815476,0.7556340177979244 +Neutrophils,All,4h,67.92240369552218,29.259450222630143 +Neutrophils,All,24h,148.0044039621702,35.57359995893058 +Neutrophils,All,48h,118.267883680665,35.77401073373927 +Neutrophils,"Near-Infarct +Endocardial Region",Control,4.096452405649356,0.0 +Neutrophils,"Near-Infarct +Endocardial Region",4h,213.90725468503933,2.030143163075408 +Neutrophils,"Near-Infarct +Endocardial Region",24h,338.2658780215104,13.06302839779309 +Neutrophils,"Near-Infarct +Endocardial Region",48h,88.58911775995483,10.184605283179968 +Neutrophils,"Remote +Endocardial Region",Control,4.096452405649356,0.0 +Neutrophils,"Remote +Endocardial Region",4h,0.0,0.0 +Neutrophils,"Remote +Endocardial Region",24h,19.264276735742975,0.0 +Neutrophils,"Remote +Endocardial Region",48h,0.0,0.0 +Neutrophils,Infarct Core,Control,1.3447734560432882,0.9547020633410342 +Neutrophils,Infarct Core,4h,79.65052192693477,51.623873762433846 +Neutrophils,Infarct Core,24h,393.5053948812221,22.665045772890664 +Neutrophils,Infarct Core,48h,312.8583496798767,45.40052738507583 +Neutrophils,Border zone,Control,0.4829253482914923,0.0 +Neutrophils,Border zone,4h,142.17652274246024,55.68440101083376 +Neutrophils,Border zone,24h,232.10868603093866,15.307940675802469 +Neutrophils,Border zone,48h,228.4268946475872,6.837563652387502 +Neutrophils,"Near-Infarct +Epicardial Region",Control,9.252228359570022,0.0 +Neutrophils,"Near-Infarct +Epicardial Region",4h,98.85299160390136,0.0 +Neutrophils,"Near-Infarct +Epicardial Region",24h,585.203379426466,124.05366861449264 +Neutrophils,"Near-Infarct +Epicardial Region",48h,401.42259901198247,152.3639327800581 +Other Leukocytes,All,Control,2.2731086818964017,1.1712733858154387 +Other Leukocytes,All,4h,11.628965566084105,2.451986624660521 +Other Leukocytes,All,24h,7.782567171138935,3.453981217014211 +Other Leukocytes,All,48h,43.31854895635716,2.712095477937158 +Other Leukocytes,"Near-Infarct +Endocardial Region",Control,7.306531963632892,3.210079557983535 +Other Leukocytes,"Near-Infarct +Endocardial Region",4h,15.343452174028855,3.671160398455086 +Other Leukocytes,"Near-Infarct +Endocardial Region",24h,21.339755170321542,17.52096270924216 +Other Leukocytes,"Near-Infarct +Endocardial Region",48h,93.37418742267835,24.232581292483964 +Other Leukocytes,"Remote +Endocardial Region",Control,7.306531963632892,3.210079557983535 +Other Leukocytes,"Remote +Endocardial Region",4h,5.691624268334585,0.0 +Other Leukocytes,"Remote +Endocardial Region",24h,4.816069183935744,0.0 +Other Leukocytes,"Remote +Endocardial Region",48h,15.031363936768699,0.033179496991504465 +Other Leukocytes,Infarct Core,Control,2.2942177423336494,1.3050053622278897 +Other Leukocytes,Infarct Core,4h,10.794557605293933,3.416137238678368 +Other Leukocytes,Infarct Core,24h,6.688953604648987,4.517121399036503 +Other Leukocytes,Infarct Core,48h,76.77024090138102,22.430303843207003 +Other Leukocytes,Border zone,Control,3.1857208628058653,1.6077381120315477 +Other Leukocytes,Border zone,4h,25.08642694063486,1.2730768251941633 +Other Leukocytes,Border zone,24h,12.853096923159676,4.761000673512291 +Other Leukocytes,Border zone,48h,90.66648992673126,20.636407981408034 +Other Leukocytes,"Near-Infarct +Epicardial Region",Control,11.571487452362364,6.95608593897486 +Other Leukocytes,"Near-Infarct +Epicardial Region",4h,42.67571358978182,27.697987589190703 +Other Leukocytes,"Near-Infarct +Epicardial Region",24h,9.43019444322723,1.549560576105467 +Other Leukocytes,"Near-Infarct +Epicardial Region",48h,48.18229912385776,6.2992841143756975 +Smooth muscle cells,All,Control,52.57532279558226,16.631232742167498 +Smooth muscle cells,All,4h,63.389091282196596,8.49724375895483 +Smooth muscle cells,All,24h,60.00856127177526,9.414699470317435 +Smooth muscle cells,All,48h,64.65702334368119,0.49512216273895143 +Smooth muscle cells,"Near-Infarct +Endocardial Region",Control,24.560949776901666,14.044338255285238 +Smooth muscle cells,"Near-Infarct +Endocardial Region",4h,10.112405444000608,7.396032219360044 +Smooth muscle cells,"Near-Infarct +Endocardial Region",24h,6.886743872623887,0.7508410495348826 +Smooth muscle cells,"Near-Infarct +Endocardial Region",48h,10.284448366482298,0.4070760621688185 +Smooth muscle cells,"Remote +Endocardial Region",Control,24.560949776901666,14.044338255285238 +Smooth muscle cells,"Remote +Endocardial Region",4h,7.211916831115493,1.520292562780908 +Smooth muscle cells,"Remote +Endocardial Region",24h,31.644458040308997,2.7480429366945387 +Smooth muscle cells,"Remote +Endocardial Region",48h,30.062727873537398,0.0663589939830107 +Smooth muscle cells,Infarct Core,Control,54.825635030600445,16.22033441249202 +Smooth muscle cells,Infarct Core,4h,77.48964445836923,3.672979574401992 +Smooth muscle cells,Infarct Core,24h,51.63386274524947,4.396512273177971 +Smooth muscle cells,Infarct Core,48h,60.40593660527396,0.666382035328688 +Smooth muscle cells,Border zone,Control,61.89089756853614,22.86186363414752 +Smooth muscle cells,Border zone,4h,53.874111131097024,24.219669394539366 +Smooth muscle cells,Border zone,24h,77.73448728554231,34.91381129782491 +Smooth muscle cells,Border zone,48h,40.4434066644578,0.29304623184133405 +Smooth muscle cells,"Near-Infarct +Epicardial Region",Control,44.075802199680155,28.850439834495262 +Smooth muscle cells,"Near-Infarct +Epicardial Region",4h,48.131982600817565,41.73437340272915 +Smooth muscle cells,"Near-Infarct +Epicardial Region",24h,71.21347170817641,27.294451630845625 +Smooth muscle cells,"Near-Infarct +Epicardial Region",48h,22.506214997421402,14.723131677673765 From 5e3046c04947c06d0ae7e5e564088d4b3676022c Mon Sep 17 00:00:00 2001 From: FloWuenne Date: Sun, 15 Dec 2024 00:19:26 -0500 Subject: [PATCH 2/2] Updated Figure 3 and Supp Figure 7 with new region quantifications. --- analysis/figures.Figure3.Rmd | 98 +-- analysis/figures.supplementary_figure_7.Rmd | 110 +--- ...er_region_counts_perctentages_20241212.csv | 607 ++++++++++++++++++ 3 files changed, 624 insertions(+), 191 deletions(-) create mode 100644 review/all_cell_types_per_region_counts_perctentages_20241212.csv diff --git a/analysis/figures.Figure3.Rmd b/analysis/figures.Figure3.Rmd index 164fe70..1c078cd 100644 --- a/analysis/figures.Figure3.Rmd +++ b/analysis/figures.Figure3.Rmd @@ -17,92 +17,26 @@ library(ggbeeswarm) source("./code/functions.R") ``` -# Load data - -```{r} -data_path <- "./data/seqIF_regions_annotations/" -cell_locations <- - list.files(path = paste(data_path,"cell_locations",sep=""),pattern = "*.csv") %>% - setNames(., .) %>% - map_df(~fread(paste(paste(data_path,"cell_locations",sep=""),.,sep="/"), select= c("CellID","ROI")), - .id = "sample") %>% - mutate("fov" = gsub("annotated_|.csv","",sample)) - -region_measurements_full <- - list.files(path = paste(data_path,"ROI_measurements",sep=""),pattern = "*.txt") %>% - setNames(., .) %>% - map_df(~fread(paste(paste(data_path,"ROI_measurements",sep=""),.,sep="/")), - .id = "sample") %>% - mutate("fov" = gsub(".txt","",sample)) -colnames(region_measurements_full) <- gsub(" ","_",colnames(region_measurements_full)) -colnames(region_measurements_full) <- gsub("\\^","",colnames(region_measurements_full)) -colnames(region_measurements_full) <- gsub("\\µ","u",colnames(region_measurements_full)) - -## Sum all individual annotations per sample and region -region_measurements <- region_measurements_full %>% - mutate("Area_um2" = if_else(fov %in% c("24h_86","4h_97"),Area_um2 * 0.235^2,Area_um2)) %>% ## Images that were post-registered using palom need to be size corrected, as their final pixel resolution is different - group_by(fov,Name) %>% - summarise("total_area_um2" = sum(Area_um2)) %>% - ungroup() -``` - -## Pixie output - -```{r} -pixie_cell_out <- fread("../data/SeqIF/pixie_cell_masks_0.05/cell_table_size_normalized_cell_labels.csv") -pixie_cell_out <- pixie_cell_out %>% - separate(fov,into = c("time","sample"), remove = FALSE) %>% - subset(cell_meta_cluster != "background") %>% - mutate("CellID" = label) -``` - -## Merge data - ```{r} -annotated_cells <- left_join(pixie_cell_out,cell_locations, by = c("fov","CellID")) -annotated_cells <- annotated_cells %>% - subset(ROI != "Background") +## Read in quantified data +all_cell_types_quantified <- fread("./review/all_cell_types_per_region_counts_perctentages_20241212.csv") -## Set factor level for time -annotated_cells$time <- factor(annotated_cells$time, - levels = c("Control","4h","24h","48h")) -``` - - -```{r} -## Let's plot the number of cells per cell-type per sample -cells_per_region <- annotated_cells %>% - subset(!ROI %in% c("Unclassified","Ignore")) %>% - subset(!ROI %in% c("PathAnnotationObject","papillary_muscle","Lumen","Background", - "Ignore","RV_ignore","myocardium_control","remote_endocardium")) %>% - group_by(ROI,fov,time,cell_meta_cluster) %>% - tally() - -cells_per_region_sub <- cells_per_region %>% -subset(grepl("Macro|Mono|Leuko|Neutro",cell_meta_cluster)) - -## Normalize cell numbers for area -region_measurements$ROI <- region_measurements$Name -cells_per_region_norm <- left_join(cells_per_region_sub,region_measurements, by = c("fov","ROI")) -cells_per_region_norm <- cells_per_region_norm %>% - mutate("cells_per_mm2" = n / total_area_um2 * 1000000) ## Normalize to square mm -``` - - -```{r} -ccr2_monomacro <- cells_per_region_norm %>% - subset(cell_meta_cluster == "Mono / Macros Ccr2+") %>% - subset(time %in% c("4h","24h","48h")) +ccr2_monomacro <- all_cell_types_quantified %>% + subset(final_cell_type == "Mono / Macros Ccr2+") %>% + subset(timepoint %in% c("4h","24h","48h")) %>% + subset(region_name %in% c("border_zone","infarct_core","epicardial_region","endocardial_region")) -ccr2_monomacro$ROI <- gsub("border_zone","Border zone",ccr2_monomacro$ROI) -ccr2_monomacro$ROI <- gsub("infarct_core","Infarct core",ccr2_monomacro$ROI) -ccr2_monomacro$ROI <- gsub("Epicardium","Epicardium",ccr2_monomacro$ROI) -ccr2_monomacro$ROI <- gsub("Endocardium","Endocardium",ccr2_monomacro$ROI) +ccr2_monomacro$region_name <- gsub("border_zone","Border zone",ccr2_monomacro$region_name) +ccr2_monomacro$region_name <- gsub("infarct_core","Infarct core",ccr2_monomacro$region_name) +ccr2_monomacro$region_name <- gsub("epicardial_region","Epicardium",ccr2_monomacro$region_name) +ccr2_monomacro$region_name <- gsub("endocardial_region","Endocardium",ccr2_monomacro$region_name) -ccr2_monomacro$ROI <- factor(ccr2_monomacro$ROI, +ccr2_monomacro$region_name <- factor(ccr2_monomacro$region_name, levels = c("Endocardium","Infarct core","Epicardium","Border zone")) +ccr2_monomacro$timepoint <- factor(ccr2_monomacro$timepoint, + levels = c("4h","24h","48h")) -seqIF_ccr2_relquant <- ggplot(ccr2_monomacro,aes(x = time,y = cells_per_mm2)) + +seqIF_ccr2_relquant <- ggplot(ccr2_monomacro,aes(x = timepoint,y = count_per_mm2)) + stat_summary( fun.y = mean, geom = "bar", @@ -110,11 +44,11 @@ seqIF_ccr2_relquant <- ggplot(ccr2_monomacro,aes(x = time,y = cells_per_mm2)) + size = 0.3, color = "black", fill = "lightgrey") + - geom_beeswarm(size = 2, pch = 21, color = "black", aes(fill = ROI)) + + geom_beeswarm(size = 2, pch = 21, color = "black", aes(fill = region_name)) + labs(x = "Time", y = expression("Cells /"~mm^2)) + #expression(paste("Mo / M",phi," per "~mm^2)) - facet_grid(. ~ ROI) + + facet_grid(. ~ region_name) + scale_fill_manual(values = c("#337272","#f0f0f0","#b062c2","#2c95c5")) + theme(axis.title = element_text(face="bold"), legend.position = "none") + diff --git a/analysis/figures.supplementary_figure_7.Rmd b/analysis/figures.supplementary_figure_7.Rmd index 1e00da6..9eb7a91 100644 --- a/analysis/figures.supplementary_figure_7.Rmd +++ b/analysis/figures.supplementary_figure_7.Rmd @@ -18,115 +18,7 @@ source("./code/functions.R") ``` -# b) SeqIF relative abundance of CCR2+ cells - -```{r} -data_path <- "./data/seqIF_regions_annotations/" -cell_locations <- - list.files(path = paste(data_path,"cell_locations",sep=""),pattern = "*.csv") %>% - setNames(., .) %>% - map_df(~fread(paste(paste(data_path,"cell_locations",sep=""),.,sep="/"), select= c("CellID","ROI")), - .id = "sample") %>% - mutate("fov" = gsub("annotated_|.csv","",sample)) - -region_measurements_full <- - list.files(path = paste(data_path,"ROI_measurements",sep=""),pattern = "*.txt") %>% - setNames(., .) %>% - map_df(~fread(paste(paste(data_path,"ROI_measurements",sep=""),.,sep="/")), - .id = "sample") %>% - mutate("fov" = gsub(".txt","",sample)) -colnames(region_measurements_full) <- gsub(" ","_",colnames(region_measurements_full)) -colnames(region_measurements_full) <- gsub("\\^","",colnames(region_measurements_full)) -colnames(region_measurements_full) <- gsub("\\µ","u",colnames(region_measurements_full)) - -## Sum all individual annotations per sample and region -region_measurements <- region_measurements_full %>% - mutate("Area_um2" = if_else(fov %in% c("24h_86","4h_97"),Area_um2 * 0.235^2,Area_um2)) %>% ## Images that were post-registered using palom need to be size corrected, as their final pixel resolution is different - group_by(fov,Name) %>% - summarise("total_area_um2" = sum(Area_um2)) %>% - ungroup() -``` - -## Pixie output - -```{r} -pixie_cell_out <- fread("../data/SeqIF/pixie_cell_masks_0.05/cell_table_size_normalized_cell_labels.csv") -pixie_cell_out <- pixie_cell_out %>% - separate(fov,into = c("time","sample"), remove = FALSE) %>% - subset(cell_meta_cluster != "background") %>% - mutate("CellID" = label) -``` - -## Merge data - -```{r} -annotated_cells <- left_join(pixie_cell_out,cell_locations, by = c("fov","CellID")) -annotated_cells <- annotated_cells %>% - subset(ROI != "Background") - -## Set factor level for time -annotated_cells$time <- factor(annotated_cells$time, - levels = c("Control","4h","24h","48h")) -``` - - -```{r} -## Let's plot the number of cells per cell-type per sample -cells_per_region <- annotated_cells %>% - subset(!ROI %in% c("Unclassified","Ignore")) %>% - subset(!ROI %in% c("PathAnnotationObject","papillary_muscle","Lumen","Background", - "Ignore","RV_ignore","myocardium_control","remote_endocardium")) %>% - group_by(ROI,fov,time,cell_meta_cluster) %>% - tally() - -cells_per_region_sub <- cells_per_region %>% -subset(grepl("Macro|Mono|Leuko|Neutro",cell_meta_cluster)) - -## Normalize cell numbers for area -region_measurements$ROI <- region_measurements$Name -cells_per_region_norm <- left_join(cells_per_region_sub,region_measurements, by = c("fov","ROI")) -cells_per_region_norm <- cells_per_region_norm %>% - mutate("cells_per_mm2" = n / total_area_um2 * 1000000) ## Normalize to square mm -``` - - -```{r} -ccr2_monomacro <- cells_per_region_norm %>% - subset(cell_meta_cluster == "Mono / Macros Ccr2+") %>% - subset(time %in% c("4h","24h","48h")) - -ccr2_monomacro$ROI <- gsub("border_zone","Border zone",ccr2_monomacro$ROI) -ccr2_monomacro$ROI <- gsub("infarct_core","Infarct core",ccr2_monomacro$ROI) -ccr2_monomacro$ROI <- gsub("Epicardium","Epicardium",ccr2_monomacro$ROI) -ccr2_monomacro$ROI <- gsub("Endocardium","Endocardium",ccr2_monomacro$ROI) - -ccr2_monomacro$ROI <- factor(ccr2_monomacro$ROI, - levels = c("Endocardium","Infarct core","Epicardium","Border zone")) - -seqIF_ccr2_relquant <- ggplot(ccr2_monomacro,aes(x = time,y = cells_per_mm2)) + - stat_summary( - fun.y = mean, - geom = "bar", - width = 0.9, - size = 0.3, - color = "black", - fill = "lightgrey") + - geom_beeswarm(size = 2, pch = 21, color = "black", aes(fill = ROI)) + - labs(x = "Time", - y = expression("Cells /"~mm^2)) + - #expression(paste("Mo / M",phi," per "~mm^2)) - facet_grid(. ~ ROI) + - scale_fill_manual(values = c("#337272","#f0f0f0","#b062c2","#2c95c5")) + - theme(axis.title = element_text(face="bold"), - legend.position = "none") + - theme(panel.border = element_rect(color = "black", fill = NA, size = 0.75)) + - theme(axis.text.x = element_text(angle = 45, hjust = 1), - axis.title.x = element_blank()) -seqIF_ccr2_relquant -``` - - -# c) Immunofluorescence relative abundance of CCR2+ cells +# New b) Immunofluorescence relative abundance of CCR2+ cells in traditional IF ```{r} diff --git a/review/all_cell_types_per_region_counts_perctentages_20241212.csv b/review/all_cell_types_per_region_counts_perctentages_20241212.csv new file mode 100644 index 0000000..48e527e --- /dev/null +++ b/review/all_cell_types_per_region_counts_perctentages_20241212.csv @@ -0,0 +1,607 @@ +timepoint,fov,region_name,final_cell_type,count,total_count,percentage,area_px,area_um,count_per_um2,count_per_mm2 +24h,24h_83,border_zone,Cardiomyocytes,2469,10052,0.24562276163947472,46147947,2441226.3963,0.0010113769061903042,1011.3769061903042 +24h,24h_83,border_zone,Cardiomyocytes Ankrd1+,3870,10052,0.38499801034619974,46147947,2441226.3963,0.001585268783700477,1585.2687837004771 +24h,24h_83,border_zone,Endocardial cells,53,10052,0.00527258257063271,46147947,2441226.3963,2.1710399363339867e-05,21.710399363339867 +24h,24h_83,border_zone,Endothelial cells,1132,10052,0.11261440509351373,46147947,2441226.3963,0.0004637013599868062,463.7013599868062 +24h,24h_83,border_zone,Fibroblasts,561,10052,0.05580978909669718,46147947,2441226.3963,0.00022980252911006916,229.80252911006917 +24h,24h_83,border_zone,Macrophages Trem2+,31,10052,0.0030839633903700756,46147947,2441226.3963,1.2698535476670488e-05,12.698535476670488 +24h,24h_83,border_zone,Macrophages Trem2-,9,10052,0.0008953442101074413,46147947,2441226.3963,3.6866715900011095e-06,3.6866715900011093 +24h,24h_83,border_zone,Mono / Macros Ccr2+,1005,10052,0.09998010346199761,46147947,2441226.3963,0.00041167832755012386,411.67832755012387 +24h,24h_83,border_zone,Neutrophils,604,10052,0.0600875447672105,46147947,2441226.3963,0.0002474166267067411,247.4166267067411 +24h,24h_83,border_zone,Other Leukocytes,43,10052,0.004277755670513331,46147947,2441226.3963,1.7614097596671966e-05,17.614097596671968 +24h,24h_83,border_zone,Smooth muscle cells,275,10052,0.027357739753282928,46147947,2441226.3963,0.00011264829858336723,112.64829858336722 +24h,24h_83,endocardial_region,Cardiomyocytes,1216,2948,0.412483039348711,9242450,488925.60500000004,0.002487085944292077,2487.085944292077 +24h,24h_83,endocardial_region,Cardiomyocytes Ankrd1+,149,2948,0.0505427408412483,9242450,488925.60500000004,0.0003047498402134206,304.7498402134206 +24h,24h_83,endocardial_region,Endocardial cells,295,2948,0.10006784260515604,9242450,488925.60500000004,0.0006033637776037522,603.3637776037522 +24h,24h_83,endocardial_region,Endothelial cells,222,2948,0.07530529172320218,9242450,488925.60500000004,0.00045405680890858637,454.0568089085864 +24h,24h_83,endocardial_region,Fibroblasts,101,2948,0.03426051560379918,9242450,488925.60500000004,0.0002065753950439965,206.5753950439965 +24h,24h_83,endocardial_region,Macrophages Trem2+,9,2948,0.0030529172320217096,9242450,488925.60500000004,1.8407708469267015e-05,18.407708469267014 +24h,24h_83,endocardial_region,Macrophages Trem2-,1,2948,0.00033921302578018993,9242450,488925.60500000004,2.0453009410296682e-06,2.045300941029668 +24h,24h_83,endocardial_region,Mono / Macros Ccr2+,774,2948,0.26255088195386705,9242450,488925.60500000004,0.0015830629283569632,1583.0629283569633 +24h,24h_83,endocardial_region,Neutrophils,159,2948,0.0539348710990502,9242450,488925.60500000004,0.00032520284962371727,325.20284962371727 +24h,24h_83,endocardial_region,Other Leukocytes,19,2948,0.006445047489823609,9242450,488925.60500000004,3.88607178795637e-05,38.8607178795637 +24h,24h_83,endocardial_region,Smooth muscle cells,3,2948,0.0010176390773405698,9242450,488925.60500000004,6.135902823089005e-06,6.135902823089005 +24h,24h_83,epicardial_region,Cardiomyocytes,521,1717,0.3034362259755387,4797480,253786.69200000004,0.002052905122385219,2052.905122385219 +24h,24h_83,epicardial_region,Cardiomyocytes Ankrd1+,560,1717,0.326150262085032,4797480,253786.69200000004,0.0022065774827940937,2206.5774827940936 +24h,24h_83,epicardial_region,Endothelial cells,205,1717,0.11939429237041352,4797480,253786.69200000004,0.0008077649713799807,807.7649713799807 +24h,24h_83,epicardial_region,Fibroblasts,76,1717,0.0442632498543972,4797480,253786.69200000004,0.000299464086950627,299.46408695062695 +24h,24h_83,epicardial_region,Macrophages Trem2+,20,1717,0.011648223645894,4797480,253786.69200000004,7.880633867121762e-05,78.80633867121762 +24h,24h_83,epicardial_region,Mono / Macros Ccr2+,128,1717,0.07454863133372161,4797480,253786.69200000004,0.0005043605674957928,504.3605674957928 +24h,24h_83,epicardial_region,Neutrophils,180,1717,0.10483401281304601,4797480,253786.69200000004,0.0007092570480409586,709.2570480409586 +24h,24h_83,epicardial_region,Other Leukocytes,2,1717,0.0011648223645894002,4797480,253786.69200000004,7.880633867121762e-06,7.880633867121762 +24h,24h_83,epicardial_region,Smooth muscle cells,25,1717,0.014560279557367502,4797480,253786.69200000004,9.850792333902203e-05,98.50792333902203 +24h,24h_83,infarct_core,Cardiomyocytes,280,10366,0.027011383368705382,48920265,2587882.0185000002,0.00010819658624248058,108.19658624248058 +24h,24h_83,infarct_core,Cardiomyocytes Ankrd1+,7587,10366,0.7319120200655991,48920265,2587882.0185000002,0.0029317410707917864,2931.7410707917866 +24h,24h_83,infarct_core,Endothelial cells,357,10366,0.034439513795099366,48920265,2587882.0185000002,0.00013795064745916275,137.95064745916275 +24h,24h_83,infarct_core,Fibroblasts,347,10366,0.03347482153193131,48920265,2587882.0185000002,0.00013408648366478843,134.08648366478843 +24h,24h_83,infarct_core,Macrophages Trem2+,8,10366,0.0007717538105344395,48920265,2587882.0185000002,3.0913310354994453e-06,3.0913310354994454 +24h,24h_83,infarct_core,Mono / Macros Ccr2+,536,10366,0.05170750530580745,48920265,2587882.0185000002,0.00020711917937846281,207.1191793784628 +24h,24h_83,infarct_core,Neutrophils,1077,10366,0.10389735674319892,48920265,2587882.0185000002,0.0004161704406541128,416.1704406541128 +24h,24h_83,infarct_core,Other Leukocytes,29,10366,0.0027976075631873432,48920265,2587882.0185000002,1.1206075003685489e-05,11.20607500368549 +24h,24h_83,infarct_core,Smooth muscle cells,145,10366,0.013988037815936716,48920265,2587882.0185000002,5.603037501842744e-05,56.03037501842744 +24h,24h_83,other_cardiac_tissue,Cardiomyocytes,16906,31469,0.5372271123963266,151092689,7992803.2481,0.0021151527787223825,2115.1527787223827 +24h,24h_83,other_cardiac_tissue,Cardiomyocytes Ankrd1+,2180,31469,0.06927452413486287,151092689,7992803.2481,0.0002727453600860519,272.7453600860519 +24h,24h_83,other_cardiac_tissue,Endocardial cells,241,31469,0.007658330420413741,151092689,7992803.2481,3.0152124670063537e-05,30.152124670063536 +24h,24h_83,other_cardiac_tissue,Endothelial cells,5693,31469,0.18090819536686897,151092689,7992803.2481,0.0007122657499861897,712.2657499861897 +24h,24h_83,other_cardiac_tissue,Fibroblasts,2653,31469,0.08430518923384918,151092689,7992803.2481,0.0003319235964716953,331.9235964716953 +24h,24h_83,other_cardiac_tissue,Macrophages Trem2+,153,31469,0.004861927611300009,151092689,7992803.2481,1.914222022622291e-05,19.14222022622291 +24h,24h_83,other_cardiac_tissue,Macrophages Trem2-,69,31469,0.0021926340207823573,151092689,7992803.2481,8.632765984375037e-06,8.632765984375038 +24h,24h_83,other_cardiac_tissue,Mono / Macros Ccr2+,2454,31469,0.07798150560869427,151092689,7992803.2481,0.0003070261989225557,307.0261989225557 +24h,24h_83,other_cardiac_tissue,Neutrophils,541,31469,0.017191521815119643,151092689,7992803.2481,6.768588981952022e-05,67.68588981952021 +24h,24h_83,other_cardiac_tissue,Other Leukocytes,63,31469,0.0020019701928882393,151092689,7992803.2481,7.882090681385905e-06,7.882090681385905 +24h,24h_83,other_cardiac_tissue,Smooth muscle cells,516,31469,0.01639708919889415,151092689,7992803.2481,6.45580760570655e-05,64.5580760570655 +24h,24h_83,remote_endocardial_region,Cardiomyocytes,776,1287,0.602952602952603,3925108,207638.21320000003,0.0037372696867341367,3737.2696867341365 +24h,24h_83,remote_endocardial_region,Cardiomyocytes Ankrd1+,6,1287,0.004662004662004662,3925108,207638.21320000003,2.8896415103614458e-05,28.89641510361446 +24h,24h_83,remote_endocardial_region,Endocardial cells,94,1287,0.07303807303807304,3925108,207638.21320000003,0.0004527105032899599,452.7105032899599 +24h,24h_83,remote_endocardial_region,Endothelial cells,138,1287,0.10722610722610723,3925108,207638.21320000003,0.0006646175473831326,664.6175473831325 +24h,24h_83,remote_endocardial_region,Fibroblasts,134,1287,0.10411810411810411,3925108,207638.21320000003,0.0006453532706473896,645.3532706473895 +24h,24h_83,remote_endocardial_region,Macrophages Trem2+,2,1287,0.001554001554001554,3925108,207638.21320000003,9.632138367871487e-06,9.632138367871487 +24h,24h_83,remote_endocardial_region,Mono / Macros Ccr2+,126,1287,0.0979020979020979,3925108,207638.21320000003,0.0006068247171759037,606.8247171759036 +24h,24h_83,remote_endocardial_region,Neutrophils,4,1287,0.003108003108003108,3925108,207638.21320000003,1.9264276735742974e-05,19.264276735742975 +24h,24h_83,remote_endocardial_region,Other Leukocytes,1,1287,0.000777000777000777,3925108,207638.21320000003,4.816069183935744e-06,4.816069183935744 +24h,24h_83,remote_endocardial_region,Smooth muscle cells,6,1287,0.004662004662004662,3925108,207638.21320000003,2.8896415103614458e-05,28.89641510361446 +24h,24h_86,border_zone,Cardiomyocytes,3890,10746,0.36199516099013584,56065349,2965856.9621000006,0.0013115939337970137,1311.5939337970137 +24h,24h_86,border_zone,Cardiomyocytes Ankrd1+,4126,10746,0.3839568211427508,56065349,2965856.9621000006,0.0013911662135852128,1391.1662135852127 +24h,24h_86,border_zone,Endocardial cells,29,10746,0.002698678578075563,56065349,2965856.9621000006,9.77794963499059e-06,9.77794963499059 +24h,24h_86,border_zone,Endothelial cells,824,10746,0.07667969477014704,56065349,2965856.9621000006,0.0002778286379045602,277.8286379045602 +24h,24h_86,border_zone,Fibroblasts,421,10746,0.03917736832309696,56065349,2965856.9621000006,0.00014194885504589786,141.94885504589786 +24h,24h_86,border_zone,Macrophages Trem2+,14,10746,0.0013028103480364787,56065349,2965856.9621000006,4.720389478960974e-06,4.720389478960974 +24h,24h_86,border_zone,Macrophages Trem2-,15,10746,0.0013958682300390843,56065349,2965856.9621000006,5.057560156029615e-06,5.0575601560296155 +24h,24h_86,border_zone,Mono / Macros Ccr2+,633,10746,0.05890563930764936,56065349,2965856.9621000006,0.00021342903858444977,213.42903858444976 +24h,24h_86,border_zone,Neutrophils,643,10746,0.059836218127675415,56065349,2965856.9621000006,0.00021680074535513618,216.80074535513617 +24h,24h_86,border_zone,Other Leukocytes,24,10746,0.002233389168062535,56065349,2965856.9621000006,8.092096249647385e-06,8.092096249647385 +24h,24h_86,border_zone,Smooth muscle cells,127,10746,0.011818351014330914,56065349,2965856.9621000006,4.282067598771741e-05,42.82067598771741 +24h,24h_86,endocardial_region,Cardiomyocytes,738,1319,0.5595147839272175,4950149,261862.88210000002,0.0028182688362765862,2818.268836276586 +24h,24h_86,endocardial_region,Cardiomyocytes Ankrd1+,20,1319,0.015163002274450341,4950149,261862.88210000002,7.63758492215877e-05,76.3758492215877 +24h,24h_86,endocardial_region,Endocardial cells,123,1319,0.0932524639878696,4950149,261862.88210000002,0.00046971147271276443,469.7114727127644 +24h,24h_86,endocardial_region,Endothelial cells,70,1319,0.05307050796057619,4950149,261862.88210000002,0.000267315472275557,267.315472275557 +24h,24h_86,endocardial_region,Fibroblasts,75,1319,0.05686125852918878,4950149,261862.88210000002,0.0002864094345809539,286.4094345809539 +24h,24h_86,endocardial_region,Macrophages Trem2+,2,1319,0.001516300227445034,4950149,261862.88210000002,7.63758492215877e-06,7.63758492215877 +24h,24h_86,endocardial_region,Macrophages Trem2-,1,1319,0.000758150113722517,4950149,261862.88210000002,3.818792461079385e-06,3.818792461079385 +24h,24h_86,endocardial_region,Mono / Macros Ccr2+,195,1319,0.14783927217589082,4950149,261862.88210000002,0.0007446645299104801,744.6645299104802 +24h,24h_86,endocardial_region,Neutrophils,92,1319,0.06974981046247157,4950149,261862.88210000002,0.0003513289064193035,351.32890641930345 +24h,24h_86,endocardial_region,Other Leukocytes,1,1319,0.000758150113722517,4950149,261862.88210000002,3.818792461079385e-06,3.818792461079385 +24h,24h_86,endocardial_region,Smooth muscle cells,2,1319,0.001516300227445034,4950149,261862.88210000002,7.63758492215877e-06,7.63758492215877 +24h,24h_86,epicardial_region,Cardiomyocytes,517,1071,0.4827264239028945,3443354,182153.4266,0.002838266672497502,2838.266672497502 +24h,24h_86,epicardial_region,Cardiomyocytes Ankrd1+,231,1071,0.21568627450980393,3443354,182153.4266,0.0012681617047329264,1268.1617047329264 +24h,24h_86,epicardial_region,Endothelial cells,107,1071,0.09990662931839403,3443354,182153.4266,0.0005874168935342993,587.4168935342993 +24h,24h_86,epicardial_region,Fibroblasts,70,1071,0.06535947712418301,3443354,182153.4266,0.00038429142567664436,384.29142567664434 +24h,24h_86,epicardial_region,Macrophages Trem2+,9,1071,0.008403361344537815,3443354,182153.4266,4.940889758699713e-05,49.408897586997135 +24h,24h_86,epicardial_region,Mono / Macros Ccr2+,43,1071,0.040149393090569564,3443354,182153.4266,0.00023606473291565297,236.06473291565297 +24h,24h_86,epicardial_region,Neutrophils,84,1071,0.0784313725490196,3443354,182153.4266,0.00046114971081197325,461.14971081197325 +24h,24h_86,epicardial_region,Other Leukocytes,2,1071,0.0018674136321195146,3443354,182153.4266,1.0979755019332697e-05,10.979755019332696 +24h,24h_86,epicardial_region,Smooth muscle cells,8,1071,0.007469654528478058,3443354,182153.4266,4.3919020077330787e-05,43.919020077330785 +24h,24h_86,infarct_core,Cardiomyocytes,1584,6977,0.22703167550523148,34815934,1841762.9086000002,0.0008600455534225432,860.0455534225432 +24h,24h_86,infarct_core,Cardiomyocytes Ankrd1+,4030,6977,0.5776121542210119,34815934,1841762.9086000002,0.0021881209471545766,2188.1209471545767 +24h,24h_86,infarct_core,Endothelial cells,251,6977,0.03597534757058908,34815934,1841762.9086000002,0.0001362824709021833,136.2824709021833 +24h,24h_86,infarct_core,Fibroblasts,148,6977,0.021212555539630213,34815934,1841762.9086000002,8.035779160766187e-05,80.35779160766187 +24h,24h_86,infarct_core,Macrophages Trem2+,5,6977,0.0007166403898523721,34815934,1841762.9086000002,2.7147902570156036e-06,2.7147902570156037 +24h,24h_86,infarct_core,Macrophages Trem2-,2,6977,0.00028665615594094884,34815934,1841762.9086000002,1.0859161028062413e-06,1.0859161028062414 +24h,24h_86,infarct_core,Mono / Macros Ccr2+,183,6977,0.026229038268596818,34815934,1841762.9086000002,9.936132340677109e-05,99.36132340677109 +24h,24h_86,infarct_core,Neutrophils,683,6977,0.09789307725383403,34815934,1841762.9086000002,0.00037084034910833143,370.84034910833145 +24h,24h_86,infarct_core,Other Leukocytes,4,6977,0.0005733123118818977,34815934,1841762.9086000002,2.1718322056124827e-06,2.171832205612483 +24h,24h_86,infarct_core,Smooth muscle cells,87,6977,0.012469542783431275,34815934,1841762.9086000002,4.72373504720715e-05,47.2373504720715 +24h,24h_86,other_cardiac_tissue,Cardiomyocytes,31226,45652,0.6840007009550513,233698041,12362626.368900001,0.0025258386906000475,2525.8386906000474 +24h,24h_86,other_cardiac_tissue,Cardiomyocytes Ankrd1+,2387,45652,0.05228686585472707,233698041,12362626.368900001,0.00019308194947999469,193.08194947999468 +24h,24h_86,other_cardiac_tissue,Endocardial cells,443,45652,0.009703846490843774,233698041,12362626.368900001,3.583380964375268e-05,35.83380964375268 +24h,24h_86,other_cardiac_tissue,Endothelial cells,5939,45652,0.1300928765442916,233698041,12362626.368900001,0.000480399538316585,480.399538316585 +24h,24h_86,other_cardiac_tissue,Fibroblasts,2993,45652,0.0655612021379129,233698041,12362626.368900001,0.00024210065973758862,242.10065973758861 +24h,24h_86,other_cardiac_tissue,Macrophages Trem2+,82,45652,0.001796197318846929,233698041,12362626.368900001,6.632894787331195e-06,6.632894787331195 +24h,24h_86,other_cardiac_tissue,Macrophages Trem2-,141,45652,0.0030885831946026463,233698041,12362626.368900001,1.140534347577681e-05,11.40534347577681 +24h,24h_86,other_cardiac_tissue,Mono / Macros Ccr2+,1227,45652,0.02687724524664856,233698041,12362626.368900001,9.92507549275046e-05,99.2507549275046 +24h,24h_86,other_cardiac_tissue,Neutrophils,498,45652,0.010908612985192325,233698041,12362626.368900001,4.0282702488913846e-05,40.28270248891385 +24h,24h_86,other_cardiac_tissue,Other Leukocytes,46,45652,0.0010076228861824236,233698041,12362626.368900001,3.7208921977711585e-06,3.7208921977711586 +24h,24h_86,other_cardiac_tissue,Smooth muscle cells,670,45652,0.014676246385700517,233698041,12362626.368900001,5.419560375014513e-05,54.19560375014513 +24h,24h_86,remote_endocardial_region,Cardiomyocytes,768,970,0.7917525773195876,3297857,174456.6353,0.004402240125056453,4402.240125056453 +24h,24h_86,remote_endocardial_region,Cardiomyocytes Ankrd1+,4,970,0.004123711340206186,3297857,174456.6353,2.2928333984669027e-05,22.928333984669028 +24h,24h_86,remote_endocardial_region,Endocardial cells,86,970,0.088659793814433,3297857,174456.6353,0.0004929591806703841,492.9591806703841 +24h,24h_86,remote_endocardial_region,Endothelial cells,41,970,0.042268041237113405,3297857,174456.6353,0.00023501542334285753,235.01542334285753 +24h,24h_86,remote_endocardial_region,Fibroblasts,50,970,0.05154639175257732,3297857,174456.6353,0.0002866041748083628,286.6041748083628 +24h,24h_86,remote_endocardial_region,Macrophages Trem2+,2,970,0.002061855670103093,3297857,174456.6353,1.1464166992334514e-05,11.464166992334514 +24h,24h_86,remote_endocardial_region,Macrophages Trem2-,3,970,0.003092783505154639,3297857,174456.6353,1.719625048850177e-05,17.196250488501768 +24h,24h_86,remote_endocardial_region,Mono / Macros Ccr2+,10,970,0.010309278350515464,3297857,174456.6353,5.732083496167256e-05,57.32083496167256 +24h,24h_86,remote_endocardial_region,Smooth muscle cells,6,970,0.006185567010309278,3297857,174456.6353,3.439250097700354e-05,34.392500977003536 +48h,48h_76,border_zone,Cardiomyocytes,1215,8990,0.13515016685205783,41300102,2184775.3958000005,0.0005561212389775667,556.1212389775667 +48h,48h_76,border_zone,Cardiomyocytes Ankrd1+,3061,8990,0.34048943270300336,41300102,2184775.3958000005,0.0014010593518603554,1401.0593518603553 +48h,48h_76,border_zone,Endocardial cells,70,8990,0.00778642936596218,41300102,2184775.3958000005,3.20399067723701e-05,32.039906772370095 +48h,48h_76,border_zone,Endothelial cells,1158,8990,0.12880978865406006,41300102,2184775.3958000005,0.0005300316006057797,530.0316006057797 +48h,48h_76,border_zone,Fibroblasts,783,8990,0.08709677419354839,41300102,2184775.3958000005,0.0003583892428966541,358.3892428966541 +48h,48h_76,border_zone,Macrophages Trem2+,391,8990,0.04349276974416018,41300102,2184775.3958000005,0.00017896576497138155,178.96576497138156 +48h,48h_76,border_zone,Macrophages Trem2-,4,8990,0.0004449388209121246,41300102,2184775.3958000005,1.8308518155640057e-06,1.8308518155640057 +48h,48h_76,border_zone,Mono / Macros Ccr2+,1552,8990,0.17263626251390435,41300102,2184775.3958000005,0.0007103705044388342,710.3705044388342 +48h,48h_76,border_zone,Neutrophils,514,8990,0.05717463848720801,41300102,2184775.3958000005,0.00023526445829997471,235.2644582999747 +48h,48h_76,border_zone,Other Leukocytes,153,8990,0.017018909899888766,41300102,2184775.3958000005,7.003008194532321e-05,70.03008194532322 +48h,48h_76,border_zone,Smooth muscle cells,89,8990,0.009899888765294773,41300102,2184775.3958000005,4.073645289629913e-05,40.73645289629913 +48h,48h_76,endocardial_region,Cardiomyocytes,548,1119,0.4897229669347632,3827656,202483.0024,0.0027064000113818936,2706.4000113818934 +48h,48h_76,endocardial_region,Cardiomyocytes Ankrd1+,25,1119,0.022341376228775692,3827656,202483.0024,0.0001234671538039185,123.4671538039185 +48h,48h_76,endocardial_region,Endocardial cells,112,1119,0.10008936550491511,3827656,202483.0024,0.000553132849041555,553.132849041555 +48h,48h_76,endocardial_region,Endothelial cells,116,1119,0.10366398570151922,3827656,202483.0024,0.0005728875936501819,572.8875936501819 +48h,48h_76,endocardial_region,Fibroblasts,105,1119,0.0938337801608579,3827656,202483.0024,0.0005185620459764577,518.5620459764577 +48h,48h_76,endocardial_region,Macrophages Trem2+,6,1119,0.005361930294906166,3827656,202483.0024,2.9632116912940443e-05,29.632116912940443 +48h,48h_76,endocardial_region,Macrophages Trem2-,1,1119,0.0008936550491510277,3827656,202483.0024,4.9386861521567405e-06,4.93868615215674 +48h,48h_76,endocardial_region,Mono / Macros Ccr2+,170,1119,0.15192135835567472,3827656,202483.0024,0.0008395766458666458,839.5766458666459 +48h,48h_76,endocardial_region,Neutrophils,20,1119,0.017873100983020553,3827656,202483.0024,9.87737230431348e-05,98.77372304313481 +48h,48h_76,endocardial_region,Other Leukocytes,14,1119,0.012511170688114389,3827656,202483.0024,6.914160613019437e-05,69.14160613019438 +48h,48h_76,endocardial_region,Smooth muscle cells,2,1119,0.0017873100983020554,3827656,202483.0024,9.877372304313481e-06,9.87737230431348 +48h,48h_76,epicardial_region,Cardiomyocytes,89,1173,0.07587382779198636,4062084,214884.24360000002,0.0004141764817604337,414.1764817604337 +48h,48h_76,epicardial_region,Cardiomyocytes Ankrd1+,432,1173,0.36828644501278773,4062084,214884.24360000002,0.0020103847204551387,2010.3847204551387 +48h,48h_76,epicardial_region,Endothelial cells,179,1173,0.1526001705029838,4062084,214884.24360000002,0.0008330066318552543,833.0066318552542 +48h,48h_76,epicardial_region,Fibroblasts,103,1173,0.08780903665814152,4062084,214884.24360000002,0.0004793278384418502,479.32783844185025 +48h,48h_76,epicardial_region,Macrophages Trem2+,48,1173,0.04092071611253197,4062084,214884.24360000002,0.000223376080050571,223.376080050571 +48h,48h_76,epicardial_region,Mono / Macros Ccr2+,186,1173,0.1585677749360614,4062084,214884.24360000002,0.0008655823101959626,865.5823101959626 +48h,48h_76,epicardial_region,Neutrophils,119,1173,0.10144927536231885,4062084,214884.24360000002,0.0005537865317920405,553.7865317920406 +48h,48h_76,epicardial_region,Other Leukocytes,9,1173,0.0076726342710997444,4062084,214884.24360000002,4.188301500948206e-05,41.88301500948206 +48h,48h_76,epicardial_region,Smooth muscle cells,8,1173,0.0068201193520886615,4062084,214884.24360000002,3.7229346675095164e-05,37.229346675095165 +48h,48h_76,infarct_core,Cardiomyocytes,171,7595,0.02251481237656353,39310054,2079501.8566,8.223123218537837e-05,82.23123218537836 +48h,48h_76,infarct_core,Cardiomyocytes Ankrd1+,3619,7595,0.47649769585253454,39310054,2079501.8566,0.001740320639057803,1740.320639057803 +48h,48h_76,infarct_core,Endocardial cells,4,7595,0.0005266622778143515,39310054,2079501.8566,1.923537594979611e-06,1.923537594979611 +48h,48h_76,infarct_core,Endothelial cells,654,7595,0.08610928242264648,39310054,2079501.8566,0.0003144983967791664,314.4983967791664 +48h,48h_76,infarct_core,Fibroblasts,645,7595,0.08492429229756418,39310054,2079501.8566,0.0003101704371904623,310.1704371904623 +48h,48h_76,infarct_core,Macrophages Trem2+,174,7595,0.022909809084924293,39310054,2079501.8566,8.367388538161307e-05,83.67388538161308 +48h,48h_76,infarct_core,Mono / Macros Ccr2+,1343,7595,0.17682685977616852,39310054,2079501.8566,0.0006458277475144044,645.8277475144045 +48h,48h_76,infarct_core,Neutrophils,745,7595,0.09809084924292298,39310054,2079501.8566,0.00035825887706495254,358.2588770649525 +48h,48h_76,infarct_core,Other Leukocytes,113,7595,0.014878209348255431,39310054,2079501.8566,5.433993705817401e-05,54.33993705817401 +48h,48h_76,infarct_core,Smooth muscle cells,127,7595,0.01672152732060566,39310054,2079501.8566,6.107231864060265e-05,61.072318640602646 +48h,48h_76,other_cardiac_tissue,Cardiomyocytes,9768,17811,0.5484251305373085,94862675,5018235.5075,0.0019465009135982642,1946.500913598264 +48h,48h_76,other_cardiac_tissue,Cardiomyocytes Ankrd1+,752,17811,0.042221099320644544,94862675,5018235.5075,0.00014985346918774516,149.85346918774516 +48h,48h_76,other_cardiac_tissue,Endocardial cells,323,17811,0.018134860479478973,94862675,5018235.5075,6.43652533878214e-05,64.3652533878214 +48h,48h_76,other_cardiac_tissue,Endothelial cells,3144,17811,0.17652012801077985,94862675,5018235.5075,0.0006265150360721686,626.5150360721686 +48h,48h_76,other_cardiac_tissue,Fibroblasts,1495,17811,0.08393689293133456,94862675,5018235.5075,0.00029791347930276465,297.91347930276464 +48h,48h_76,other_cardiac_tissue,Macrophages Trem2+,633,17811,0.03553983493346808,94862675,5018235.5075,0.0001261399547817057,126.1399547817057 +48h,48h_76,other_cardiac_tissue,Macrophages Trem2-,87,17811,0.004884621862893717,94862675,5018235.5075,1.7336771036348176e-05,17.336771036348175 +48h,48h_76,other_cardiac_tissue,Mono / Macros Ccr2+,959,17811,0.053843130649598565,94862675,5018235.5075,0.00019110302786043564,191.10302786043565 +48h,48h_76,other_cardiac_tissue,Neutrophils,127,17811,0.0071304250182471504,94862675,5018235.5075,2.530770024846228e-05,25.30770024846228 +48h,48h_76,other_cardiac_tissue,Other Leukocytes,110,17811,0.006175958677221941,94862675,5018235.5075,2.1920055333313788e-05,21.920055333313787 +48h,48h_76,other_cardiac_tissue,Smooth muscle cells,413,17811,0.0231879175790242,94862675,5018235.5075,8.229984411507812e-05,82.29984411507812 +48h,48h_76,remote_endocardial_region,Cardiomyocytes,863,1277,0.6758026624902115,3781176,200024.2104,0.004314477723842573,4314.477723842573 +48h,48h_76,remote_endocardial_region,Endocardial cells,68,1277,0.05324980422866092,3781176,200024.2104,0.0003399588473016164,339.9588473016164 +48h,48h_76,remote_endocardial_region,Endothelial cells,127,1277,0.09945184025058731,3781176,200024.2104,0.0006349231412839013,634.9231412839013 +48h,48h_76,remote_endocardial_region,Fibroblasts,174,1277,0.13625685199686766,3781176,200024.2104,0.0008698946975070773,869.8946975070774 +48h,48h_76,remote_endocardial_region,Macrophages Trem2+,19,1277,0.014878621769772905,3781176,200024.2104,9.498850145192224e-05,94.98850145192225 +48h,48h_76,remote_endocardial_region,Macrophages Trem2-,5,1277,0.003915426781519186,3781176,200024.2104,2.4996974066295324e-05,24.996974066295323 +48h,48h_76,remote_endocardial_region,Mono / Macros Ccr2+,12,1277,0.009397024275646046,3781176,200024.2104,5.999273775910878e-05,59.99273775910878 +48h,48h_76,remote_endocardial_region,Other Leukocytes,3,1277,0.0023492560689115116,3781176,200024.2104,1.4998184439777195e-05,14.998184439777194 +48h,48h_76,remote_endocardial_region,Smooth muscle cells,6,1277,0.004698512137823023,3781176,200024.2104,2.999636887955439e-05,29.99636887955439 +48h,48h_79,border_zone,Cardiomyocytes,1285,9985,0.128693039559339,37194778,1967603.7562,0.0006530786475431918,653.0786475431918 +48h,48h_79,border_zone,Cardiomyocytes Ankrd1+,3023,9985,0.3027541311967952,37194778,1967603.7562,0.0015363865770607538,1536.3865770607538 +48h,48h_79,border_zone,Endocardial cells,61,9985,0.006109163745618428,37194778,1967603.7562,3.100217704290638e-05,31.002177042906382 +48h,48h_79,border_zone,Endothelial cells,1881,9985,0.18838257386079119,37194778,1967603.7562,0.0009559851642247033,955.9851642247033 +48h,48h_79,border_zone,Fibroblasts,830,9985,0.08312468703054582,37194778,1967603.7562,0.00042183290074774253,421.83290074774254 +48h,48h_79,border_zone,Macrophages Trem2+,387,9985,0.038758137205808715,37194778,1967603.7562,0.0001966859428787667,196.6859428787667 +48h,48h_79,border_zone,Macrophages Trem2-,6,9985,0.0006009013520280421,37194778,1967603.7562,3.049394463236693e-06,3.049394463236693 +48h,48h_79,border_zone,Mono / Macros Ccr2+,1778,9985,0.17806710065097647,37194778,1967603.7562,0.00090363722593914,903.63722593914 +48h,48h_79,border_zone,Neutrophils,436,9985,0.04366549824737106,37194778,1967603.7562,0.0002215893309951997,221.5893309951997 +48h,48h_79,border_zone,Other Leukocytes,219,9985,0.021932899349023535,37194778,1967603.7562,0.00011130289790813929,111.30289790813929 +48h,48h_79,border_zone,Smooth muscle cells,79,9985,0.007911867801702555,37194778,1967603.7562,4.015036043261646e-05,40.15036043261646 +48h,48h_79,endocardial_region,Cardiomyocytes,542,1600,0.33875,5304274,280596.0946,0.0019316020801096352,1931.6020801096352 +48h,48h_79,endocardial_region,Cardiomyocytes Ankrd1+,46,1600,0.02875,5304274,280596.0946,0.0001639367079059838,163.9367079059838 +48h,48h_79,endocardial_region,Endocardial cells,148,1600,0.0925,5304274,280596.0946,0.0005274485384801218,527.4485384801219 +48h,48h_79,endocardial_region,Endothelial cells,355,1600,0.221875,5304274,280596.0946,0.0012651637240570488,1265.1637240570487 +48h,48h_79,endocardial_region,Fibroblasts,215,1600,0.134375,5304274,280596.0946,0.0007662259173866634,766.2259173866635 +48h,48h_79,endocardial_region,Macrophages Trem2+,18,1600,0.01125,5304274,280596.0946,6.414914657190671e-05,64.14914657190671 +48h,48h_79,endocardial_region,Mono / Macros Ccr2+,218,1600,0.13625,5304274,280596.0946,0.0007769174418153145,776.9174418153145 +48h,48h_79,endocardial_region,Neutrophils,22,1600,0.01375,5304274,280596.0946,7.840451247677486e-05,78.40451247677485 +48h,48h_79,endocardial_region,Other Leukocytes,33,1600,0.020625,5304274,280596.0946,0.0001176067687151623,117.6067687151623 +48h,48h_79,endocardial_region,Smooth muscle cells,3,1600,0.001875,5304274,280596.0946,1.0691524428651118e-05,10.691524428651118 +48h,48h_79,epicardial_region,Cardiomyocytes,48,965,0.049740932642487044,2428805,128483.78450000001,0.00037358799934788655,373.5879993478865 +48h,48h_79,epicardial_region,Cardiomyocytes Ankrd1+,492,965,0.5098445595854922,2428805,128483.78450000001,0.003829276993315837,3829.276993315837 +48h,48h_79,epicardial_region,Endothelial cells,174,965,0.18031088082901556,2428805,128483.78450000001,0.0013542564976360887,1354.2564976360886 +48h,48h_79,epicardial_region,Fibroblasts,106,965,0.10984455958549223,2428805,128483.78450000001,0.0008250068318932495,825.0068318932495 +48h,48h_79,epicardial_region,Macrophages Trem2+,11,965,0.011398963730569948,2428805,128483.78450000001,8.561391651722401e-05,85.61391651722401 +48h,48h_79,epicardial_region,Mono / Macros Ccr2+,94,965,0.09740932642487046,2428805,128483.78450000001,0.0007316098320562779,731.6098320562778 +48h,48h_79,epicardial_region,Neutrophils,32,965,0.03316062176165803,2428805,128483.78450000001,0.00024905866623192436,249.05866623192438 +48h,48h_79,epicardial_region,Other Leukocytes,7,965,0.007253886010362694,2428805,128483.78450000001,5.4481583238233455e-05,54.481583238233455 +48h,48h_79,epicardial_region,Smooth muscle cells,1,965,0.0010362694300518134,2428805,128483.78450000001,7.783083319747636e-06,7.783083319747637 +48h,48h_79,infarct_core,Cardiomyocytes,79,9142,0.008641435134543863,34491243,1824586.7547000002,4.329747533051079e-05,43.297475330510785 +48h,48h_79,infarct_core,Cardiomyocytes Ankrd1+,4907,9142,0.5367534456355283,34491243,1824586.7547000002,0.002689376094263499,2689.376094263499 +48h,48h_79,infarct_core,Endothelial cells,1090,9142,0.11922992780573179,34491243,1824586.7547000002,0.0005973955456994527,597.3955456994527 +48h,48h_79,infarct_core,Fibroblasts,898,9142,0.09822795887114417,34491243,1824586.7547000002,0.0004921662385670721,492.16623856707207 +48h,48h_79,infarct_core,Macrophages Trem2+,98,9142,0.010719754977029096,34491243,1824586.7547000002,5.3710792182152625e-05,53.71079218215262 +48h,48h_79,infarct_core,Mono / Macros Ccr2+,1292,9142,0.14132574928899586,34491243,1824586.7547000002,0.0007081055459116448,708.1055459116448 +48h,48h_79,infarct_core,Neutrophils,488,9142,0.0533800043754102,34491243,1824586.7547000002,0.00026745782229480085,267.45782229480085 +48h,48h_79,infarct_core,Other Leukocytes,181,9142,0.019798731131043534,34491243,1824586.7547000002,9.920054474458802e-05,99.20054474458802 +48h,48h_79,infarct_core,Smooth muscle cells,109,9142,0.01192299278057318,34491243,1824586.7547000002,5.973955456994527e-05,59.73955456994527 +48h,48h_79,other_cardiac_tissue,Cardiomyocytes,20176,46267,0.43607754987356,200614974,10612532.1246,0.0019011485442980893,1901.1485442980893 +48h,48h_79,other_cardiac_tissue,Cardiomyocytes Ankrd1+,1843,46267,0.03983400695960404,200614974,10612532.1246,0.0001736626074118447,173.6626074118447 +48h,48h_79,other_cardiac_tissue,Endocardial cells,379,46267,0.008191583634123674,200614974,10612532.1246,3.5712494958811255e-05,35.712494958811256 +48h,48h_79,other_cardiac_tissue,Endothelial cells,12568,46267,0.2716406942313096,200614974,10612532.1246,0.001184260254992981,1184.2602549929811 +48h,48h_79,other_cardiac_tissue,Fibroblasts,6015,46267,0.1300062679663691,200614974,10612532.1246,0.0005667827366154345,566.7827366154345 +48h,48h_79,other_cardiac_tissue,Macrophages Trem2+,1508,46267,0.03259342511941556,200614974,10612532.1246,0.00014209615408413554,142.09615408413555 +48h,48h_79,other_cardiac_tissue,Macrophages Trem2-,72,46267,0.001556184753712149,200614974,10612532.1246,6.784431759985251e-06,6.784431759985251 +48h,48h_79,other_cardiac_tissue,Mono / Macros Ccr2+,2442,46267,0.052780599563403724,200614974,10612532.1246,0.00023010531052616645,230.10531052616645 +48h,48h_79,other_cardiac_tissue,Neutrophils,255,46267,0.005511487669397195,200614974,10612532.1246,2.402819581661443e-05,24.02819581661443 +48h,48h_79,other_cardiac_tissue,Other Leukocytes,246,46267,0.005316964575183176,200614974,10612532.1246,2.3180141846616276e-05,23.180141846616277 +48h,48h_79,other_cardiac_tissue,Smooth muscle cells,763,46267,0.016491235653921802,200614974,10612532.1246,7.189613101206593e-05,71.89613101206594 +48h,48h_79,remote_endocardial_region,Cardiomyocytes,375,895,0.41899441340782123,2509680,132762.07200000001,0.0028246018938300386,2824.6018938300385 +48h,48h_79,remote_endocardial_region,Endocardial cells,58,895,0.06480446927374302,2509680,132762.07200000001,0.000436871759579046,436.871759579046 +48h,48h_79,remote_endocardial_region,Endothelial cells,158,895,0.17653631284916202,2509680,132762.07200000001,0.0011900989312670564,1190.0989312670565 +48h,48h_79,remote_endocardial_region,Fibroblasts,205,895,0.22905027932960895,2509680,132762.07200000001,0.0015441157019604212,1544.1157019604211 +48h,48h_79,remote_endocardial_region,Macrophages Trem2+,24,895,0.026815642458100558,2509680,132762.07200000001,0.0001807745212051225,180.77452120512248 +48h,48h_79,remote_endocardial_region,Mono / Macros Ccr2+,69,895,0.07709497206703911,2509680,132762.07200000001,0.0005197267484647271,519.7267484647272 +48h,48h_79,remote_endocardial_region,Other Leukocytes,2,895,0.0022346368715083797,2509680,132762.07200000001,1.5064543433760206e-05,15.064543433760205 +48h,48h_79,remote_endocardial_region,Smooth muscle cells,4,895,0.004469273743016759,2509680,132762.07200000001,3.0129086867520412e-05,30.12908686752041 +4h,4h_96,border_zone,Cardiomyocytes,3758,9963,0.3771956238080899,45897293,2427966.7997000003,0.001547797111749773,1547.797111749773 +4h,4h_96,border_zone,Cardiomyocytes Ankrd1+,4465,9963,0.44815818528555657,45897293,2427966.7997000003,0.0018389872549129155,1838.9872549129154 +4h,4h_96,border_zone,Endocardial cells,97,9963,0.009736023286158788,45897293,2427966.7997000003,3.9951122895084616e-05,39.951122895084616 +4h,4h_96,border_zone,Endothelial cells,784,9963,0.07869115728194319,45897293,2427966.7997000003,0.0003229039211314055,322.9039211314055 +4h,4h_96,border_zone,Fibroblasts,361,9963,0.03623406604436415,45897293,2427966.7997000003,0.00014868407592912933,148.68407592912934 +4h,4h_96,border_zone,Macrophages Trem2+,11,9963,0.0011040851149252233,45897293,2427966.7997000003,4.530539709751864e-06,4.530539709751864 +4h,4h_96,border_zone,Macrophages Trem2-,16,9963,0.0016059419853457794,45897293,2427966.7997000003,6.5898759414572556e-06,6.589875941457255 +4h,4h_96,border_zone,Mono / Macros Ccr2+,125,9963,0.012546421760513902,45897293,2427966.7997000003,5.1483405792634814e-05,51.48340579263481 +4h,4h_96,border_zone,Neutrophils,210,9963,0.021077988557663355,45897293,2427966.7997000003,8.649212173162649e-05,86.49212173162648 +4h,4h_96,border_zone,Other Leukocytes,64,9963,0.006423767941383118,45897293,2427966.7997000003,2.6359503765829022e-05,26.35950376582902 +4h,4h_96,border_zone,Smooth muscle cells,72,9963,0.007226738934056007,45897293,2427966.7997000003,2.9654441736557653e-05,29.654441736557654 +4h,4h_96,endocardial_region,Cardiomyocytes,1229,1906,0.6448058761804827,6959129,368137.92410000006,0.003338422693083252,3338.422693083252 +4h,4h_96,endocardial_region,Cardiomyocytes Ankrd1+,153,1906,0.08027282266526757,6959129,368137.92410000006,0.0004156051033700061,415.60510337000613 +4h,4h_96,endocardial_region,Endocardial cells,132,1906,0.06925498426023086,6959129,368137.92410000006,0.00035856126565255434,358.56126565255437 +4h,4h_96,endocardial_region,Endothelial cells,178,1906,0.09338929695697797,6959129,368137.92410000006,0.00048351443398602024,483.5144339860202 +4h,4h_96,endocardial_region,Fibroblasts,87,1906,0.04564533053515215,6959129,368137.92410000006,0.00023632447054372898,236.32447054372898 +4h,4h_96,endocardial_region,Macrophages Trem2+,5,1906,0.0026232948583420775,6959129,368137.92410000006,1.3581866123202816e-05,13.581866123202815 +4h,4h_96,endocardial_region,Macrophages Trem2-,3,1906,0.0015739769150052466,6959129,368137.92410000006,8.14911967392169e-06,8.149119673921689 +4h,4h_96,endocardial_region,Mono / Macros Ccr2+,33,1906,0.017313746065057714,6959129,368137.92410000006,8.964031641313859e-05,89.64031641313859 +4h,4h_96,endocardial_region,Neutrophils,78,1906,0.040923399790136414,6959129,368137.92410000006,0.0002118771115219639,211.8771115219639 +4h,4h_96,endocardial_region,Other Leukocytes,7,1906,0.0036726128016789086,6959129,368137.92410000006,1.901461257248394e-05,19.01461257248394 +4h,4h_96,endocardial_region,Smooth muscle cells,1,1906,0.0005246589716684155,6959129,368137.92410000006,2.716373224640563e-06,2.716373224640563 +4h,4h_96,epicardial_region,Cardiomyocytes,352,842,0.4180522565320665,2954790,156308.39100000003,0.0022519584377271207,2251.958437727121 +4h,4h_96,epicardial_region,Cardiomyocytes Ankrd1+,327,842,0.38836104513064135,2954790,156308.39100000003,0.0020920182077749103,2092.0182077749105 +4h,4h_96,epicardial_region,Endothelial cells,98,842,0.1163895486935867,2954790,156308.39100000003,0.0006269657014126642,626.9657014126642 +4h,4h_96,epicardial_region,Fibroblasts,49,842,0.05819477434679335,2954790,156308.39100000003,0.0003134828507063321,313.4828507063321 +4h,4h_96,epicardial_region,Macrophages Trem2+,1,842,0.0011876484560570072,2954790,156308.39100000003,6.397609198088411e-06,6.397609198088411 +4h,4h_96,epicardial_region,Mono / Macros Ccr2+,3,842,0.0035629453681710215,2954790,156308.39100000003,1.919282759426523e-05,19.192827594265232 +4h,4h_96,epicardial_region,Other Leukocytes,11,842,0.013064133016627079,2954790,156308.39100000003,7.037370117897252e-05,70.37370117897252 +4h,4h_96,epicardial_region,Smooth muscle cells,1,842,0.0011876484560570072,2954790,156308.39100000003,6.397609198088411e-06,6.397609198088411 +4h,4h_96,infarct_core,Cardiomyocytes,2405,9054,0.26562845151314335,47888531,2533303.2899,0.0009493533638820384,949.3533638820385 +4h,4h_96,infarct_core,Cardiomyocytes Ankrd1+,5558,9054,0.6138723216258007,47888531,2533303.2899,0.0021939733872999457,2193.973387299946 +4h,4h_96,infarct_core,Endothelial cells,491,9054,0.05423017450850453,47888531,2533303.2899,0.00019381808801084444,193.81808801084443 +4h,4h_96,infarct_core,Fibroblasts,269,9054,0.029710625138060526,47888531,2533303.2899,0.00010618546980634858,106.18546980634858 +4h,4h_96,infarct_core,Macrophages Trem2+,5,9054,0.000552242102937928,47888531,2533303.2899,1.973707617218375e-06,1.9737076172183752 +4h,4h_96,infarct_core,Macrophages Trem2-,2,9054,0.0002208968411751712,47888531,2533303.2899,7.894830468873501e-07,0.78948304688735 +4h,4h_96,infarct_core,Mono / Macros Ccr2+,30,9054,0.0033134526176275677,47888531,2533303.2899,1.1842245703310251e-05,11.842245703310251 +4h,4h_96,infarct_core,Neutrophils,71,9054,0.007841837861718578,47888531,2533303.2899,2.8026648164500925e-05,28.026648164500926 +4h,4h_96,infarct_core,Other Leukocytes,36,9054,0.003976143141153081,47888531,2533303.2899,1.4210694843972302e-05,14.210694843972302 +4h,4h_96,infarct_core,Smooth muscle cells,187,9054,0.020653854649878508,47888531,2533303.2899,7.381666488396723e-05,73.81666488396723 +4h,4h_96,other_cardiac_tissue,Cardiomyocytes,19703,29236,0.6739294021069914,131756856,6969937.682400001,0.0028268545427246267,2826.8545427246268 +4h,4h_96,other_cardiac_tissue,Cardiomyocytes Ankrd1+,3504,29236,0.1198522369681215,131756856,6969937.682400001,0.0005027304632648375,502.73046326483745 +4h,4h_96,other_cardiac_tissue,Endocardial cells,148,29236,0.0050622520180599265,131756856,6969937.682400001,2.1234049247487426e-05,21.234049247487427 +4h,4h_96,other_cardiac_tissue,Endothelial cells,3515,29236,0.12022848542892324,131756856,6969937.682400001,0.0005043086696278264,504.30866962782636 +4h,4h_96,other_cardiac_tissue,Fibroblasts,1566,29236,0.05356409905595841,131756856,6969937.682400001,0.00022467919676733318,224.67919676733317 +4h,4h_96,other_cardiac_tissue,Macrophages Trem2+,50,29236,0.0017102202763715968,131756856,6969937.682400001,7.173665286313319e-06,7.1736652863133195 +4h,4h_96,other_cardiac_tissue,Macrophages Trem2-,14,29236,0.00047886167738404704,131756856,6969937.682400001,2.0086262801677296e-06,2.0086262801677295 +4h,4h_96,other_cardiac_tissue,Mono / Macros Ccr2+,122,29236,0.004172937474346695,131756856,6969937.682400001,1.75037432986045e-05,17.503743298604498 +4h,4h_96,other_cardiac_tissue,Neutrophils,127,29236,0.004343959501983855,131756856,6969937.682400001,1.822110982723583e-05,18.221109827235832 +4h,4h_96,other_cardiac_tissue,Other Leukocytes,59,29236,0.002018059926118484,131756856,6969937.682400001,8.464925037849717e-06,8.464925037849717 +4h,4h_96,other_cardiac_tissue,Smooth muscle cells,428,29236,0.014639485565740868,131756856,6969937.682400001,6.140657485084202e-05,61.40657485084202 +4h,4h_96,remote_endocardial_region,Cardiomyocytes,616,839,0.734207389749702,2164812,114518.55480000001,0.0053790409866401835,5379.040986640183 +4h,4h_96,remote_endocardial_region,Cardiomyocytes Ankrd1+,3,839,0.003575685339690107,2164812,114518.55480000001,2.6196628181689207e-05,26.196628181689206 +4h,4h_96,remote_endocardial_region,Endocardial cells,64,839,0.07628128724672228,2164812,114518.55480000001,0.0005588614012093697,558.8614012093697 +4h,4h_96,remote_endocardial_region,Endothelial cells,38,839,0.04529201430274136,2164812,114518.55480000001,0.00033182395696806325,331.82395696806327 +4h,4h_96,remote_endocardial_region,Fibroblasts,109,839,0.1299165673420739,2164812,114518.55480000001,0.0009518108239347078,951.8108239347077 +4h,4h_96,remote_endocardial_region,Macrophages Trem2+,5,839,0.0059594755661501785,2164812,114518.55480000001,4.366104696948201e-05,43.66104696948201 +4h,4h_96,remote_endocardial_region,Macrophages Trem2-,2,839,0.0023837902264600714,2164812,114518.55480000001,1.7464418787792802e-05,17.464418787792802 +4h,4h_96,remote_endocardial_region,Mono / Macros Ccr2+,1,839,0.0011918951132300357,2164812,114518.55480000001,8.732209393896401e-06,8.732209393896401 +4h,4h_96,remote_endocardial_region,Smooth muscle cells,1,839,0.0011918951132300357,2164812,114518.55480000001,8.732209393896401e-06,8.732209393896401 +4h,4h_97,border_zone,Cardiomyocytes,5870,10792,0.5439214232765011,53979983,2855541.1007000003,0.0020556524290828953,2055.652429082895 +4h,4h_97,border_zone,Cardiomyocytes Ankrd1+,1986,10792,0.1840252038547072,53979983,2855541.1007000003,0.0006954899019009591,695.489901900959 +4h,4h_97,border_zone,Endocardial cells,113,10792,0.010470719051149,53979983,2855541.1007000003,3.95721847506588e-05,39.5721847506588 +4h,4h_97,border_zone,Endothelial cells,1164,10792,0.1078576723498888,53979983,2855541.1007000003,0.00040762852256430833,407.62852256430835 +4h,4h_97,border_zone,Fibroblasts,557,10792,0.051612305411415864,53979983,2855541.1007000003,0.00019505935315147747,195.05935315147747 +4h,4h_97,border_zone,Macrophages Trem2+,20,10792,0.0018532246108228317,53979983,2855541.1007000003,7.003926504541381e-06,7.003926504541381 +4h,4h_97,border_zone,Macrophages Trem2-,14,10792,0.0012972572275759822,53979983,2855541.1007000003,4.902748553178966e-06,4.9027485531789665 +4h,4h_97,border_zone,Mono / Macros Ccr2+,212,10792,0.019644180874722018,53979983,2855541.1007000003,7.424162094813863e-05,74.24162094813863 +4h,4h_97,border_zone,Neutrophils,565,10792,0.052353595255745,53979983,2855541.1007000003,0.000197860923753294,197.860923753294 +4h,4h_97,border_zone,Other Leukocytes,68,10792,0.006300963676797628,53979983,2855541.1007000003,2.3813350115440695e-05,23.813350115440695 +4h,4h_97,border_zone,Smooth muscle cells,223,10792,0.020663454410674575,53979983,2855541.1007000003,7.809378052563639e-05,78.09378052563639 +4h,4h_97,endocardial_region,Cardiomyocytes,1026,1538,0.6671001300390117,6478108,342691.9132,0.002993942840434672,2993.942840434672 +4h,4h_97,endocardial_region,Cardiomyocytes Ankrd1+,21,1538,0.013654096228868661,6478108,342691.9132,6.127953182176228e-05,61.27953182176228 +4h,4h_97,endocardial_region,Endocardial cells,128,1538,0.08322496749024708,6478108,342691.9132,0.0003735133368183606,373.5133368183606 +4h,4h_97,endocardial_region,Endothelial cells,111,1538,0.07217165149544863,6478108,342691.9132,0.0003239060967721721,323.9060967721721 +4h,4h_97,endocardial_region,Fibroblasts,116,1538,0.0754226267880364,6478108,342691.9132,0.0003384964614916393,338.4964614916393 +4h,4h_97,endocardial_region,Macrophages Trem2+,2,1538,0.0013003901170351106,6478108,342691.9132,5.836145887786884e-06,5.836145887786884 +4h,4h_97,endocardial_region,Macrophages Trem2-,4,1538,0.002600780234070221,6478108,342691.9132,1.1672291775573769e-05,11.672291775573768 +4h,4h_97,endocardial_region,Mono / Macros Ccr2+,46,1538,0.02990897269180754,6478108,342691.9132,0.00013423135541909835,134.23135541909835 +4h,4h_97,endocardial_region,Neutrophils,74,1538,0.04811443433029909,6478108,342691.9132,0.00021593739784811473,215.93739784811473 +4h,4h_97,endocardial_region,Other Leukocytes,4,1538,0.002600780234070221,6478108,342691.9132,1.1672291775573769e-05,11.672291775573768 +4h,4h_97,endocardial_region,Smooth muscle cells,6,1538,0.0039011703511053317,6478108,342691.9132,1.7508437663360654e-05,17.508437663360652 +4h,4h_97,epicardial_region,Cardiomyocytes,1329,1771,0.7504234895539243,6310568,333829.04720000003,0.0039810795709571195,3981.0795709571194 +4h,4h_97,epicardial_region,Cardiomyocytes Ankrd1+,74,1771,0.04178430265386787,6310568,333829.04720000003,0.00022167034480874854,221.67034480874855 +4h,4h_97,epicardial_region,Endothelial cells,187,1771,0.10559006211180125,6310568,333829.04720000003,0.0005601669524221078,560.1669524221078 +4h,4h_97,epicardial_region,Fibroblasts,87,1771,0.04912478825522304,6310568,333829.04720000003,0.00026061243241028544,260.61243241028546 +4h,4h_97,epicardial_region,Macrophages Trem2+,1,1771,0.000564652738565782,6310568,333829.04720000003,2.9955452001182238e-06,2.9955452001182237 +4h,4h_97,epicardial_region,Macrophages Trem2-,4,1771,0.002258610954263128,6310568,333829.04720000003,1.1982180800472895e-05,11.982180800472895 +4h,4h_97,epicardial_region,Mono / Macros Ccr2+,21,1771,0.011857707509881422,6310568,333829.04720000003,6.290644920248269e-05,62.90644920248269 +4h,4h_97,epicardial_region,Neutrophils,33,1771,0.018633540372670808,6310568,333829.04720000003,9.885299160390137e-05,98.85299160390137 +4h,4h_97,epicardial_region,Other Leukocytes,5,1771,0.00282326369282891,6310568,333829.04720000003,1.4977726000591117e-05,14.977726000591117 +4h,4h_97,epicardial_region,Smooth muscle cells,30,1771,0.01693958215697346,6310568,333829.04720000003,8.986635600354671e-05,89.86635600354671 +4h,4h_97,infarct_core,Cardiomyocytes,6829,12055,0.5664869348817918,61488256,3252728.7424000003,0.0020994680284840707,2099.4680284840706 +4h,4h_97,infarct_core,Cardiomyocytes Ankrd1+,2989,12055,0.24794690999585234,61488256,3252728.7424000003,0.0009189207698255803,918.9207698255802 +4h,4h_97,infarct_core,Endothelial cells,925,12055,0.0767316466196599,61488256,3252728.7424000003,0.0002843766182966416,284.3766182966416 +4h,4h_97,infarct_core,Fibroblasts,419,12055,0.034757362090418915,61488256,3252728.7424000003,0.0001288149222338301,128.8149222338301 +4h,4h_97,infarct_core,Macrophages Trem2+,12,12055,0.0009954375777685607,61488256,3252728.7424000003,3.689210183307783e-06,3.689210183307783 +4h,4h_97,infarct_core,Macrophages Trem2-,9,12055,0.0007465781833264206,61488256,3252728.7424000003,2.7669076374808375e-06,2.7669076374808377 +4h,4h_97,infarct_core,Mono / Macros Ccr2+,157,12055,0.013023641642472003,61488256,3252728.7424000003,4.8267166564943496e-05,48.267166564943494 +4h,4h_97,infarct_core,Neutrophils,427,12055,0.03542098714226462,61488256,3252728.7424000003,0.0001312743956893686,131.27439568936862 +4h,4h_97,infarct_core,Other Leukocytes,24,12055,0.0019908751555371214,61488256,3252728.7424000003,7.378420366615566e-06,7.378420366615566 +4h,4h_97,infarct_core,Smooth muscle cells,264,12055,0.021899626710908338,61488256,3252728.7424000003,8.116262403277122e-05,81.16262403277122 +4h,4h_97,other_cardiac_tissue,Cardiomyocytes,27632,39969,0.691335785233556,189765042,10038570.721800001,0.002752583088346799,2752.583088346799 +4h,4h_97,other_cardiac_tissue,Cardiomyocytes Ankrd1+,1272,39969,0.031824664114688886,189765042,10038570.721800001,0.00012671126550293602,126.71126550293602 +4h,4h_97,other_cardiac_tissue,Endocardial cells,201,39969,0.005028897395481498,189765042,10038570.721800001,2.0022770728058285e-05,20.022770728058283 +4h,4h_97,other_cardiac_tissue,Endothelial cells,6358,39969,0.15907328179338986,189765042,10038570.721800001,0.0006333570959651472,633.3570959651471 +4h,4h_97,other_cardiac_tissue,Fibroblasts,2733,39969,0.068377992944532,189765042,10038570.721800001,0.0002722499124367328,272.2499124367328 +4h,4h_97,other_cardiac_tissue,Macrophages Trem2+,82,39969,0.0020515899822362333,189765042,10038570.721800001,8.168493530849648e-06,8.168493530849648 +4h,4h_97,other_cardiac_tissue,Macrophages Trem2-,95,39969,0.002376842052590758,189765042,10038570.721800001,9.463498602813617e-06,9.463498602813617 +4h,4h_97,other_cardiac_tissue,Mono / Macros Ccr2+,291,39969,0.0072806424979359,189765042,10038570.721800001,2.8988190457039606e-05,28.988190457039607 +4h,4h_97,other_cardiac_tissue,Neutrophils,553,39969,0.013835722685080938,189765042,10038570.721800001,5.50875234458519e-05,55.0875234458519 +4h,4h_97,other_cardiac_tissue,Other Leukocytes,54,39969,0.0013510470614726414,189765042,10038570.721800001,5.379251837388793e-06,5.379251837388793 +4h,4h_97,other_cardiac_tissue,Smooth muscle cells,698,39969,0.017463534239035253,189765042,10038570.721800001,6.953181078698847e-05,69.53181078698847 +4h,4h_97,remote_endocardial_region,Cardiomyocytes,914,1232,0.7418831168831169,3321300,175696.77000000002,0.005202144581257811,5202.14458125781 +4h,4h_97,remote_endocardial_region,Cardiomyocytes Ankrd1+,3,1232,0.002435064935064935,3321300,175696.77000000002,1.7074872805003757e-05,17.074872805003757 +4h,4h_97,remote_endocardial_region,Endocardial cells,81,1232,0.06574675324675325,3321300,175696.77000000002,0.0004610215657351014,461.0215657351014 +4h,4h_97,remote_endocardial_region,Endothelial cells,114,1232,0.09253246753246754,3321300,175696.77000000002,0.0006488451665901427,648.8451665901428 +4h,4h_97,remote_endocardial_region,Fibroblasts,114,1232,0.09253246753246754,3321300,175696.77000000002,0.0006488451665901427,648.8451665901428 +4h,4h_97,remote_endocardial_region,Macrophages Trem2+,2,1232,0.0016233766233766235,3321300,175696.77000000002,1.138324853666917e-05,11.38324853666917 +4h,4h_97,remote_endocardial_region,Macrophages Trem2-,2,1232,0.0016233766233766235,3321300,175696.77000000002,1.138324853666917e-05,11.38324853666917 +4h,4h_97,remote_endocardial_region,Other Leukocytes,1,1232,0.0008116883116883117,3321300,175696.77000000002,5.691624268334585e-06,5.691624268334585 +4h,4h_97,remote_endocardial_region,Smooth muscle cells,1,1232,0.0008116883116883117,3321300,175696.77000000002,5.691624268334585e-06,5.691624268334585 +Control,Control_12,border_zone,Cardiomyocytes,5641,7747,0.728152833354847,37450197,1981115.4213000003,0.002847385841001832,2847.385841001832 +Control,Control_12,border_zone,Cardiomyocytes Ankrd1+,56,7747,0.007228604621143668,37450197,1981115.4213000003,2.8266904289328592e-05,28.266904289328593 +Control,Control_12,border_zone,Endocardial cells,112,7747,0.014457209242287336,37450197,1981115.4213000003,5.6533808578657184e-05,56.53380857865719 +Control,Control_12,border_zone,Endothelial cells,1424,7747,0.18381308893765327,37450197,1981115.4213000003,0.0007187869947857843,718.7869947857843 +Control,Control_12,border_zone,Fibroblasts,403,7747,0.0520201368271589,37450197,1981115.4213000003,0.00020342075765356112,203.4207576535611 +Control,Control_12,border_zone,Macrophages Trem2+,8,7747,0.001032657803020524,37450197,1981115.4213000003,4.038129184189799e-06,4.038129184189799 +Control,Control_12,border_zone,Mono / Macros Ccr2+,52,7747,0.006712275719633407,37450197,1981115.4213000003,2.6247839697233693e-05,26.247839697233694 +Control,Control_12,border_zone,Other Leukocytes,6,7747,0.0007744933522653931,37450197,1981115.4213000003,3.0285968881423492e-06,3.0285968881423493 +Control,Control_12,border_zone,Smooth muscle cells,45,7747,0.005808700141990448,37450197,1981115.4213000003,2.2714476661067618e-05,22.714476661067618 +Control,Control_12,endocardial_region,Cardiomyocytes,928,1414,0.6562942008486563,4614625,244113.6625,0.0038015078324426022,3801.507832442602 +Control,Control_12,endocardial_region,Cardiomyocytes Ankrd1+,13,1414,0.009193776520509194,4614625,244113.6625,5.3253881273441625e-05,53.25388127344163 +Control,Control_12,endocardial_region,Endocardial cells,197,1414,0.13932107496463933,4614625,244113.6625,0.0008070011239129231,807.0011239129232 +Control,Control_12,endocardial_region,Endothelial cells,141,1414,0.09971711456859972,4614625,244113.6625,0.0005775997891965592,577.5997891965592 +Control,Control_12,endocardial_region,Fibroblasts,133,1414,0.09405940594059406,4614625,244113.6625,0.0005448281699513643,544.8281699513643 +Control,Control_12,endocardial_region,Neutrophils,1,1414,0.0007072135785007072,4614625,244113.6625,4.096452405649356e-06,4.096452405649356 +Control,Control_12,endocardial_region,Other Leukocytes,1,1414,0.0007072135785007072,4614625,244113.6625,4.096452405649356e-06,4.096452405649356 +Control,Control_12,epicardial_region,Cardiomyocytes,1196,1605,0.7451713395638629,6129418,324246.21220000007,0.003688555039348582,3688.5550393485823 +Control,Control_12,epicardial_region,Cardiomyocytes Ankrd1+,41,1605,0.02554517133956386,6129418,324246.21220000007,0.00012644712091412365,126.44712091412364 +Control,Control_12,epicardial_region,Endothelial cells,210,1605,0.1308411214953271,6129418,324246.21220000007,0.0006476559851699015,647.6559851699016 +Control,Control_12,epicardial_region,Fibroblasts,139,1605,0.08660436137071652,6129418,324246.21220000007,0.0004286865806600777,428.6865806600777 +Control,Control_12,epicardial_region,Macrophages Trem2+,4,1605,0.0024922118380062306,6129418,324246.21220000007,1.2336304479426696e-05,12.336304479426696 +Control,Control_12,epicardial_region,Mono / Macros Ccr2+,10,1605,0.006230529595015576,6129418,324246.21220000007,3.084076119856674e-05,30.84076119856674 +Control,Control_12,epicardial_region,Neutrophils,3,1605,0.001869158878504673,6129418,324246.21220000007,9.252228359570022e-06,9.252228359570022 +Control,Control_12,epicardial_region,Other Leukocytes,2,1605,0.0012461059190031153,6129418,324246.21220000007,6.168152239713348e-06,6.168152239713348 +Control,Control_12,infarct_core,Cardiomyocytes,10562,13514,0.7815598638449016,75605896,3999551.8984000008,0.002640795836209869,2640.7958362098693 +Control,Control_12,infarct_core,Cardiomyocytes Ankrd1+,105,13514,0.007769720290069558,75605896,3999551.8984000008,2.6252940996216273e-05,26.252940996216275 +Control,Control_12,infarct_core,Endothelial cells,2365,13514,0.1750036998668048,75605896,3999551.8984000008,0.0005913162424385855,591.3162424385855 +Control,Control_12,infarct_core,Fibroblasts,304,13514,0.022495190173153767,75605896,3999551.8984000008,7.60085148842833e-05,76.0085148842833 +Control,Control_12,infarct_core,Macrophages Trem2+,5,13514,0.00036998668047950276,75605896,3999551.8984000008,1.2501400474388702e-06,1.2501400474388702 +Control,Control_12,infarct_core,Macrophages Trem2-,3,13514,0.00022199200828770165,75605896,3999551.8984000008,7.50084028463322e-07,0.750084028463322 +Control,Control_12,infarct_core,Mono / Macros Ccr2+,60,13514,0.0044398401657540325,75605896,3999551.8984000008,1.5001680569266442e-05,15.001680569266442 +Control,Control_12,infarct_core,Neutrophils,13,13514,0.0009619653692467072,75605896,3999551.8984000008,3.2503641233410623e-06,3.2503641233410625 +Control,Control_12,infarct_core,Other Leukocytes,5,13514,0.00036998668047950276,75605896,3999551.8984000008,1.2501400474388702e-06,1.2501400474388702 +Control,Control_12,infarct_core,Smooth muscle cells,92,13514,0.00680775492082285,75605896,3999551.8984000008,2.300257687287521e-05,23.00257687287521 +Control,Control_12,other_cardiac_tissue,Cardiomyocytes,30538,42718,0.7148742918675968,203358604,10757670.151600001,0.0028387187531919303,2838.7187531919303 +Control,Control_12,other_cardiac_tissue,Cardiomyocytes Ankrd1+,738,42718,0.017276089704574185,203358604,10757670.151600001,6.860221494058695e-05,68.60221494058695 +Control,Control_12,other_cardiac_tissue,Endocardial cells,243,42718,0.0056884685612622315,203358604,10757670.151600001,2.2588534187754243e-05,22.58853418775424 +Control,Control_12,other_cardiac_tissue,Endothelial cells,8941,42718,0.20930286998454983,203358604,10757670.151600001,0.0008311279184062168,831.1279184062168 +Control,Control_12,other_cardiac_tissue,Fibroblasts,1842,42718,0.0431199962545063,203358604,10757670.151600001,0.00017122666655902598,171.22666655902597 +Control,Control_12,other_cardiac_tissue,Macrophages Trem2+,16,42718,0.0003745493702888712,203358604,10757670.151600001,1.4873108930208556e-06,1.4873108930208556 +Control,Control_12,other_cardiac_tissue,Mono / Macros Ccr2+,153,42718,0.003581628353387331,203358604,10757670.151600001,1.4222410414511931e-05,14.22241041451193 +Control,Control_12,other_cardiac_tissue,Neutrophils,28,42718,0.0006554613980055246,203358604,10757670.151600001,2.602794062786497e-06,2.6027940627864967 +Control,Control_12,other_cardiac_tissue,Other Leukocytes,14,42718,0.0003277306990027623,203358604,10757670.151600001,1.3013970313932485e-06,1.3013970313932484 +Control,Control_12,other_cardiac_tissue,Smooth muscle cells,205,42718,0.0047989138068261624,203358604,10757670.151600001,1.905617081682971e-05,19.05617081682971 +Control,Control_13,border_zone,Cardiomyocytes,3767,6098,0.6177435224663824,31268138,1654084.5002000001,0.00227739272059228,2277.39272059228 +Control,Control_13,border_zone,Cardiomyocytes Ankrd1+,3,6098,0.0004919645785503444,31268138,1654084.5002000001,1.8136921055951261e-06,1.813692105595126 +Control,Control_13,border_zone,Endocardial cells,59,6098,0.009675303378156773,31268138,1654084.5002000001,3.566927807670415e-05,35.669278076704146 +Control,Control_13,border_zone,Endothelial cells,1525,6098,0.25008199409642506,31268138,1654084.5002000001,0.0009219601536775224,921.9601536775224 +Control,Control_13,border_zone,Fibroblasts,599,6098,0.09822892751721876,31268138,1654084.5002000001,0.00036213385708382687,362.13385708382685 +Control,Control_13,border_zone,Macrophages Trem2+,13,6098,0.002131846507051492,31268138,1654084.5002000001,7.859332457578879e-06,7.859332457578879 +Control,Control_13,border_zone,Macrophages Trem2-,10,6098,0.0016398819285011479,31268138,1654084.5002000001,6.045640351983754e-06,6.045640351983754 +Control,Control_13,border_zone,Mono / Macros Ccr2+,11,6098,0.0018038701213512628,31268138,1654084.5002000001,6.650204387182129e-06,6.6502043871821295 +Control,Control_13,border_zone,Other Leukocytes,10,6098,0.0016398819285011479,31268138,1654084.5002000001,6.045640351983754e-06,6.045640351983754 +Control,Control_13,border_zone,Smooth muscle cells,101,6098,0.016562807477861593,31268138,1654084.5002000001,6.106096755503592e-05,61.060967555035916 +Control,Control_13,endocardial_region,Cardiomyocytes,841,1489,0.564808596373405,5392495,285262.9855,0.002948156763226472,2948.156763226472 +Control,Control_13,endocardial_region,Cardiomyocytes Ankrd1+,1,1489,0.000671591672263264,5392495,285262.9855,3.5055371738721426e-06,3.505537173872143 +Control,Control_13,endocardial_region,Endocardial cells,198,1489,0.13297515110812627,5392495,285262.9855,0.0006940963604266842,694.0963604266842 +Control,Control_13,endocardial_region,Endothelial cells,251,1489,0.16856950973807924,5392495,285262.9855,0.0008798898306419078,879.8898306419078 +Control,Control_13,endocardial_region,Fibroblasts,188,1489,0.1262592343854936,5392495,285262.9855,0.0006590409886879628,659.0409886879628 +Control,Control_13,endocardial_region,Macrophages Trem2+,1,1489,0.000671591672263264,5392495,285262.9855,3.5055371738721426e-06,3.505537173872143 +Control,Control_13,endocardial_region,Macrophages Trem2-,2,1489,0.001343183344526528,5392495,285262.9855,7.011074347744285e-06,7.011074347744286 +Control,Control_13,endocardial_region,Mono / Macros Ccr2+,1,1489,0.000671591672263264,5392495,285262.9855,3.5055371738721426e-06,3.505537173872143 +Control,Control_13,endocardial_region,Other Leukocytes,3,1489,0.0020147750167897917,5392495,285262.9855,1.0516611521616428e-05,10.516611521616428 +Control,Control_13,endocardial_region,Smooth muscle cells,3,1489,0.0020147750167897917,5392495,285262.9855,1.0516611521616428e-05,10.516611521616428 +Control,Control_13,epicardial_region,Cardiomyocytes,667,1067,0.6251171508903468,3724757,197039.6453,0.0033851055658594407,3385.1055658594405 +Control,Control_13,epicardial_region,Cardiomyocytes Ankrd1+,9,1067,0.008434864104967198,3724757,197039.6453,4.5676087095554674e-05,45.67608709555467 +Control,Control_13,epicardial_region,Endothelial cells,213,1067,0.19962511715089035,3724757,197039.6453,0.0010810007279281272,1081.0007279281272 +Control,Control_13,epicardial_region,Fibroblasts,160,1067,0.14995313964386128,3724757,197039.6453,0.0008120193261431941,812.0193261431941 +Control,Control_13,epicardial_region,Macrophages Trem2+,5,1067,0.004686035613870665,3724757,197039.6453,2.5375603941974817e-05,25.375603941974816 +Control,Control_13,epicardial_region,Macrophages Trem2-,1,1067,0.0009372071227741331,3724757,197039.6453,5.075120788394963e-06,5.075120788394964 +Control,Control_13,epicardial_region,Mono / Macros Ccr2+,4,1067,0.0037488284910965324,3724757,197039.6453,2.0300483153579853e-05,20.300483153579854 +Control,Control_13,epicardial_region,Other Leukocytes,5,1067,0.004686035613870665,3724757,197039.6453,2.5375603941974817e-05,25.375603941974816 +Control,Control_13,epicardial_region,Smooth muscle cells,3,1067,0.0028116213683223993,3724757,197039.6453,1.522536236518489e-05,15.22536236518489 +Control,Control_13,infarct_core,Cardiomyocytes,7721,12344,0.6254860661049902,65746772,3478004.2388000004,0.0022199512909920837,2219.9512909920836 +Control,Control_13,infarct_core,Cardiomyocytes Ankrd1+,15,12344,0.0012151652624756966,65746772,3478004.2388000004,4.312818205527944e-06,4.312818205527944 +Control,Control_13,infarct_core,Endothelial cells,3069,12344,0.24862281270252753,65746772,3478004.2388000004,0.0008824026048510173,882.4026048510173 +Control,Control_13,infarct_core,Fibroblasts,1143,12344,0.09259559300064808,65746772,3478004.2388000004,0.00032863674726122934,328.63674726122935 +Control,Control_13,infarct_core,Macrophages Trem2+,46,12344,0.0037265068049254697,65746772,3478004.2388000004,1.3225975830285695e-05,13.225975830285694 +Control,Control_13,infarct_core,Macrophages Trem2-,31,12344,0.0025113415424497733,65746772,3478004.2388000004,8.91315762475775e-06,8.91315762475775 +Control,Control_13,infarct_core,Mono / Macros Ccr2+,36,12344,0.002916396629941672,65746772,3478004.2388000004,1.0350763693267065e-05,10.350763693267064 +Control,Control_13,infarct_core,Neutrophils,1,12344,8.101101749837978e-05,65746772,3478004.2388000004,2.875212137018629e-07,0.2875212137018629 +Control,Control_13,infarct_core,Other Leukocytes,17,12344,0.0013771872974724562,65746772,3478004.2388000004,4.88786063293167e-06,4.88786063293167 +Control,Control_13,infarct_core,Smooth muscle cells,265,12344,0.02146791963707064,65746772,3478004.2388000004,7.619312163099367e-05,76.19312163099367 +Control,Control_13,other_cardiac_tissue,Cardiomyocytes,27195,45359,0.5995502546352433,213883446,11314434.293400003,0.0024035669212258835,2403.5669212258836 +Control,Control_13,other_cardiac_tissue,Cardiomyocytes Ankrd1+,46,45359,0.0010141317048435812,213883446,11314434.293400003,4.065603176186455e-06,4.065603176186455 +Control,Control_13,other_cardiac_tissue,Endocardial cells,314,45359,0.006922551202627924,213883446,11314434.293400003,2.7752160811359717e-05,27.752160811359715 +Control,Control_13,other_cardiac_tissue,Endothelial cells,12518,45359,0.275976101765912,213883446,11314434.293400003,0.0011063743599891748,1106.3743599891748 +Control,Control_13,other_cardiac_tissue,Fibroblasts,4233,45359,0.09332216318701911,213883446,11314434.293400003,0.00037412387488689706,374.12387488689706 +Control,Control_13,other_cardiac_tissue,Macrophages Trem2+,150,45359,0.0033069512114464604,213883446,11314434.293400003,1.325740166147757e-05,13.25740166147757 +Control,Control_13,other_cardiac_tissue,Macrophages Trem2-,51,45359,0.0011243634118917965,213883446,11314434.293400003,4.507516564902374e-06,4.507516564902374 +Control,Control_13,other_cardiac_tissue,Mono / Macros Ccr2+,90,45359,0.001984170726867876,213883446,11314434.293400003,7.954440996886542e-06,7.954440996886542 +Control,Control_13,other_cardiac_tissue,Neutrophils,4,45359,8.818536563857227e-05,213883446,11314434.293400003,3.5353071097273523e-07,0.35353071097273525 +Control,Control_13,other_cardiac_tissue,Other Leukocytes,42,45359,0.0009259463392050089,213883446,11314434.293400003,3.71207246521372e-06,3.71207246521372 +Control,Control_13,other_cardiac_tissue,Smooth muscle cells,716,45359,0.015785180449304437,213883446,11314434.293400003,6.328199726411961e-05,63.28199726411961 +Control,Control_14,border_zone,Cardiomyocytes,4846,6022,0.8047160411823314,39143921,2070713.4209,0.0023402562378205716,2340.2562378205716 +Control,Control_14,border_zone,Cardiomyocytes Ankrd1+,4,6022,0.0006642311524410495,39143921,2070713.4209,1.9317013931659693e-06,1.9317013931659692 +Control,Control_14,border_zone,Endocardial cells,18,6022,0.0029890401859847225,39143921,2070713.4209,8.692656269246861e-06,8.69265626924686 +Control,Control_14,border_zone,Endothelial cells,606,6022,0.100631019594819,39143921,2070713.4209,0.0002926527610646443,292.6527610646443 +Control,Control_14,border_zone,Fibroblasts,289,6022,0.04799070076386582,39143921,2070713.4209,0.00013956542565624126,139.56542565624127 +Control,Control_14,border_zone,Macrophages Trem2+,18,6022,0.0029890401859847225,39143921,2070713.4209,8.692656269246861e-06,8.69265626924686 +Control,Control_14,border_zone,Macrophages Trem2-,21,6022,0.0034872135503155096,39143921,2070713.4209,1.0141432314121338e-05,10.141432314121339 +Control,Control_14,border_zone,Mono / Macros Ccr2+,7,6022,0.0011624045167718366,39143921,2070713.4209,3.380477438040446e-06,3.380477438040446 +Control,Control_14,border_zone,Neutrophils,1,6022,0.00016605778811026238,39143921,2070713.4209,4.829253482914923e-07,0.4829253482914923 +Control,Control_14,border_zone,Other Leukocytes,1,6022,0.00016605778811026238,39143921,2070713.4209,4.829253482914923e-07,0.4829253482914923 +Control,Control_14,border_zone,Smooth muscle cells,211,6022,0.03503819329126536,39143921,2070713.4209,0.00010189724848950487,101.89724848950488 +Control,Control_14,endocardial_region,Cardiomyocytes,1106,1365,0.8102564102564103,5386296,284935.05840000004,0.0038815862330544293,3881.586233054429 +Control,Control_14,endocardial_region,Cardiomyocytes Ankrd1+,2,1365,0.0014652014652014652,5386296,284935.05840000004,7.019143278579438e-06,7.019143278579438 +Control,Control_14,endocardial_region,Endocardial cells,105,1365,0.07692307692307693,5386296,284935.05840000004,0.0003685050221254205,368.5050221254205 +Control,Control_14,endocardial_region,Endothelial cells,38,1365,0.02783882783882784,5386296,284935.05840000004,0.00013336372229300932,133.36372229300932 +Control,Control_14,endocardial_region,Fibroblasts,97,1365,0.07106227106227106,5386296,284935.05840000004,0.00034042844901110275,340.42844901110277 +Control,Control_14,endocardial_region,Macrophages Trem2-,5,1365,0.003663003663003663,5386296,284935.05840000004,1.7547858196448594e-05,17.547858196448594 +Control,Control_14,endocardial_region,Mono / Macros Ccr2+,1,1365,0.0007326007326007326,5386296,284935.05840000004,3.509571639289719e-06,3.509571639289719 +Control,Control_14,endocardial_region,Smooth muscle cells,11,1365,0.00805860805860806,5386296,284935.05840000004,3.860528803218691e-05,38.605288032186905 +Control,Control_14,epicardial_region,Cardiomyocytes,1078,1381,0.78059377262853,5961950,315387.155,0.003418021257080048,3418.021257080048 +Control,Control_14,epicardial_region,Cardiomyocytes Ankrd1+,2,1381,0.001448225923244026,5961950,315387.155,6.341412350797863e-06,6.341412350797863 +Control,Control_14,epicardial_region,Endothelial cells,145,1381,0.10499637943519188,5961950,315387.155,0.000459752395432845,459.752395432845 +Control,Control_14,epicardial_region,Fibroblasts,118,1381,0.08544532947139753,5961950,315387.155,0.0003741433286970739,374.1433286970739 +Control,Control_14,epicardial_region,Macrophages Trem2+,9,1381,0.0065170166545981175,5961950,315387.155,2.853635557859038e-05,28.53635557859038 +Control,Control_14,epicardial_region,Macrophages Trem2-,3,1381,0.002172338884866039,5961950,315387.155,9.512118526196793e-06,9.512118526196794 +Control,Control_14,epicardial_region,Mono / Macros Ccr2+,2,1381,0.001448225923244026,5961950,315387.155,6.341412350797863e-06,6.341412350797863 +Control,Control_14,epicardial_region,Other Leukocytes,1,1381,0.000724112961622013,5961950,315387.155,3.1707061753989314e-06,3.1707061753989314 +Control,Control_14,epicardial_region,Smooth muscle cells,23,1381,0.0166545981173063,5961950,315387.155,7.292624203417542e-05,72.92624203417542 +Control,Control_14,infarct_core,Cardiomyocytes,11013,13504,0.8155361374407583,76157364,4028724.5556000005,0.0027336194986802287,2733.619498680229 +Control,Control_14,infarct_core,Cardiomyocytes Ankrd1+,3,13504,0.0002221563981042654,76157364,4028724.5556000005,7.446525466304083e-07,0.7446525466304083 +Control,Control_14,infarct_core,Endocardial cells,15,13504,0.001110781990521327,76157364,4028724.5556000005,3.723262733152041e-06,3.723262733152041 +Control,Control_14,infarct_core,Endothelial cells,1577,13504,0.11678021327014218,76157364,4028724.5556000005,0.00039143902201205124,391.4390220120512 +Control,Control_14,infarct_core,Fibroblasts,535,13504,0.03961789099526066,76157364,4028724.5556000005,0.00013279637081575613,132.79637081575612 +Control,Control_14,infarct_core,Macrophages Trem2+,23,13504,0.0017031990521327014,76157364,4028724.5556000005,5.7090028574997964e-06,5.709002857499796 +Control,Control_14,infarct_core,Macrophages Trem2-,52,13504,0.0038507109004739335,76157364,4028724.5556000005,1.2907310808260409e-05,12.907310808260409 +Control,Control_14,infarct_core,Mono / Macros Ccr2+,18,13504,0.0013329383886255925,76157364,4028724.5556000005,4.467915279782449e-06,4.467915279782449 +Control,Control_14,infarct_core,Neutrophils,2,13504,0.0001481042654028436,76157364,4028724.5556000005,4.964350310869388e-07,0.49643503108693876 +Control,Control_14,infarct_core,Other Leukocytes,3,13504,0.0002221563981042654,76157364,4028724.5556000005,7.446525466304083e-07,0.7446525466304083 +Control,Control_14,infarct_core,Smooth muscle cells,263,13504,0.019475710900473935,76157364,4028724.5556000005,6.528120658793246e-05,65.28120658793246 +Control,Control_14,other_cardiac_tissue,Cardiomyocytes,48440,56963,0.8503765602233029,278633985,14739737.8065,0.0032863542510667113,3286.354251066711 +Control,Control_14,other_cardiac_tissue,Cardiomyocytes Ankrd1+,36,56963,0.000631989185962818,278633985,14739737.8065,2.4423772303551117e-06,2.442377230355112 +Control,Control_14,other_cardiac_tissue,Endocardial cells,375,56963,0.006583220687112687,278633985,14739737.8065,2.5441429482865747e-05,25.441429482865747 +Control,Control_14,other_cardiac_tissue,Endothelial cells,4235,56963,0.07434650562645928,278633985,14739737.8065,0.0002873185436264972,287.31854362649716 +Control,Control_14,other_cardiac_tissue,Fibroblasts,2475,56963,0.043449256534943734,278633985,14739737.8065,0.00016791343458691393,167.91343458691392 +Control,Control_14,other_cardiac_tissue,Macrophages Trem2+,58,56963,0.0010182047996067623,278633985,14739737.8065,3.934941093349902e-06,3.934941093349902 +Control,Control_14,other_cardiac_tissue,Macrophages Trem2-,207,56963,0.0036339378192862034,278633985,14739737.8065,1.4043669074541892e-05,14.043669074541892 +Control,Control_14,other_cardiac_tissue,Mono / Macros Ccr2+,51,56963,0.0008953180134473255,278633985,14739737.8065,3.4600344096697414e-06,3.4600344096697415 +Control,Control_14,other_cardiac_tissue,Neutrophils,5,56963,8.777627582816916e-05,278633985,14739737.8065,3.3921905977154327e-07,0.33921905977154326 +Control,Control_14,other_cardiac_tissue,Other Leukocytes,9,56963,0.0001579972964907045,278633985,14739737.8065,6.105943075887779e-07,0.610594307588778 +Control,Control_14,other_cardiac_tissue,Smooth muscle cells,1072,56963,0.018819233537559467,278633985,14739737.8065,7.272856641501888e-05,72.72856641501888 +24h,24h_83,all,Cardiomyocytes,22168,57839,0.3832708034371272,264125939,13972262.173100002,0.0015865720042584645,1586.5720042584646 +24h,24h_83,all,Cardiomyocytes Ankrd1+,14352,57839,0.2481370701429831,264125939,13972262.173100002,0.0010271779774953754,1027.1779774953754 +24h,24h_83,all,Endocardial cells,683,57839,0.011808641228237002,264125939,13972262.173100002,4.888256400706114e-05,48.882564007061134 +24h,24h_83,all,Endothelial cells,7747,57839,0.13394076661076437,264125939,13972262.173100002,0.0005544556711020536,554.4556711020537 +24h,24h_83,all,Fibroblasts,3872,57839,0.06694444924704784,264125939,13972262.173100002,0.00027712047999317824,277.12047999317826 +24h,24h_83,all,Macrophages Trem2+,223,57839,0.0038555300057054927,264125939,13972262.173100002,1.596019293349141e-05,15.960192933491411 +24h,24h_83,all,Macrophages Trem2-,79,57839,0.0013658604056086723,264125939,13972262.173100002,5.654059380026105e-06,5.654059380026105 +24h,24h_83,all,Mono / Macros Ccr2+,5023,57839,0.0868445166755995,264125939,13972262.173100002,0.0003594979780490016,359.49797804900163 +24h,24h_83,all,Neutrophils,2565,57839,0.04434723975172462,264125939,13972262.173100002,0.00018357800392110077,183.57800392110076 +24h,24h_83,all,Other Leukocytes,157,57839,0.00271443143899445,264125939,13972262.173100002,1.1236548388153146e-05,11.236548388153146 +24h,24h_83,all,Smooth muscle cells,970,57839,0.016770691056207748,264125939,13972262.173100002,6.942326074209269e-05,69.4232607420927 +24h,24h_86,all,Cardiomyocytes,38723,66735,0.5802502435004121,336270684,17788719.1836,0.0021768290117087233,2176.829011708723 +24h,24h_86,all,Cardiomyocytes Ankrd1+,10798,66735,0.16180415074548588,336270684,17788719.1836,0.0006070139108134906,607.0139108134906 +24h,24h_86,all,Endocardial cells,681,66735,0.0102045403461452,336270684,17788719.1836,3.828268876310308e-05,38.28268876310308 +24h,24h_86,all,Endothelial cells,7232,66735,0.10836892185509853,336270684,17788719.1836,0.0004065497872757144,406.5497872757144 +24h,24h_86,all,Fibroblasts,3757,66735,0.056297295272345844,336270684,17788719.1836,0.0002112012653200856,211.20126532008558 +24h,24h_86,all,Macrophages Trem2+,114,66735,0.0017082490447291527,336270684,17788719.1836,6.408555828184657e-06,6.408555828184657 +24h,24h_86,all,Macrophages Trem2-,162,66735,0.0024275118004045853,336270684,17788719.1836,9.106895124262407e-06,9.106895124262406 +24h,24h_86,all,Mono / Macros Ccr2+,2291,66735,0.03432981194275867,336270684,17788719.1836,0.00012878948598571096,128.78948598571097 +24h,24h_86,all,Neutrophils,2000,66735,0.029969281486476363,336270684,17788719.1836,0.0001124308040032396,112.4308040032396 +24h,24h_86,all,Other Leukocytes,77,66735,0.0011538173372293398,336270684,17788719.1836,4.328585954124725e-06,4.3285859541247245 +24h,24h_86,all,Smooth muscle cells,900,66735,0.013486176668914362,336270684,17788719.1836,5.059386180145782e-05,50.59386180145782 +48h,48h_76,all,Cardiomyocytes,12654,37965,0.3333069932832872,187143747,9899904.216300001,0.0012781941848654893,1278.1941848654892 +48h,48h_76,all,Cardiomyocytes Ankrd1+,7889,37965,0.20779665481364415,187143747,9899904.216300001,0.0007968763967444164,796.8763967444164 +48h,48h_76,all,Endocardial cells,577,37965,0.015198208876596866,187143747,9899904.216300001,5.828339218171229e-05,58.28339218171229 +48h,48h_76,all,Endothelial cells,5378,37965,0.1416567891478994,187143747,9899904.216300001,0.0005432375791217482,543.2375791217482 +48h,48h_76,all,Fibroblasts,3305,37965,0.08705386540234426,187143747,9899904.216300001,0.0003338416137964629,333.8416137964629 +48h,48h_76,all,Macrophages Trem2+,1271,37965,0.03347820360858686,187143747,9899904.216300001,0.00012838508052505427,128.38508052505426 +48h,48h_76,all,Macrophages Trem2-,97,37965,0.0025549848544712235,187143747,9899904.216300001,9.798074595539154e-06,9.798074595539154 +48h,48h_76,all,Mono / Macros Ccr2+,4222,37965,0.11120769129461346,187143747,9899904.216300001,0.00042646877260171454,426.46877260171453 +48h,48h_76,all,Neutrophils,1525,37965,0.04016857632029501,187143747,9899904.216300001,0.00015404189441440422,154.04189441440423 +48h,48h_76,all,Other Leukocytes,402,37965,0.010588700118530225,187143747,9899904.216300001,4.060645347842e-05,40.60645347842 +48h,48h_76,all,Smooth muscle cells,645,37965,0.01698933227973133,187143747,9899904.216300001,6.515214550642015e-05,65.15214550642014 +48h,48h_79,all,Cardiomyocytes,22505,68854,0.32685101809626166,282543754,14946564.586600002,0.0015056971700491187,1505.6971700491188 +48h,48h_79,all,Cardiomyocytes Ankrd1+,10311,68854,0.14975164841548785,282543754,14946564.586600002,0.0006898575214564081,689.8575214564081 +48h,48h_79,all,Endocardial cells,646,68854,0.009382170970459233,282543754,14946564.586600002,4.3220634163596124e-05,43.220634163596124 +48h,48h_79,all,Endothelial cells,16226,68854,0.23565805908153484,282543754,14946564.586600002,0.0010856006345797379,1085.600634579738 +48h,48h_79,all,Fibroblasts,8269,68854,0.12009469311877305,282543754,14946564.586600002,0.0005532374982953194,553.2374982953195 +48h,48h_79,all,Macrophages Trem2+,2046,68854,0.029715049234612368,282543754,14946564.586600002,0.00013688764318686947,136.88764318686947 +48h,48h_79,all,Macrophages Trem2-,78,68854,0.0011328317890028174,282543754,14946564.586600002,5.218590502725229e-06,5.218590502725228 +48h,48h_79,all,Mono / Macros Ccr2+,5893,68854,0.08558689400761031,282543754,14946564.586600002,0.0003942712029815355,394.2712029815355 +48h,48h_79,all,Neutrophils,1233,68854,0.017907456356929155,282543754,14946564.586600002,8.249387294692572e-05,82.49387294692572 +48h,48h_79,all,Other Leukocytes,688,68854,0.009992157318383826,282543754,14946564.586600002,4.6030644434294324e-05,46.030644434294324 +48h,48h_79,all,Smooth muscle cells,959,68854,0.013928021610944898,282543754,14946564.586600002,6.416190118094223e-05,64.16190118094224 +4h,4h_96,all,Cardiomyocytes,28063,51840,0.5413387345679013,237621411,12570172.641900001,0.002232507126151788,2232.5071261517883 +4h,4h_96,all,Cardiomyocytes Ankrd1+,14010,51840,0.27025462962962965,237621411,12570172.641900001,0.0011145431649284307,1114.5431649284308 +4h,4h_96,all,Endocardial cells,441,51840,0.008506944444444444,237621411,12570172.641900001,3.5083050373550176e-05,35.08305037355017 +4h,4h_96,all,Endothelial cells,5104,51840,0.09845679012345679,237621411,12570172.641900001,0.00040604056486757387,406.0405648675739 +4h,4h_96,all,Fibroblasts,2441,51840,0.047087191358024694,237621411,12570172.641900001,0.00019418985478874371,194.1898547887437 +4h,4h_96,all,Macrophages Trem2+,77,51840,0.0014853395061728396,237621411,12570172.641900001,6.125611969984951e-06,6.125611969984951 +4h,4h_96,all,Macrophages Trem2-,37,51840,0.0007137345679012345,237621411,12570172.641900001,2.9434758816810805e-06,2.9434758816810804 +4h,4h_96,all,Mono / Macros Ccr2+,314,51840,0.006057098765432099,237621411,12570172.641900001,2.4979768293185384e-05,24.979768293185383 +4h,4h_96,all,Neutrophils,486,51840,0.009375,237621411,12570172.641900001,3.866295347289203e-05,38.66295347289203 +4h,4h_96,all,Other Leukocytes,177,51840,0.003414351851851852,237621411,12570172.641900001,1.4080952190744627e-05,14.080952190744627 +4h,4h_96,all,Smooth muscle cells,690,51840,0.013310185185185185,237621411,12570172.641900001,5.4891847523241766e-05,54.891847523241765 +4h,4h_97,all,Cardiomyocytes,43600,67357,0.6472972371097288,321343257,16999058.2953,0.00256484796055172,2564.84796055172 +4h,4h_97,all,Cardiomyocytes Ankrd1+,6345,67357,0.09419956351975296,321343257,16999058.2953,0.0003732559704059785,373.25597040597853 +4h,4h_97,all,Endocardial cells,523,67357,0.007764597591935508,321343257,16999058.2953,3.076641016900343e-05,30.76641016900343 +4h,4h_97,all,Endothelial cells,8859,67357,0.13152307852190567,321343257,16999058.2953,0.0005211465156543047,521.1465156543047 +4h,4h_97,all,Fibroblasts,4026,67357,0.059771070564306604,321343257,16999058.2953,0.00023683664883443175,236.83664883443174 +4h,4h_97,all,Macrophages Trem2+,119,67357,0.0017667057618361863,321343257,16999058.2953,7.0003877822397856e-06,7.000387782239786 +4h,4h_97,all,Macrophages Trem2-,128,67357,0.0019003221639918642,321343257,16999058.2953,7.5298288750142235e-06,7.529828875014224 +4h,4h_97,all,Mono / Macros Ccr2+,727,67357,0.010793236040797542,321343257,16999058.2953,4.2767074938557346e-05,42.76707493855734 +4h,4h_97,all,Neutrophils,1652,67357,0.02452603292902,321343257,16999058.2953,9.718185391815232e-05,97.18185391815233 +4h,4h_97,all,Other Leukocytes,156,67357,0.0023160176373650844,321343257,16999058.2953,9.176978941423585e-06,9.176978941423585 +4h,4h_97,all,Smooth muscle cells,1222,67357,0.01814213815935983,321343257,16999058.2953,7.188633504115142e-05,71.88633504115143 +Control,Control_12,all,Cardiomyocytes,48865,66998,0.7293501298546226,327158740,17306697.346,0.002823473423211731,2823.4734232117307 +Control,Control_12,all,Cardiomyocytes Ankrd1+,953,66998,0.014224305203140393,327158740,17306697.346,5.506538774830205e-05,55.06538774830205 +Control,Control_12,all,Endocardial cells,552,66998,0.008239051911997372,327158740,17306697.346,3.189516688044358e-05,31.89516688044358 +Control,Control_12,all,Endothelial cells,13081,66998,0.19524463416818413,327158740,17306697.346,0.0007558345615273233,755.8345615273232 +Control,Control_12,all,Fibroblasts,2821,66998,0.0421057344995373,327158740,17306697.346,0.0001630004814669046,163.0004814669046 +Control,Control_12,all,Macrophages Trem2+,33,66998,0.0004925520164781039,327158740,17306697.346,1.9067762808960834e-06,1.9067762808960833 +Control,Control_12,all,Macrophages Trem2-,3,66998,4.477745604346399e-05,327158740,17306697.346,1.7334329826328033e-07,0.17334329826328032 +Control,Control_12,all,Mono / Macros Ccr2+,275,66998,0.004104600137317532,327158740,17306697.346,1.5889802340800695e-05,15.889802340800694 +Control,Control_12,all,Neutrophils,45,66998,0.0006716618406519598,327158740,17306697.346,2.6001494739492047e-06,2.600149473949205 +Control,Control_12,all,Other Leukocytes,28,66998,0.00041792292307233053,327158740,17306697.346,1.6178707837906163e-06,1.6178707837906163 +Control,Control_12,all,Smooth muscle cells,342,66998,0.005104629988954894,327158740,17306697.346,1.9761136002013954e-05,19.761136002013956 +Control,Control_13,all,Cardiomyocytes,40191,66357,0.6056783760567838,320015608,16928825.663200002,0.002374116244068097,2374.116244068097 +Control,Control_13,all,Cardiomyocytes Ankrd1+,74,66357,0.0011151800111518,320015608,16928825.663200002,4.371242369212988e-06,4.371242369212988 +Control,Control_13,all,Endocardial cells,571,66357,0.0086049700860497,320015608,16928825.663200002,3.372945125433265e-05,33.72945125433265 +Control,Control_13,all,Endothelial cells,17576,66357,0.26487032264870325,320015608,16928825.663200002,0.0010382291335309117,1038.2291335309117 +Control,Control_13,all,Fibroblasts,6323,66357,0.0952876109528761,320015608,16928825.663200002,0.0003735049391964016,373.5049391964016 +Control,Control_13,all,Macrophages Trem2+,215,66357,0.0032400500324005,320015608,16928825.663200002,1.2700231207848545e-05,12.700231207848546 +Control,Control_13,all,Macrophages Trem2-,95,66357,0.0014316500143165,320015608,16928825.663200002,5.61173006858424e-06,5.61173006858424 +Control,Control_13,all,Mono / Macros Ccr2+,142,66357,0.0021399400213994004,320015608,16928825.663200002,8.38805968146276e-06,8.38805968146276 +Control,Control_13,all,Neutrophils,5,66357,7.535000075350001e-05,320015608,16928825.663200002,2.953542141360127e-07,0.2953542141360127 +Control,Control_13,all,Other Leukocytes,77,66357,0.0011603900116039002,320015608,16928825.663200002,4.548454897694595e-06,4.548454897694595 +Control,Control_13,all,Smooth muscle cells,1088,66357,0.0163961601639616,320015608,16928825.663200002,6.426907699599636e-05,64.26907699599636 +Control,Control_14,all,Cardiomyocytes,66483,79235,0.839061021013441,405283516,21439497.996400002,0.003100958800955295,3100.9588009552954 +Control,Control_14,all,Cardiomyocytes Ankrd1+,47,79235,0.0005931722092509624,405283516,21439497.996400002,2.1922155083991226e-06,2.192215508399123 +Control,Control_14,all,Endocardial cells,513,79235,0.006474411560547738,405283516,21439497.996400002,2.3927799059760636e-05,23.927799059760638 +Control,Control_14,all,Endothelial cells,6601,79235,0.08330914368650218,405283516,21439497.996400002,0.00030788967172218313,307.88967172218315 +Control,Control_14,all,Fibroblasts,3514,79235,0.04434908815548684,405283516,21439497.996400002,0.00016390309141520247,163.90309141520245 +Control,Control_14,all,Macrophages Trem2+,108,79235,0.0013630340127468922,405283516,21439497.996400002,5.037431381002239e-06,5.037431381002239 +Control,Control_14,all,Macrophages Trem2-,288,79235,0.0036347573673250456,405283516,21439497.996400002,1.3433150349339303e-05,13.433150349339304 +Control,Control_14,all,Mono / Macros Ccr2+,79,79235,0.0009970341389537452,405283516,21439497.996400002,3.684787769436823e-06,3.6847877694368227 +Control,Control_14,all,Neutrophils,8,79235,0.00010096548242569571,405283516,21439497.996400002,3.731430652594251e-07,0.3731430652594251 +Control,Control_14,all,Other Leukocytes,14,79235,0.0001766895942449675,405283516,21439497.996400002,6.53000364203994e-07,0.653000364203994 +Control,Control_14,all,Smooth muscle cells,1580,79235,0.019940682779074903,405283516,21439497.996400002,7.369575538873646e-05,73.69575538873646