After high-dimensional cytometry data are collected, you may want to assess the quality of the data to look for channels whose measurements failed, acquisition artifacts, or outlier cells.
To perform such analyses, {tidytof} provides several functions for quality control that allow users to do the following:
To demonstrate how to use {tidytof}’s quality control verbs, we will use a combination of simulated and real data in this vignette. Simulated data will be generated on-the-fly in the sections below, but we will walk through how to download the real dataset in this section.
We want to download a dataset originally collected for the development of the PhenoGraph algorithm. These data are built into in the {HDCytoData} package, which is available on Bioconductor and can be downloaded with the following command:
if (!requireNamespace("BiocManager", quietly = TRUE)) {
    install.packages("BiocManager")
}
BiocManager::install("HDCytoData")To load the PhenoGraph data into our current R session, we can call a function from the {HDCytoData}, which will provide it to us in a format from the {flowCore} package (called a “flowSet”). To convert this into a tidy tibble, we can use {tidytof} built-in method for converting flowCore objects into tof_tbl’s. We also add a few lines of dplyr code to clean up the column names and perform the standard arcsinh transformation.
levine <-
    HDCytoData::Levine_32dim_flowSet() |>
    as_tof_tbl() |>
    # a bit of data cleaning
    dplyr::mutate(population_id = as.character(population_id)) |>
    dplyr::rename_with(
        .fn = \(x) stringr::str_to_lower(stringr::str_remove(x, "\\|.+"))
    ) |>
    dplyr::mutate(dplyr::across(c(file_number, population_id), as.character)) |>
    # arcsinh transformation
    tof_preprocess(
        channel_cols =
            c(-time, -cell_length, -event_number, -file_number, -population_id)
    )Thus, we can see that levine is a tof_tbl with 265627 cells (one in each row) and 40 pieces of information about each cell (one in each column).
tof_assess_channels()After data collection, we might wonder which of our channels to include in downstream analyses. In particular, we might want to exclude channels with very few positive values, a situation that indicates that an antibody may have failed, or that signal on a particular channel may have been too weak to be detected.
To do so, we can use tof_assess_channels(), a verb that calculates how many cells are negative (i.e. below a use-specified threshold, negative_threshold) in each channel and flags channels that have more than a user-specified proportion of negative cells (negative_proportion_flag).
For the levine dataset, we look for markers that have more than 97.5% of cells below a threshold of 5 ion counts:
# convert 5 counts to asinh value with a cofactor of 5
threshold <- asinh(5 / 5)
levine |>
    tof_assess_channels(
        negative_threshold = threshold,
        negative_proportion_flag = 0.975
    )
#> # A tibble: 38 × 3
#>    channel negative_proportion flagged_channel
#>    <chr>                 <dbl> <lgl>          
#>  1 cd14                  0.988 TRUE           
#>  2 cd133                 0.975 TRUE           
#>  3 cd117                 0.969 FALSE          
#>  4 cd16                  0.967 FALSE          
#>  5 flt3                  0.960 FALSE          
#>  6 cd15                  0.940 FALSE          
#>  7 cd41                  0.923 FALSE          
#>  8 cd34                  0.909 FALSE          
#>  9 cd61                  0.890 FALSE          
#> 10 cd33                  0.885 FALSE          
#> # ℹ 28 more rowsWe can see that two channels have more than 97.5% of cells in the dataset below 5 counts. For a given experiment, this might be an expected (i.e. a marker is only expressed on a very rare cell population) or unexpected (a marker should be expressed on many cells). In this case, we can visualize the marker with the most negative cells to manually inspect it (as we would recommend with all flagged channels).
In this case, it looks like a small population of cells is slightly positive for cd14, but this could simply be measurement noise/nonspecific binding of the antibody. It would be up to user whether or not to include cd14 in downstream analyses.
tof_assess_flow_rate()Large changes in the flow rate of a cytometer can impact the quality of the signal acquired during data collection: for example, abnormally low flow rates can be caused by partial occlusions of a cytometer’s flow cell, leading to debris and air infiltration into the cytometer’s microfluidics system. Thus, it can be useful to perform a quality control step that explicitly interrogates the flow rate over the course of a cytometry experiment in order to flag cells that were collected at unusually high or low rates of acquisition.
To do this, {tidytof} provides tof_assess_flow_rate(), a function that implements a simplified version of FlowAI’s flow rate analysis. In short, the relative flow rates for each timestep of a cytometry experiment are calculated, and outlier timepoints with particularly high or low flow rates (i.e. those beyond extreme values of the t-distribution across all timesteps) are flagged. The size of timesteps is a user-defined parameter of the calculation, as is the significance level (between 0 and 1) within the t-distribution that determines how anomalous a time step’s flow rate must be before cells are flagged.
We can apply tof_assess_flow_rate() to the levine dataset below, using
levine |>
    tof_assess_flow_rate(
        time_col = time,
        num_timesteps = 200,
        # flag timepoints in which flow rates are high or low at a signicance level
        # of p = 0.01
        alpha_threshold = 0.01,
        # plot the number of cells in each timestep, and whether or not the
        # rates were flagged as too high or too low
        visualize = TRUE
    )In the result above, we can see that the last several timesteps have been flagged as having potentially low flow rates. The decision to include or exclude these cells from further analyses is left to the user.
