The VectraPolarisData ExperimentHub package provides two large multiplex immunofluorescence datasets collected by Akoya Biosciences Vectra 3 and Vectra Polaris platforms. Image preprocessing (cell segmentation and phenotyping) was performed using Inform software. Data cover are formatted into objects of class SpatialExperiment.
VectraPolarisData 1.4.0
To retrieve a dataset, we can use a dataset’s corresponding named function <id>(), where <id> should correspond to one a valid dataset identifier (see ?VectraPolarisData). Below both the lung and ovarian cancer datasets are loaded this way.
library(VectraPolarisData)
spe_lung <- HumanLungCancerV3()
spe_ovarian <- HumanOvarianCancerVP()Alternatively, data can loaded directly from Bioconductor’s ExperimentHub as follows. First, we initialize a hub instance and store the complete list of records in a variable eh. Using query(), we then identify any records made available by the VectraPolarisData package, as well as their accession IDs (EH7311 for the lung cancer data). Finally, we can load the data into R via eh[[id]], where id corresponds to the data entry’s identifier we’d like to load. E.g.:
library(ExperimentHub)
eh <- ExperimentHub()        # initialize hub instance
q <- query(eh, "VectraPolarisData") # retrieve 'VectraPolarisData' records
id <- q$ah_id[1]             # specify dataset ID to load
spe <- eh[[id]]              # load specified datasetBoth the HumanLungCancerV3() and HumanOvarianCancerVP() datasets are stored as SpatialExperiment objects. This allows users of our data to interact with methods built for SingleCellExperiment, SummarizedExperiment, and SpatialExperiment class methods in Bioconductor. See this ebook for more details on SpatialExperiment. To get cell level tabular data that can be stored in this format, raw multiplex.tiff images have been preprocessed, segmented and cell phenotyped using Inform software from Akoya Biosciences.
The SpatialExperiment class was originally built for spatial transcriptomics data and follows the structure depicted in the schematic below (Righelli et al. 2021):
To adapt this class structure for multiplex imaging data we use slots in the following way:
assays slot: intensities, nucleus_intensities, membrane_intensitiessample_id slot: contains image identifier. For the VectraOvarianDataVP this also identifies the subject because there is one image per subjectcolData slot: Other cell-level characteristics of the marker intensities, cell phenotypes, cell shape characteristicsspatialCoordsNames slot: The x- and y- coordinates describing the location of the center point in the image for each cellmetadata slot: A dataframe of subject-level patient clinical characteristics.The following code shows how to transform the SpatialExperiment class object to a data.frame class object, if that is preferred for analysis. The example below is shown using the HumanOvarianVP dataset.
library(dplyr)
## Assays slots
assays_slot <- assays(spe_ovarian)
intensities_df <- assays_slot$intensities
rownames(intensities_df) <- paste0("total_", rownames(intensities_df))
nucleus_intensities_df<- assays_slot$nucleus_intensities
rownames(nucleus_intensities_df) <- paste0("nucleus_", rownames(nucleus_intensities_df))
membrane_intensities_df<- assays_slot$membrane_intensities
rownames(membrane_intensities_df) <- paste0("membrane_", rownames(membrane_intensities_df))
# colData and spatialData
colData_df <- colData(spe_ovarian)
spatialCoords_df <- spatialCoords(spe_ovarian)
# clinical data
patient_level_df <- metadata(spe_ovarian)$clinical_data
cell_level_df <- as.data.frame(cbind(colData_df, 
                                     spatialCoords_df,
                                     t(intensities_df),
                                     t(nucleus_intensities_df),
                                     t(membrane_intensities_df))
                               )
ovarian_df <- full_join(patient_level_df, cell_level_df, by = "sample_id")The objects provided in this package are rich data sources we encourage others to use in their own analyses. If you do include them in your peer-reviewed work, we ask that you cite our package and the original studies.
To cite the VectraPolarisData package, use:
@Manual{VectraPolarisData,
    title = {VectraPolarisData: Vectra Polaris and Vectra 3 multiplex single-cell imaging data},
    author = {Wrobel, J and Ghosh, T},
    year = {2022},
    note = {Bioconductor R package version 1.0},
  }To cite the HumanLungCancerV3() data in bibtex format, use:
@article{johnson2021cancer,
  title={Cancer cell-specific MHCII expression as a determinant of the immune infiltrate organization and function in the non-small cell lung cancer tumor microenvironment.},
  author={Johnson, AM and Boland, JM and Wrobel, J and Klezcko, EK and Weiser-Evans, M and Hopp, K and Heasley, L and Clambey, ET and Jordan, K and Nemenoff, RA and others},
  journal={Journal of Thoracic Oncology: Official Publication of the International Association for the Study of Lung Cancer},
  year={2021}
}To cite the HumanOvarianCancerVP() data, use:
@article{steinhart2021spatial,
  title={The spatial context of tumor-infiltrating immune cells associates with improved ovarian cancer survival},
  author={Steinhart, Benjamin and Jordan, Kimberly R and Bapat, Jaidev and Post, Miriam D and Brubaker, Lindsay W and Bitler, Benjamin G and Wrobel, Julia},
  journal={Molecular Cancer Research},
  volume={19},
  number={12},
  pages={1973--1979},
  year={2021},
  publisher={AACR}
}Detailed tables representing what is provided in each dataset are listed here
In the table below note the following shorthand:
[marker] represents one of: cd3, cd8, cd14, cd19, cd68, ck, dapi, hladr,[cell region] represents one of: entire_cell, membrane, nucleusTable 1: data dictionary for HumanLungCancerV3
| Variable | Slot | Description | Variable coding | 
|---|---|---|---|
| [marker] | assays: intensities | mean total cell intensity for [marker] | |
| [marker] | assays: nucleus_intensities | mean nucleus intensity for [marker] | |
| [marker] | assays: membrane_intensities | mean membrane intensity for [marker] | |
| sample_id | image identifier, also subject id for the ovarian data | ||
| cell_id | colData | cell identifier | |
| slide_id | slide identifier, also the patient id for the lung data | ||
| tissue category | type of tissue (indicates a region of the image) | Stroma or Tumor | |
| [cell region]_[marker]_min | min [cell region] intensity for [marker] | ||
| [cell region]_[marker]_max | max [cell region] intensity for [marker] | ||
| [cell region]_[marker]_std_dev | [cell region] std dev of intensity for [marker] | ||
| [cell region]_[marker]_total | total [cell region] intensity for [marker] | ||
| [cell region]_area_square_microns | [cell region] area in square microns | ||
| [cell region]_compactness | [cell region] compactness | ||
| [cell region]_minor_axis | [cell region] length of minor axis | ||
| [cell region]_major_axis | [cell region] length of major axis | ||
| [cell region]_axis_ratio | [cell region] ratio of major and minor axis | ||
| phenotype_[marker] | cell phenotype label as determined by Inform software | ||
| cell_x_position | spatialCoordsNames | cell x coordinate | |
| cell_y_position | cell y coordinate | ||
| gender | metadata | gender | “M”, “F” | 
| mhcII_status | MHCII status, from Johnson et.al. 2021 | “low”, “high” | |
| age_at_diagnosis | age at diagnosis | ||
| stage_at_diagnosis | stage of the cancer when image was collected | ||
| stage_numeric | numeric version of stage variable | ||
| pack_years | pack-years of cigarette smoking | ||
| survival_days | time in days from date of diagnosis to date of death or censoring event | ||
| survival_status | did the participant pass away? | 0 = no, 1 = yes | |
| cause_of_death | cause of death | ||
| recurrence_or_lung_ca_death | did the participant have a recurrence or death event? | 0 = no, 1 = yes | |
| time_to_recurrence_days | time in days from date of diagnosis to first recurrent event | ||
| adjuvant_therapy | whether or not the participant received adjuvant therapy | “No”, “Yes” | 
In the table below note the following shorthand:
[marker] represents one of: cd3, cd8, cd19, cd68, ck, dapi, ier3, ki67, pstat3[cell region] represents one of: cytoplasm, membrane, nucleusTable 2: data dictionary for HumanOvarianCancerVP
| Variable | Slot | Description | Variable coding | 
|---|---|---|---|
| [marker] | assays: intensities | mean total cell intensity for [marker] | |
| [marker] | assays: nucleus_intensities | mean nucleus intensity for [marker] | |
| [marker] | assays: membrane_intensities | mean membrane intensity for [marker] | |
| sample_id | image identifier, also subject id for the ovarian data | ||
| cell_id | colData | cell identifier | |
| slide_id | slide identifier | ||
| tissue category | type of tissue (indicates a region of the image) | Stroma or Tumor | |
| [cell region]_[marker]_min | min [cell region] intensity for [marker] | ||
| [cell region]_[marker]_max | max [cell region] intensity for [marker] | ||
| [cell region]_[marker]_std_dev | [cell region] std dev of intensity for [marker] | ||
| [cell region]_[marker]_total | total [cell region] intensity for [marker] | ||
| [cell region]_area_square_microns | [cell region] area in square microns | ||
| [cell region]_compactness | [cell region] compactness | ||
| [cell region]_minor_axis | [cell region] length of minor axis | ||
| [cell region]_major_axis | [cell region] length of major axis | ||
| [cell region]_axis_ratio | [cell region] ratio of major and minor axis | ||
| cell_x_position | spatialCoordsNames | cell x coordinate | |
| cell_y_position | cell y coordinate | ||
| diagnosis | metadata | ||
| primary | primary tumor from initial diagnosis? | 0 = no, 1 = yes | |
| recurrent | tumor from a recurrent event (not initial diagnosis tumor)? | 0 = no, 1 = yes | |
| treatment_effect | was tumor treated with chemo prior to imaging? | 0 = no, 1 = yes | |
| stage | stage of the cancer when image was collected | I,II,II,IV | |
| grade | grade of cancer severity (nearly all 3) | ||
| survival_time | time in months from date of diagnosis to date of death or censoring event | ||
| death | did the participant pass away? | 0 = no, 1 = yes | |
| BRCA_mutation | does the participant have a BRCA mutation? | 0 = no, 1 = yes | |
| age_at_diagnosis | age at diagnosis | ||
| time_to_recurrence | time in months from date of diagnosis to first recurrent event | ||
| parpi_inhibitor | whether or not the participant received PARPi inhibitor | N = no, Y = yes | |
| debulking | subjective rating of how the tumor removal process went | optimal, suboptimal, interval | 
Note: the debulking variable described as optimal if surgeon believes tumor area was reduced to 1 cm or below; suboptimal if surgeon was unable to remove significant amount of tumor due to various reasons; interval if tumor removal came after three cycles of chemo
sessionInfo()
#> R version 4.3.0 RC (2023-04-13 r84269)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 22.04.2 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.17-bioc/R/lib/libRblas.so 
#> LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.0
#> 
#> locale:
#>  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
#>  [3] LC_TIME=en_GB              LC_COLLATE=C              
#>  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
#>  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
#>  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
#> [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
#> 
#> time zone: America/New_York
#> tzcode source: system (glibc)
#> 
#> attached base packages:
#> [1] stats4    stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#>  [1] dplyr_1.1.2                 VectraPolarisData_1.4.0    
#>  [3] SpatialExperiment_1.10.0    SingleCellExperiment_1.22.0
#>  [5] SummarizedExperiment_1.30.0 Biobase_2.60.0             
#>  [7] GenomicRanges_1.52.0        GenomeInfoDb_1.36.0        
#>  [9] IRanges_2.34.0              S4Vectors_0.38.0           
#> [11] MatrixGenerics_1.12.0       matrixStats_0.63.0         
#> [13] ExperimentHub_2.8.0         AnnotationHub_3.8.0        
#> [15] BiocFileCache_2.8.0         dbplyr_2.3.2               
#> [17] BiocGenerics_0.46.0         BiocStyle_2.28.0           
#> 
#> loaded via a namespace (and not attached):
#>  [1] DBI_1.1.3                     bitops_1.0-7                 
#>  [3] rlang_1.1.0                   magrittr_2.0.3               
#>  [5] compiler_4.3.0                RSQLite_2.3.1                
#>  [7] DelayedMatrixStats_1.22.0     png_0.1-8                    
#>  [9] vctrs_0.6.2                   pkgconfig_2.0.3              
#> [11] crayon_1.5.2                  fastmap_1.1.1                
#> [13] magick_2.7.4                  XVector_0.40.0               
#> [15] ellipsis_0.3.2                scuttle_1.10.0               
#> [17] utf8_1.2.3                    promises_1.2.0.1             
#> [19] rmarkdown_2.21                purrr_1.0.1                  
#> [21] bit_4.0.5                     xfun_0.39                    
#> [23] zlibbioc_1.46.0               cachem_1.0.7                 
#> [25] beachmat_2.16.0               jsonlite_1.8.4               
#> [27] blob_1.2.4                    later_1.3.0                  
#> [29] rhdf5filters_1.12.0           DelayedArray_0.26.0          
#> [31] Rhdf5lib_1.22.0               BiocParallel_1.34.0          
#> [33] interactiveDisplayBase_1.38.0 parallel_4.3.0               
#> [35] R6_2.5.1                      bslib_0.4.2                  
#> [37] limma_3.56.0                  jquerylib_0.1.4              
#> [39] Rcpp_1.0.10                   bookdown_0.33                
#> [41] knitr_1.42                    R.utils_2.12.2               
#> [43] httpuv_1.6.9                  Matrix_1.5-4                 
#> [45] tidyselect_1.2.0              yaml_2.3.7                   
#> [47] codetools_0.2-19              curl_5.0.0                   
#> [49] lattice_0.21-8                tibble_3.2.1                 
#> [51] withr_2.5.0                   shiny_1.7.4                  
#> [53] KEGGREST_1.40.0               evaluate_0.20                
#> [55] Biostrings_2.68.0             pillar_1.9.0                 
#> [57] BiocManager_1.30.20           filelock_1.0.2               
#> [59] generics_0.1.3                RCurl_1.98-1.12              
#> [61] BiocVersion_3.17.1            sparseMatrixStats_1.12.0     
#> [63] xtable_1.8-4                  glue_1.6.2                   
#> [65] tools_4.3.0                   locfit_1.5-9.7               
#> [67] rhdf5_2.44.0                  grid_4.3.0                   
#> [69] DropletUtils_1.20.0           AnnotationDbi_1.62.0         
#> [71] edgeR_3.42.0                  GenomeInfoDbData_1.2.10      
#> [73] HDF5Array_1.28.0              cli_3.6.1                    
#> [75] rappdirs_0.3.3                fansi_1.0.4                  
#> [77] R.methodsS3_1.8.2             sass_0.4.5                   
#> [79] digest_0.6.31                 dqrng_0.3.0                  
#> [81] rjson_0.2.21                  memoise_2.0.1                
#> [83] htmltools_0.5.5               R.oo_1.25.0                  
#> [85] lifecycle_1.0.3               httr_1.4.5                   
#> [87] mime_0.12                     bit64_4.0.5