Interactive visualization of SummarizedExperiment objects with iSEE

This lab demonstrates how to use the iSEE package to create and configure interactive applications for the exploration of various types of genomics data sets (e.g., bulk and single-cell RNA-seq, CyTOF, gene expression microarray).

Preparation of example scRNAseq data

We use example data from the TENxPBMCData package. This package provides an R / Bioconductor resource for representing and manipulating different single-cell RNA-seq data sets profiling peripheral blood mononuclear cells (PBMC) generated by 10X Genomics (https://support.10xgenomics.com/single-cell-gene-expression/datasets).

The man page for the TENxPBMCData() function gives an idea of the datasets that are available from this package. It can be opened with the following command.

Here, we use the "pbmc3k" dataset, which contains gene expression profiles for 2,700 single peripheral blood mononuclear cells. The first time this dataset is loaded, this command downloads the dataset to a local cache, which takes some time, depending on the speed of your internet connection. Subsequent times, the same command loads the dataset directly from the local cache.

At this point we can inspect the dataset in the console.

The dataset is provided as an object of the SingleCellExperiment class. In particular, this summary view indicates that the following pieces of information are available:

  • An assay matrix named "counts"
  • Row names (i.e. genes) are Ensembl gene IDs
  • Row metadata include for each gene the official gene symbol, and the gene symbol used by the 10x CellRanger quantification pipeline
  • Column names (i.e., cells) are not initialized and left to NULL
  • Column metadata include diverse information for each cell, including the cell barcode ("Barcode") and the donor identifier ("Individual").

Note that a SingleCellExperiment object (or, more generally, any SummarizedExperiment object) like this one already contains sufficient information to launch an interactive application instance to visualize the available data and metadata, using the iSEE() function.

For the purpose of this workshop, we first apply some preprocessing to the SingleCellExperiment object, in order to populate it with more information that can be visualized with iSEE. The steps below roughly follow those outlined in the simpleSingleCell Bioconductor workflow.

We start by adding column names to the object, and use gene symbols instead of Ensembl IDs as row names. In the case where multiple Ensembl identifiers correspond to the same gene symbol, the scater::uniquifyFeatureNames function concatenates the Ensembl ID and the gene symbol in order to generate unique feature names.

Next, we use the scater package to calculate gene- and cell-level quality metrics. These metrics are added as columns to the rowData and colData slots of the SingleCellExperiment object, respectively.

We filter out a few cells with a large fraction of the counts coming from mitochondrial genes, since these may be damaged cells. Notice the reduced number of columns in the dataset below.

Next, we calculate size factors and normalized and log-transformed expression values, using the scran and scater packages. Note that it is typically recommended to pre-cluster the cells before computing the size factors, as follows:

However, for time reasons, we will skip the pre-clustering step in this workshop.

In order to extract the most informative genes, we first model the mean-variance trend and decompose the variance into biological and technical components.

Next, we apply Principal Components Analysis (PCA) and t-distributed Stochastic Neighbor Embedding (t-SNE) to generate low-dimensional representations of the cells in our data set. These low-dimensional representations are added to the reducedDim slot of the SingleCellExperiment object.

Finally, we cluster the cells using a graph-based algorithm, and find ‘marker genes’ for each cluster as the genes that are significantly upregulated in the cluster compared to each of the other inferred clusters. The adjusted p-values from this test, for each cluster, are added to the rowData slot of the object.

This concludes the preparation of the data. We have now a SingleCellExperiment object that contains different types of abundance values, representations in reduced dimensions, as well as a range of row (feature) and column (cell) metadata.

We can launch an iSEE instance for exploring this data set using the iSEE() function:

The main argument to the iSEE() function is a SummarizedExperiment object, or an object of any class extending SummarizedExperiment (such as SingleCellExperiment, in this case). No other restrictions are made on the type of data stored in the object, and iSEE can be used for interactive visualization of many different types of data. It is also worth noting that for various types of data, Bioconductor packages provides functionality for directly importing quantifications generated by external software packages into a SummarizedExperiment object. For example, the DropletUtils package can read quantifications from the 10x Genomics CellRanger pipeline for single-cell RNA-seq data, and the tximeta package can be used to read data from transcript quantification pipelines into a SummarizedExperiment object.

Overview of the iSEE package

This section provides an overview of the graphical interface of iSEE applications. To follow along, make sure that you have launched an iSEE instance as described in the code block at the end of the previous section. Note that in the default configuration, the panels do not look exactly like the ones shown in the screenshots below. For example, data points are not immediately colored, and the default annotation variables displayed by each panel may differ. Later sections of this workshop demonstrate how to modify the content of the panels and how they are displayed.

Note that for simplicity, we typically refer to a SummarizedExperiment in this workshop; however, iSEE works seamlessly for objects of any class extending SummarizedExperiment as well (e.g., SingleCellExperiment, DESeqDataSet). That said, some types of panels – such as the Reduced dimension plot – are only available for objects that contain a reducedDim slot (in particular, SingleCellExperiment objects); the basic SummarizedExperiment class does not contain this slot. In this workshop, we refer to the rows of the SummarizedExperiment object as ‘features’ (these can be genes, transcripts, genomic regions, etc) and to the columns as ‘samples’ (which, in our example data set, are single cells).

The user interface

The iSEE user interface consists of a number of panels, each displaying the data provided in the SummarizedExperiment from a specific perspective. There are 8 standard panel types; 6 plot panels and 2 table panels, all showcased in the figure below. In the default configuration, one panel of each type is included when launching the iSEE user interface. However, users are free to rearrange, resize, remove or add panels freely, as described in a later section. We provide a brief overview of each panel type in the following subsections.

In addition to the 8 standard panel types, user can create custom panels (both plots and tables). The creation and configuration of custom panels is discussed later, in a dedicated section of this workshop.

Reduced dimension plot

The reduced dimension plot can display any reduced dimension representation that is present in the reducedDim slot of the SingleCellExperiment object.

Note that this slot is not defined for the base SummarizedExperiment class, in which case the user interface does not allow the inclusion of panels of this type.

Column data plot

The column data plot can display one or two of the provided column annotations (from the colData slot). Depending on the class of the selected annotations, the panel shows either a Hinton diagram (Hinton and Shallice 1991; Bremner, Gotts, and Denham 1994), a violin plot, or a scatter plot.

Row data plot

Analogous to the column data plot above, the row data plot displays one or two of the provided row annotations (from the rowData slot). Depending on the class of the selected annotations, the panel displays either a Hinton plot, a violin plot, or a scatter plot.

Heat map

The heat map panel displays, for any assay, the observed values for a subset of the features across the samples.

Feature assay plot

The feature assay plot displays the observed values for one feature across the samples. It is also possible to plot the observed values for two features, in a scatter plot.

Sample assay plot

Analogous to the feature assay plot above, the sample assay plot shows the observed values for all features, for one of the samples. It is also possible to plot the observed values for two samples, in a scatter plot.

Row statistics table

The row statistics table displays all information provided in the rowData slot of the SummarizedExperiment object, leveraging the interactivity provided by the DT package.

Column statistics table

Analogous to the row statistics table above, the column statistics table displays all information provided in the colData slot of the SummarizedExperiment object.

‘Data parameters’ collapsible box

Each plot panel type has a Data parameters collapsible box. This box has different content for the each panel types, but in all cases it lets the user control the data that is displayed in the plot.

‘Visual parameters’ collapsible box

In contrast to the Data parameters collapsible box that lets users control what is displayed in the plot, the Visual parameters box lets users control how the information is displayed.

This collapsible box contains the controls to change the size, shape, opacity, and color of the points, to facet the plot by any available categorical annotation, to subsample points for increased speed of plot rendering, and to control how legends are displayed.

‘Selection parameters’ collapsible box

The Selection parameters collapsible box provides controls to transfer selections of points (features or samples) between panels.

We discuss point transmission in more detail later in this workshop.

Additional controls

At the top-right corner of the iSEE application, users can find additional controls for reproducibility, configuration, and help. Each of these is discussed in more detail later in this workshop. Links are provided in the last column of the table below.

Panel organization Organize panels
Diagnostics Examine panel chart, Extract R code, Display panel settings
Documentation Quick tour, Open the vignette
Additional info About this session, About iSEE

Configuration of the app interface

As mentioned above, the default behaviour of the iSEE() function is to launch an instance of the user interface that displays one panel of each of the standard types (provided the underlying data is available, e.g. for reduced dimension plots the reducedDim slot is required). However, in some cases it is desirable to have multiple panels of the same type, and/or exclude some panel types.

In order to accommodate such situations, users can add, remove, change the order of and resize all panels via the Panel organization menu in the top-right corner.

Action: Using your open iSEE instance, open the Organization menu () and click on the Organize panels () button. Try to add and remove panels, and resize the existing ones. Remember to click on Apply settings () to apply the changes you have made to the interface.

Clicking in the selectize box listing all current panels will present you with a drop-down menu from which you can choose additional panels to add. Similarly, panels can be removed by clicking on the icon associated with the panel name.

Each panel can be individually resized by changing the width and height. Note that the total width of a row in the interface is 12 units. When the width of a panel is greater than the space available, the panel is moved to a new row.

It can take a great amount of time to achieve a satisfactory panel configuration. To avoid the need to manually organize the panels each time the app is opened, iSEE offers the possibility to export the current panel settings.

Action: click on the wrench icon () in the top-right corner, and select ‘Display panel settings’. Scroll to the end of the code in the popup window and copy the definition of the initialPanels variable.

For example:

Action: Close the application, run the code that you just copied in your R session, and relaunch the application, now with the additional argument initialPanels set:

Notice how the panel configuration at startup is now identical to the one you saw just before displaying the panel settings.

Now that we have an application consisting of a suitable collection of panels for our data set, we’ll explore the collapsible boxes below each plot, which lets us control their appearance.

Displaying a different reduced dimension representation

By default, each Reduced dimension plot displays the first reduced dimension representation provided (contained in the reducedDim slot of the SingleCellExperiment object). If additional reduced dimension representations are included, the one chosen for the display can be changed in the Data parameters collapsible box in the Reduced dimension plot panel.

Action: Use this control to show the t-SNE representation instead of the PCA.

Notably, the instance can be preconfigured to immediately display the t-SNE representation when the application is launched.

Action: Close the application and run the following block of code to show two Reduced dimension plot panels; one showing the PCA representation, one showing the t-SNE representation.

Coloring points by row/column annotation

With default settings, all points are colored black. However, any provided row (for features) or column (for samples) annotation can be used to color the points.

Action: To demonstrate this, open the Visual parameters collapsible box in one of the Reduced dimension plot panels, and set Color by: to Column data. Scroll through the dropdown menu that appears to see all the sample annotations that can be used to color the points. All these values are taken from the colData slot of the provided object.

Action: First, color the cells by Cluster, which contains the cluster labels that were assigned to the cells in the preprocessing step in a previous section. Note how a discrete color scheme is selected, since the variable is categorical.

Action: Next, color the cells by the log10-transformed number of detected genes (log10_total_features_by_counts). Notice how the color scale is now continuous.

The instance can be preconfigured to control the coloring of data points, to display the same result on startup.

Action: Close the application and run the following block of code to continue editing the configuration of the two Reduced dimension plot panels prepared in the previous section.

iSEE allows precise control over the color schemes used. More information about this can be found in the ExperimentColorMap vignette.

Coloring points by feature value

In addition to coloring cells by the provided annotations as above, we can also color them by the observed values for a given feature (as provided in one of the assays).

Action: Set Color by: to Feature name in one of the Reduced dimension plot panels, and select one of the genes from the dropdown menu. You can search for a gene of interest by typing in the dropdown box. You can also choose which assay should be used to extract the values to color according to.

Again, the same result can be achieved by preconfiguring the application as follows.

Action: Close the application and run the following block of code to set up 3 panels, all displaying the t-SNE representation. In the first panel, we color cells by their Cluster label. In the second and third panel, we display CD79A and CD74, a combination of gene markers typically observed in B cells.

Highlighting a single point

The Color by: Sample name option in the Reduced dimension plot can also be used to highlight a single sample.

Action: Set Color by: to Sample name in the Reduced dimension plot, and use the dropdown menu underneath to change the highlighted cell.

Again, the same result can be achieved by preconfiguring the application as follows. Note that it is more robust to provide the numerical index of the sample in the sce object (see the match statements in the code chunk below).

Action: Close the app and run the following block of code to continue editing the configuration of the two Reduced dimension plot panels prepared in the previous section. We also open the Visual parameters collapsible box to highlight the preconfigured options.

Changing the size, shape and opacity of points

By default, only the Color options are displayed in the Visual parameters box. Additional controls can be shown by clicking the check boxes for Shape, Points, Facets and Other. The Shape and Points panels let you set the shape and size of points according to provided annotations (or to resize all points), and to set the point opacity. Here, you can also downsample points to increase the speed of rendering, which can be useful for data sets with large numbers of points.

Action: Close the app and run the following block of code to continue editing the configuration of the two Reduced dimension plot panels prepared in the previous section. Here, we reduce the point size and increase the transparency (i.e. reduce the value for the alpha attribute). We also apply a downsampling grid of 100 horizontal and vertical bins to the plot, where only a single data point is plotted (if any) for each bin. Finally, we display the Shape and Points options.

Changing the displayed metadata

The Column data plot and Row data plot panels are used to display the information in the colData and rowData slots of the SummarizedExperiment object. These panels can display either one or two annotations. By default, the first annotation in the respective metadata table is selected.

The plot layout adapts automatically to the type of annotation(s) displayed.

  • When all chosen annotations are categorical, iSEE displays a Hinton plot, consisting of rectangles with an area proportional to the number of observations they represent.
  • For a single continuous variable, or one continuous and one categorical variable, iSEE uses violin plot(s).
  • If two continuous variables are chosen, iSEE displays a scatter plot.

As a side note, categorical variables with “too many” unique values (which is typically the case for sample IDs, for instance) are represented as numeric variables, by replacing each value by an index. The limit for what is considered “too many” unique values can be set using options(iSEE.maxlevels = 30).

Action: Explore the different types of plots provided in the Column data or Row data plot panels by selecting different annotations as the Column of interest (Y-axis) and/or setting X-axis: to Column data and selecting an additional annotation.

In the following code chunk we demonstrate the preconfiguration of an app instance that immediately displays two panels.

Action: Close the app and run the following block of code to set up one Column data plot and one Row data plot panel. We set up the Column data plot panel to immediately examine the proportion of counts assigned to mitochondrial features in each cluster. We set up the Row data plot panel to examine the proportion of cells with detectable expression against the log-transformed total counts for each gene.

Displaying gene expression

The Feature assay plot is used to display the observed values for one feature across the samples on the Y-axis. By default, the first feature in the rownames of the dataset is selected, displaying its distribution across the entire dataset.

While continuous measurements are more common (e.g., gene expression), discrete assays are also supported (e.g., single nucleotide polymorphisms), and displayed as a Hinton plot, consisting of rectangles with an area proportional to the number of samples they represent.

It is also possible to plot the observed values a second feature on the X-axis. This will result in a scatter plot or Hinton plot, depending on the continuous or discrete nature of the data, respectively.

Alternatively, the X-axis can also be used to stratify gene expression according to a discrete sample metadata in the form of a violin plot, while a continuous metadata will generate a scatter plot.

Action: Explore the different types of plots generated by the Feature assay plot panel using the choices available for the two axes.

Similarly to all other panels, Feature assay plot can be preconfigured to immediately display specific information when the app is launched.

Action: Close the app and run the following block of code to set up three Feature assay plot panels demonstrating different configurations. All three panels display the same gene on the Y-axis and color data points according to their cluster label. On the X-axis, the first panel displays a discrete sample metadata variable, the cluster label; the second panel display a continuous sample metadata variable, the log-transformed library size; the third panel displays the expression of a second gene.

Linking panels and transmitting point selections

When exploring data, it is often useful to be able to select a subset of points and investigate different aspects of their characteristic features. In iSEE, this can be achieved by selecting points in one panel, and transmitting this selection to one or more other panels.

Action: Select a set of points in one of the Feature assay plot panels, by drawing a rectangle around them. Then open the Selection parameters collapsible box of one of the other Feature assay plot panels, and select the Feature assay plot panel where you made the point selection from the dropdown menu under Receive column selection from. Note how the points corresponding to the cells that you selected in the first panel are highlighted in the receiving panel. You can highlight the points in different ways by changing the Selection effect.

Also the brushing and point selection can be preconfigured. In the example below, we configure three types of panels: a Feature assay plot, a Reduced dimension plot, and a Column data plot. For visual convenience, we color data points in all three panels by the cluster label.

To demonstrate the feature, we define a Shiny brush in the Feature assay plot panel to select cells with detectable levels of the CD3D gene. For the other two panels, pay particular attention to the "SelectByPlot" instruction which declares that they should both receive the data points selected in the Feature assay plot panel. In addition, we specify that the Reduced dimension plot should highlight the selection by applying a transparency effect to unselected data points. Alternatively, we use the Column data plot to demonstrate how the selection can also be highlighted by applying a given color (here, red) to the selected data points.

Action: Close the app and run the following block of code to launch the example application described above.

featAssayArgs <- featAssayPlotDefaults(sce, 2)
featAssayArgs[1, "YAxisFeatName"] <- match("CD3D", rownames(sce))
featAssayArgs$BrushData[[1]] <-  list(
    xmin = 0.5, xmax = 12.5, ymin = 0.5, ymax = 5.7,
    mapping = list(x = "X", y = "Y", group = "GroupBy"),
    direction = "xy", 
    brushId = "featAssayPlot1_Brush", outputId = "featAssayPlot1")
featAssayArgs[1, "XAxis"] <- "Column data"
featAssayArgs[1, "XAxisColData"] <- "Cluster"
featAssayArgs[1, "ColorBy"] <- "Column data"
featAssayArgs[1, "ColorByColData"] <- "Cluster"
redDimArgs <- redDimPlotDefaults(sce, 2)
redDimArgs[1, "SelectByPlot"] <- "Feature assay plot 1"
redDimArgs[1, "Type"] <- match("TSNE", reducedDimNames(sce))
redDimArgs[1, "ColorBy"] <- "Column data"
redDimArgs[1, "ColorByColData"] <- "Cluster"
redDimArgs[1, "SelectBoxOpen"] <- TRUE
colDataArgs <- colDataPlotDefaults(sce, 2)
colDataArgs[1, "SelectByPlot"] <- "Feature assay plot 1"
colDataArgs[1, "SelectEffect"] <- "Color"
colDataArgs[1, "YAxis"] <- "log10_total_counts"
colDataArgs[1, "XAxis"] <- "Column data"
colDataArgs[1, "XAxisColData"] <- "pct_counts_MT"
colDataArgs[1, "ColorBy"] <- "Column data"
colDataArgs[1, "ColorByColData"] <- "Cluster"
colDataArgs[1, "SelectBoxOpen"] <- TRUE
initialPanels <- DataFrame(
    Name=c(
        "Feature assay plot 1", "Reduced dimension plot 1", "Column data plot 1",
        "Feature assay plot 2", "Reduced dimension plot 2", "Column data plot 2"),
    Width=rep(4L, 3L),
    Height=rep(400, 3L)
)
if (interactive()) {
    iSEE(
        sce,
        redDimArgs = redDimArgs, colDataArgs = colDataArgs, featAssayArgs = featAssayArgs,
        initialPanels = initialPanels
    )
}

Notably, iSEE can display active links transmitting point selections between panel using the “Examine panel chart” menu. Visible panels that do not send or receive a selection are also shown.

Zooming into a plot subregion

iSEE allows you to zoom into a subregion of a plot, by simply drawing a rectangle around the area of interest and double-clicking inside the rectangle. To zoom back out to the full plot, double-click anywhere in the plot.

To demonstrate the feature, we set up two Reduced dimension plot panels. In the first panel, we draw a Shiny brush to indicate an area of interest in the reduced dimension plot. We preconfigure the second panel to display only that area. In both panels, we color data points by cluster label using the same color map, to help visualize the zoom relationship between the two panels.

Action: Close the app and run the following block of code to launch the example application described above. Double-click on the area selected in the first panel to zoom and display the same view as the second panel. Double click again anywhere in the panel to zoom out.

Filtering tables

Tables may also be preconfigured to immediately display a subset of rows according to their filters or select a row different from the first one when the app is launched.

For simplicity, we demonstrate this feature using a subset of 3 column metadata–namely “Cluster”, “total_counts”, and “pct_counts_MT”–out of the set of column metadata computed by the workflow above.

In the example below, we preconfigure a Column statistics table to display only cells with cluster labels “3” and “5”, and a library size between 5,000 and 15,844 (the maximum library size in the dataset). In addition, we also preselect the cell named “Cell684”.

Action: Close the app and run the following block of code to launch the example application described above.

Notably the preselected cell can be used to immediately establish a relationship with another panel and highlighted the selection in a different panel as demonstrated earlier.

Action: Close the app and run the following block of code to launch an application that includes a Reduced dimension plot panel dynamically higlighting the cell selected in the Column statistics table. Select different rows of the cell to see the Reduced dimension plot panel update accordingly.

Saving and restoring the state of the application

In the previous sections we have seen how we can specify the initial state of each panel by modifying the columns of the corresponding *Args argument. Often, the initial exploration of a data set, including reorganization and configuration of panels is done interactively. Once a satisfactory panel setup has been achieved, the corresponding settings can be exported and used to restore the state of the app at startup.

Action: Click on the wrench icon () in the top-right corner, and select ‘Display panel settings’. Copy all the code shown in the pop-up window. Close the app and paste this code in your R session. Then launch a new instance using the following code. Note how the app starts in the same configuration as it was before closing. Of course, it is still possible to continue exploring the data interactively - we have only changed the starting configuration.

Custom panels

In addition to the standard panel types, iSEE allows the user to create custom panels, displaying any type of plot or table. The custom panels can receive row and column selections from the standard panels. In order to create a custom panel, we need to define a function that generates the desired output. This function must receive a SummarizedExperiment object as it first input. In addition, if only one selection is to be transmitted (i.e., if iSEE(..., customSendAll=FALSE)) it should take a vector of row names as the second argument, and a vector of column names as the third argument. If iSEE(..., customSendAll=TRUE), all selections (active and saved) are transmitted.

Example: Custom PCA plot

We will first show how to create a custom panel that performs dimension reduction (here, PCA) on a subset of the rows and columns, selected in and transmitted from other panels in the interface.

Action: Copy the code below in your R session in order to define the custom function.

Action: Next, launch an iSEE session with the custom PCA plot panel, as well as a Reduced dimension plot and a Row data plot, from which the column and row selections for the custom PCA are obtained. Select subsets of the points in each of these two panels and note how the PCA plot in the custom panel is updated. Then, in the Data parameters box in the custom panel, use the ‘Custom arguments’ field to select another annotation (or a feature name) to color the points by. Note how iSEE detects that the input arguments were changed, and prompts you to update the plot.

Example: Multiple selections and differential expression

In the example below, we demonstrate the use of iSEE(..., customSendAll=TRUE) to transmit all selections (active and saved). This information is used to compute the log-fold change between the active selection and each of the other saved selections.

Action: Copy the code below in your R session in order to define the custom function.

Action: Next, launch an iSEE session with the custom table panel, as well as a Reduced dimension plot and a Row data plot, from which the column and row selections for the custom table are obtained. Select multiple subsets of the points in the reduced dimension plot (e.g., clusters) and note how the DE table in the custom panel is updated.

More examples of custom panels can be found at https://github.com/kevinrue/iSEE_custom and in the Custom panels vignette (https://bioconductor.org/packages/release/bioc/vignettes/iSEE/inst/doc/custom.html).

Reproducibility

The fact that data exploration is done interactively is no reason to forego reproducibility! To this end, iSEE lets you export the exact R code used to create each of the currently visible plots.

Action: Close the application and run the following block of code to set up 3 panels, all displaying the t-SNE representation.

Then click on the wrench icon () in the top-right corner, and select ‘Extract the R code’. Copy the preamble and the code for the first Reduced dimension plot from the pop-up window. Close the app and paste the code in your R session. Note how this recreates the first reduced dimension plot from the app.

Sharing and communication

One important aspect of visualization is the ability to share your insights with others. A powerful way of easily getting people unfamiliar with your data up to speed is to provide a walk-through of the interface and the different types of plots that are displayed. With iSEE, this can be achieved using tours. To configure a tour, you need to create a text file with two columns; named element and intro, with the former describing the UI element to highlight in each step, and the latter providing the descriptive text that will be displayed.

Action: Run the code below to generate a data frame configuring a tour for the app generated in the previous step. Then launch a new instance, providing the data frame to the tour argument.

To see an example of a more complex tour in action, visit https://marionilab.cruk.cam.ac.uk/iSEE_pbmc4k/. The code used to create this app and the associated tour is available from https://github.com/LTLA/iSEE2018/tree/master/tours/pbmc4k.

Additional resources

Session info

sessionInfo()
#> R version 3.6.0 (2019-04-26)
#> Platform: x86_64-apple-darwin15.6.0 (64-bit)
#> Running under: macOS High Sierra 10.13.6
#> 
#> Matrix products: default
#> BLAS:   /Library/Frameworks/R.framework/Versions/3.6/Resources/lib/libRblas.0.dylib
#> LAPACK: /Library/Frameworks/R.framework/Versions/3.6/Resources/lib/libRlapack.dylib
#> 
#> locale:
#> [1] en_US.UTF-8/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8
#> 
#> attached base packages:
#> [1] parallel  stats4    stats     graphics  grDevices utils     datasets 
#> [8] methods   base     
#> 
#> other attached packages:
#>  [1] iSEE_1.4.0                  BiocSingular_1.0.0         
#>  [3] scran_1.12.1                scater_1.12.2              
#>  [5] ggplot2_3.2.0               TENxPBMCData_1.2.0         
#>  [7] HDF5Array_1.12.1            rhdf5_2.28.0               
#>  [9] SingleCellExperiment_1.6.0  SummarizedExperiment_1.14.0
#> [11] DelayedArray_0.10.0         BiocParallel_1.18.0        
#> [13] matrixStats_0.54.0          Biobase_2.44.0             
#> [15] GenomicRanges_1.36.0        GenomeInfoDb_1.20.0        
#> [17] IRanges_2.18.1              S4Vectors_0.22.0           
#> [19] BiocGenerics_0.30.0         BiocStyle_2.12.0           
#> 
#> loaded via a namespace (and not attached):
#>  [1] Rtsne_0.15                    ggbeeswarm_0.6.0             
#>  [3] colorspace_1.4-1              dynamicTreeCut_1.63-1        
#>  [5] XVector_0.24.0                BiocNeighbors_1.2.0          
#>  [7] DT_0.7                        bit64_0.9-7                  
#>  [9] interactiveDisplayBase_1.22.0 AnnotationDbi_1.46.0         
#> [11] splines_3.6.0                 knitr_1.23                   
#> [13] jsonlite_1.6                  dbplyr_1.4.2                 
#> [15] png_0.1-7                     shinydashboard_0.7.1         
#> [17] shiny_1.3.2                   BiocManager_1.30.4           
#> [19] rentrez_1.2.2                 compiler_3.6.0               
#> [21] httr_1.4.0                    dqrng_0.2.1                  
#> [23] assertthat_0.2.1              Matrix_1.2-17                
#> [25] lazyeval_0.2.2                limma_3.40.2                 
#> [27] later_0.8.0                   htmltools_0.3.6              
#> [29] tools_3.6.0                   rsvd_1.0.1                   
#> [31] igraph_1.2.4.1                gtable_0.3.0                 
#> [33] glue_1.3.1                    GenomeInfoDbData_1.2.1       
#> [35] reshape2_1.4.3                dplyr_0.8.3                  
#> [37] rappdirs_0.3.1                Rcpp_1.0.1                   
#> [39] nlme_3.1-140                  ExperimentHub_1.10.0         
#> [41] rintrojs_0.2.2                DelayedMatrixStats_1.6.0     
#> [43] xfun_0.8                      stringr_1.4.0                
#> [45] beachmat_2.0.0                mime_0.7                     
#> [47] miniUI_0.1.1.1                irlba_2.3.3                  
#> [49] statmod_1.4.32                XML_3.98-1.20                
#> [51] shinyAce_0.3.3                AnnotationHub_2.16.0         
#> [53] edgeR_3.26.5                  zlibbioc_1.30.0              
#> [55] scales_1.0.0                  colourpicker_1.0             
#> [57] promises_1.0.1                yaml_2.2.0                   
#> [59] curl_3.3                      memoise_1.1.0                
#> [61] gridExtra_2.3                 stringi_1.4.3                
#> [63] RSQLite_2.1.1                 rlang_0.4.0                  
#> [65] pkgconfig_2.0.2               bitops_1.0-6                 
#> [67] evaluate_0.14                 lattice_0.20-38              
#> [69] purrr_0.3.2                   Rhdf5lib_1.6.0               
#> [71] labeling_0.3                  htmlwidgets_1.3              
#> [73] cowplot_0.9.4                 bit_1.1-14                   
#> [75] tidyselect_0.2.5              plyr_1.8.4                   
#> [77] magrittr_1.5                  R6_2.4.0                     
#> [79] DBI_1.0.0                     pillar_1.4.2                 
#> [81] withr_2.1.2                   mgcv_1.8-28                  
#> [83] RCurl_1.95-4.12               tibble_2.1.3                 
#> [85] crayon_1.3.4                  BiocFileCache_1.8.0          
#> [87] rmarkdown_1.13                viridis_0.5.1                
#> [89] locfit_1.5-9.1                grid_3.6.0                   
#> [91] blob_1.1.1                    digest_0.6.20                
#> [93] xtable_1.8-4                  httpuv_1.5.1                 
#> [95] munsell_0.5.0                 beeswarm_0.2.3               
#> [97] viridisLite_0.3.0             vipor_0.4.5                  
#> [99] shinyjs_1.0

References

Bremner, Frederick J, Stephen J Gotts, and Dina L Denham. 1994. “Hinton Diagrams: Viewing Connection Strengths in Neural Networks.” Behav. Res. Methods Instrum. Comput. 26 (2): 215–18.

Hinton, Geoffrey E, and Tim Shallice. 1991. “Lesioning an Attractor Network: Investigations of Acquired Dyslexia.” Psychological Review 98 (1): 74–95.