The group_cols argument can also be used to analyze the flow rates of samples, patients, mass cytometry barcode plates, etc. separately.
levine |>
    tof_assess_flow_rate(
        time_col = time,
        # analyze two files in the levine dataset separately
        group_cols = file_number,
        alpha_threshold = 0.01,
        visualize = TRUE
    )tof_assess_clusters_distance()After using your favorite clustering algorithm to define cell subpopulations (for example, using tof_cluster()), you may wonder how well the clustering procedure worked. For example, there may be some clusters that contain outliers - that is, cells that are less similar to the other cells in their cluster than is typical.
To detect such cells, {tidytof} provides the tof_assess_clusters_distance() verb, which computes the Mahalanobis distance between each cell and the centroid of the cluster to which it was assigned. After doing so, it computes the z-score of mahalanobis distances for all cells in each cluster and flags cells with a z-score over a user-specified threshold. Altogether, this procedure flags cells that are unusually far from their cluster centroid - i.e. candidate outliers.
We demonstrate how to use tof_assess_clusters_distance() with simulated data. We simulate data with 3 clusters, each of which has a large population of cells that “truly” belong in that cluster as well as a small population of outliers cells that have been erroneously assigned to the same cluster.
set.seed(2020L)
# simulate large population of cells that truly belong in their assigned cluster
sim_data_base <-
    dplyr::tibble(
        cd45 = c(rnorm(n = 600), rnorm(n = 500, mean = -4)),
        cd38 =
            c(
                rnorm(n = 100, sd = 0.5),
                rnorm(n = 500, mean = -3),
                rnorm(n = 500, mean = 8)
            ),
        cd34 =
            c(
                rnorm(n = 100, sd = 0.2, mean = -10),
                rnorm(n = 500, mean = 4),
                rnorm(n = 500, mean = 60)
            ),
        cd19 = c(rnorm(n = 100, sd = 0.3, mean = 10), rnorm(n = 1000)),
        cluster_id = c(rep("a", 100), rep("b", 500), rep("c", 500)),
        dataset = "non-outlier"
    )
# simulate outlier cells that do not belong in their assigned cluster
sim_data_outlier <-
    dplyr::tibble(
        cd45 = c(rnorm(n = 10), rnorm(50, mean = 3), rnorm(n = 50, mean = -12)),
        cd38 =
            c(
                rnorm(n = 10, sd = 0.5),
                rnorm(n = 50, mean = -10),
                rnorm(n = 50, mean = 10)
            ),
        cd34 =
            c(
                rnorm(n = 10, sd = 0.2, mean = -15),
                rnorm(n = 50, mean = 15),
                rnorm(n = 50, mean = 70)
            ),
        cd19 = c(rnorm(n = 10, sd = 0.3, mean = 19), rnorm(n = 100)),
        cluster_id = c(rep("a", 10), rep("b", 50), rep("c", 50)),
        dataset = "outlier"
    )
# bind simulated data together
sim_data <- bind_rows(sim_data_base, sim_data_outlier)The following plots visualize the simulated data as described above:
Using this dataset, we see that tof_assess_clusters_distance() can successfully flag the majority of the outlier cells in each cluster.
sim_data |>
    tof_assess_clusters_distance(
        cluster_col = cluster_id,
        # flag cells with a mahalanobis distance z-score over 3
        z_threshold = 3,
        augment = TRUE
    ) |>
    # visualize result as above
    dplyr::select(-dplyr::starts_with(".mahala"), -z_score) |>
    dplyr::mutate(flagged_cell = as.character(flagged_cell)) |>
    tof_plot_cells_embedding(color_col = flagged_cell) +
    scale_fill_manual(values = tof_generate_palette(num_colors = 2))tof_assess_clusters_entropy()We may also wish to evaluate a clustering result not based on a cell’s absolute distance to the centroid of the cluster to which it was assigned, but based on the relative distances of that cell to all cluster centroids. This is because, in order to be confident in a cell’s cluster assignment, we ideally would want that cell to be close to the centroid of the cluster to which it has been assigned, but relatively distant from all other clusters. This contrasts with the scenario in which a cell might be similarly close to the centroids of 2-3 clusters, in which case we might think of that cell as having an “ambiguous” phenotype, or a phenotype intermediate between the clusters that our clustering algorithm identified.
To flag such “ambiguous” clusters, {tidytof} provides the tof_assess_clusters_entropy() verb. tof_assess_clusters_entropy() computes the entropy of the L1-scaled mahalanobis distance vector (i.e. the mahalanobis distance from each cell to the centroids of all clusters in the dataset) - the entropy will be low (close to 0) when we are confident in a cell’s cluster assignment, and high (near or above 1) when it is equally close to multiple cluster centroids. We demonstrate the use of this function on both simulated data and the levine dataset below.
First, we simulate some a fake dataset with 3000 cells and 4 channels.
sim_data <-
    dplyr::tibble(
        cd45 =
            c(
                rnorm(n = 1000, sd = 2),
                rnorm(n = 1000, mean = 2),
                rnorm(n = 1000, mean = -2)
            ),
        cd38 =
            c(
                rnorm(n = 1000, sd = 2),
                rnorm(n = 1000, mean = 2),
                rnorm(n = 1000, mean = -2)
            ),
        cd34 =
            c(
                rnorm(n = 1000, sd = 2),
                rnorm(n = 1000, mean = 2),
                rnorm(n = 1000, mean = -2)
            ),
        cd19 =
            c(
                rnorm(n = 1000, sd = 2),
                rnorm(n = 1000, mean = 2),
                rnorm(n = 1000, mean = -2)
            ),
        cluster_id = c(rep("a", 1000), rep("b", 1000), rep("c", 1000))
    )In this simulated dataset, we have two well-defined clusters (“b” and “c”) and a more dispersed cluster that is intermediate between the others (“a”). These data are visualized below:
sim_data |>
    tof_reduce_dimensions(method = "pca") |>
    tof_plot_cells_embedding(
        embedding_cols = c(.pc1, .pc2),
        color_col = cluster_id
    )With this dataset, we can imagine that our first analysis approach might involve clustering the cells into 2 distinct clusters. Because these data are simulated, we already know that this number of clusters is too small - but can calculating the entropy of the cells in the resulting clusters help us to realize this without prior knowledge?
To check, we can use tof_assess_clusters_entropy():
set.seed(17L)
entropy_result <-
    sim_data |>
    # cluster into 2 clusters
    tof_cluster(
        num_clusters = 2,
        method = "kmeans"
    ) |>
    # calculate the entropy of all cells
    tof_assess_clusters_entropy(
        cluster_col = .kmeans_cluster,
        marker_cols = starts_with("cd"),
        entropy_quantile = 0.8,
        augment = TRUE
    )
# plot the clusters in PCA space
entropy_result |>
    select(-starts_with(".mahala"), -flagged_cell) |>
    tof_reduce_dimensions(pca_cols = starts_with("cd"), method = "pca") |>
    tof_plot_cells_embedding(embedding_cols = c(.pc1, .pc2), color_col = .kmeans_cluster)
# show the entropy values for each cell
entropy_result |>
    select(-starts_with(".mahala"), -flagged_cell) |>
    tof_reduce_dimensions(pca_cols = starts_with("cd"), method = "pca") |>
    tof_plot_cells_embedding(embedding_cols = c(.pc1, .pc2), color_col = entropy) +
    scale_fill_viridis_c()In the plots above, we can see that cells in the middle of the 2 k-means clusters (which correspond well to the ground-truth clusters “b” and “c” above) have high entropy values, whereas cells that were closer to one of the centroids than the other have low entropy values.
We can also see that tof_assess_clusters_entropy() flags cells as potentially anomalous (i.e. having an intermediate phenotype between two or more clusters that have been identified) if their entropy values are over the 75th percentile (a user-specified parameter) of all entropy values in the dataset. It is then up to the user if they wish to recluster the dataset, filter out the anomalous cells, or other processing steps.
entropy_result |>
    select(-starts_with(".mahala")) |>
    tof_reduce_dimensions(pca_cols = starts_with("cd"), method = "pca") |>
    tof_plot_cells_embedding(embedding_cols = c(.pc1, .pc2), color_col = flagged_cell) +
    scale_fill_viridis_d()And we can see that, as expected, the intermediate cluster (“a”) has higher entropies than either of the more distinct clusters (“b” and “c”).
entropy_result |>
    ggplot(aes(x = entropy, fill = cluster_id)) +
    geom_density(alpha = 0.4) +
    theme_bw()We can also apply tof_assess_clusters_entropy() to a dataset derived from the levine data. Suppose we take the 5 largest clusters in levine and save the result in the small_levine tof_tbl.
clusters_to_keep <-
    levine |>
    dplyr::count(population_id) |>
    dplyr::slice_max(order_by = n, n = 5L) |>
    dplyr::arrange(n) |>
    pull(population_id)
smallest_cluster <- clusters_to_keep[1]
largest_cluster <- clusters_to_keep[[length(clusters_to_keep)]]
small_levine <-
    levine |>
    dplyr::filter(population_id %in% clusters_to_keep)From here, we can perturb the dataset by replacing the labels for the cells in the smallest cluster (cluster 9) with random labels. This effectively creates a population of cells in the dataset whose “true” cluster label is absent. In this scenario, we would expect that the cells in the perturbed cluster will be relatively distant from the remaining clusters, whereas the unperturbed cells will be relatively close to their own cluster centroid (the correct centroid). Thus, we can test if tof_assess_clusters_entropy() successfully flags cells from the perturbed cluster relative to the others:
# perform the perturbation
small_levine <-
    small_levine |>
    dplyr::mutate(
        new_population_id =
            dplyr::if_else(
                population_id %in% smallest_cluster,
                sample(
                    clusters_to_keep[-which(clusters_to_keep %in% smallest_cluster)],
                    size = nrow(small_levine),
                    replace = TRUE
                ),
                population_id
            )
    )
# perform the entropy assessment
entropy_levine <-
    small_levine |>
    tof_assess_clusters_entropy(
        cluster_col = new_population_id,
        marker_cols = starts_with("cd"),
        augment = TRUE
    )From the plot below, we can see that the cells from cluster 9 have larger entropy values than cells from other clusters, as expected.
entropy_levine |>
    mutate(population_id = fct_reorder(population_id, entropy)) |>
    tof_plot_cells_density(
        marker_col = entropy,
        group_col = population_id,
        use_ggridges = TRUE,
        scale = 0.1
    ) +
    ggplot2::theme(legend.position = "none") +
    ggplot2::labs(x = "Entropy", y = "Cluster ID")Similarly, we can see that the majority of the cells from 9 are successfully flagged by tof_assess_clusters_entropy() using an entropy quantile threshold of 0.9. Conversely, no cells from any other cluster (other than cluster 15) flagged.
entropy_levine |>
    mutate(flagged_cell = entropy > quantile(entropy, prob = 0.9)) |>
    dplyr::count(population_id, flagged_cell) |>
    group_by(population_id) |>
    mutate(prop = n / sum(n)) |>
    ungroup() |>
    dplyr::filter(flagged_cell)
#> # A tibble: 2 × 4
#>   population_id flagged_cell     n   prop
#>   <chr>         <lgl>        <int>  <dbl>
#> 1 15            TRUE         12888 0.0798
#> 2 9             TRUE         11666 0.706sessionInfo()
#> R version 4.5.0 RC (2025-04-04 r88126)
#> Platform: x86_64-pc-linux-gnu
#> Running under: Ubuntu 24.04.2 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.21-bioc/R/lib/libRblas.so 
#> LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0  LAPACK version 3.12.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] HDCytoData_1.27.0           flowCore_2.20.0            
#>  [3] SummarizedExperiment_1.38.0 Biobase_2.68.0             
#>  [5] GenomicRanges_1.60.0        GenomeInfoDb_1.44.0        
#>  [7] IRanges_2.42.0              S4Vectors_0.46.0           
#>  [9] MatrixGenerics_1.20.0       matrixStats_1.5.0          
#> [11] ExperimentHub_2.16.0        AnnotationHub_3.16.0       
#> [13] BiocFileCache_2.16.0        dbplyr_2.5.0               
#> [15] BiocGenerics_0.54.0         generics_0.1.3             
#> [17] forcats_1.0.0               ggplot2_3.5.2              
#> [19] dplyr_1.1.4                 tidytof_1.2.0              
#> 
#> loaded via a namespace (and not attached):
#>   [1] jsonlite_2.0.0          shape_1.4.6.1           magrittr_2.0.3         
#>   [4] farver_2.1.2            rmarkdown_2.29          vctrs_0.6.5            
#>   [7] memoise_2.0.1           sparsevctrs_0.3.3       htmltools_0.5.8.1      
#>  [10] S4Arrays_1.8.0          curl_6.2.2              SparseArray_1.8.0      
#>  [13] sass_0.4.10             parallelly_1.43.0       bslib_0.9.0            
#>  [16] lubridate_1.9.4         cachem_1.1.0            igraph_2.1.4           
#>  [19] mime_0.13               lifecycle_1.0.4         iterators_1.0.14       
#>  [22] pkgconfig_2.0.3         Matrix_1.7-3            R6_2.6.1               
#>  [25] fastmap_1.2.0           GenomeInfoDbData_1.2.14 future_1.40.0          
#>  [28] digest_0.6.37           colorspace_2.1-1        AnnotationDbi_1.70.0   
#>  [31] RSQLite_2.3.9           labeling_0.4.3          filelock_1.0.3         
#>  [34] cytolib_2.20.0          yardstick_1.3.2         timechange_0.3.0       
#>  [37] httr_1.4.7              polyclip_1.10-7         abind_1.4-8            
#>  [40] compiler_4.5.0          bit64_4.6.0-1           withr_3.0.2            
#>  [43] doParallel_1.0.17       viridis_0.6.5           DBI_1.2.3              
#>  [46] ggforce_0.4.2           MASS_7.3-65             lava_1.8.1             
#>  [49] rappdirs_0.3.3          DelayedArray_0.34.0     tools_4.5.0            
#>  [52] future.apply_1.11.3     nnet_7.3-20             glue_1.8.0             
#>  [55] grid_4.5.0              recipes_1.2.1           gtable_0.3.6           
#>  [58] tzdb_0.5.0              class_7.3-23            tidyr_1.3.1            
#>  [61] data.table_1.17.0       hms_1.1.3               utf8_1.2.4             
#>  [64] tidygraph_1.3.1         XVector_0.48.0          ggrepel_0.9.6          
#>  [67] BiocVersion_3.21.1      foreach_1.5.2           pillar_1.10.2          
#>  [70] stringr_1.5.1           RcppHNSW_0.6.0          splines_4.5.0          
#>  [73] tweenr_2.0.3            lattice_0.22-7          survival_3.8-3         
#>  [76] bit_4.6.0               RProtoBufLib_2.20.0     tidyselect_1.2.1       
#>  [79] Biostrings_2.76.0       knitr_1.50              gridExtra_2.3          
#>  [82] xfun_0.52               graphlayouts_1.2.2      hardhat_1.4.1          
#>  [85] timeDate_4041.110       stringi_1.8.7           UCSC.utils_1.4.0       
#>  [88] yaml_2.3.10             evaluate_1.0.3          codetools_0.2-20       
#>  [91] ggraph_2.2.1            tibble_3.2.1            BiocManager_1.30.25    
#>  [94] cli_3.6.4               rpart_4.1.24            munsell_0.5.1          
#>  [97] jquerylib_0.1.4         Rcpp_1.0.14             globals_0.16.3         
#> [100] png_0.1-8               parallel_4.5.0          gower_1.0.2            
#> [103] readr_2.1.5             blob_1.2.4              listenv_0.9.1          
#> [106] glmnet_4.1-8            viridisLite_0.4.2       ipred_0.9-15           
#> [109] ggridges_0.5.6          scales_1.3.0            prodlim_2024.06.25     
#> [112] purrr_1.0.4             crayon_1.5.3            rlang_1.1.6            
#> [115] KEGGREST_1.48.0