Skip to main content

cellXpress: a fast and user-friendly software platform for profiling cellular phenotypes

Abstract

Background

High-throughput, image-based screens of cellular responses to genetic or chemical perturbations generate huge numbers of cell images. Automated analysis is required to quantify and compare the effects of these perturbations. However, few of the current freely-available bioimage analysis software tools are optimized for efficient handling of these images. Even fewer of them are designed to transform the phenotypic features measured from these images into discriminative profiles that can reveal biologically meaningful associations among the tested perturbations.

Results

We present a fast and user-friendly software platform called "cellXpress" to segment cells, measure quantitative features of cellular phenotypes, construct discriminative profiles, and visualize the resulting cell masks and feature values. We have also developed a suite of library functions to load the extracted features for further customizable analysis and visualization under the R computing environment. We systematically compared the processing speed, cell segmentation accuracy, and phenotypic-profile clustering performance of cellXpress to other existing bioimage analysis software packages or algorithms. We found that cellXpress outperforms these existing tools on three different bioimage datasets. We estimate that cellXpress could finish processing a genome-wide gene knockdown image dataset in less than a day on a modern personal desktop computer.

Conclusions

The cellXpress platform is designed to make fast and efficient high-throughput phenotypic profiling more accessible to the wider biological research community. The cellXpress installation packages for 64-bit Windows and Linux, user manual, installation guide, and datasets used in this analysis can be downloaded freely from http://www.cellXpress.org.

Introduction

High-throughput, image-based phenotypic profiling enables multi-parameter measurements of cellular responses to large-scale genetic or chemical perturbations. These measurements are useful for unraveling complex changes in cellular morphology and protein subcellular localization [1], and have been used to study drug responses [2], cell division [3], cytoskeleton remodelling [4], and endocytosis [5]. Several free software tools are currently available for analyzing microscopy images. They include CellProfiler [6], ImageJ [7], BioImageXD [8], Icy [9], OMERO [10], and EBImage [11].

However, most of these existing software tools are designed for general 2D, 3D or time-lapse image analyses, such as de-convolution, segmentation, registration, and motion tracking (Figure 1). Few of them are specifically designed for high-throughput cellular phenotype profiling that generates huge numbers of microscopy images (on the order of 104-105) and poses several new and different challenges to the analysis pipeline and user-interface design. First, individual cells need to be identified and quantified from these images within a reasonable time (usually less than a day for an entire dataset). However, most of the existing free bioimage analysis software tools are developed in high-level programming languages, such as Python or Java, which are slower than C/C++ in executing computational algorithms [12, 13]. Some of the current tools alleviate this problem through external computer clusters [6], which are usually expensive and difficult to manage. Second, diverse types and often large numbers of phenotypic features are required to distinguish the effects of different perturbations [2]. However, most existing tools can extract limited types of phenotypic features. For example, features comparing different sub-cellular regions, such as nuclear versus cytoplasmic intensity, are not available in most existing tools without custom scripting or programming (Figure 1). Third, computational algorithms are required to transform the extracted features into discriminative profiles that can reveal biologically meaningful associations among the tested perturbations [14]. Very few of the existing tools can currently perform this function (Figure 1). Last, intuitive user interfaces are required for configuring algorithms and visualizing results, such as displaying the computed segmentation boundaries or feature values on top of cell images. Therefore, there is a need for a new free and user-friendly software tool that can address these needs of high-throughput phenotypic profiling.

Figure 1
figure 1

Major functional differences between cellXpress and other existing bioimage analysis software platforms.

Implementation

Overall software design and architecture

Here, we present a new cell image analysis software platform called "cellXpress" for high-throughput phenotypic profiling. The platform consists of two main frameworks (Figure 2). The core framework is used for cell segmentation, feature extraction, image management and browsing, and quick data analysis (Figure 3). The second extensible framework is used for custom data analysis, including phenotypic profile construction and visualization (Figure 3). The cellXpress platform can read standard 8-bit or 16-bit TIFF or PNG images produced by most microscopy imaging systems. All the segmentation and feature extraction results computed by the core processing engine are saved in HDF5 binary files [15]. They can also be exported as standard 16-bit TIFF/PNG images or CSV files, which can be opened by third-party image viewers, spreadsheets or data analysis software packages for further processing.

Figure 2
figure 2

The cellXpress cellular phenotype profiling software platform has two main frameworks.

Figure 3
figure 3

Typical data analysis workflow for cellXpress.

The cellXpress platform has the following advantages over existing bioimage analysis software packages. First, to achieve higher processing speeds, we have developed the core processing engine of cellXpress completely in C/C++ based on a highly-optimized computer vision library, OpenCV [16], and efficient single-instruction-multiple-data (SIMD) instruction sets [17]. To fully utilize all the processing units in modern multi-core processors, we have also developed a dynamic job scheduler based on the OpenMP interface [18]. The scheduler manages a job queue for cell segmentation and feature extraction jobs, and automatically assigns pending jobs to free processors or cores. Thus, all the available processors will be fully ultilized by cellXpress.

Second, to extract diverse types of features, we have developed a new subcellular region detection algorithm that can automatically identify eight different subcellular regions based on the nuclear and cell masks from each segmented cell. These sub-cellular regions include whole-cell, nucleus, nuclear boundary, inner nucleus, peri-nucleus, cytoplasm, cytoplasmic boundary, and inner cytoplasm. The cellXpress platform automatically computes four different feature types, namely morphology, intensity, region-level intensity ratio and pixel-level intensity correlation, for each of the identified regions (see Feature Extraction). These diverse types of features will allow the quantification of complex protein subcellular localization patterns at the single-cell level.

Third, to perform profile construction or other custom data analyses, we have developed a suite of library functions called "cXlibrary" under the R computing environment [19]. Users can import cellXpress data saved in HDF5 files into a R session and construct phenotypic profiles. The resulting data or profiles can then be used for supervised classification, unsupervised clustering, or other types of analysis. We also implemented phenotypic profiling algorithms to condense large numbers of raw features extracted in typical high-throughput studies into more concise and discriminative profiles, such as the support-vector-machine (SVM)-based "drug profiles" (d-profiles) [2, 14].

Finally, to make our software user-friendly, we have developed intuitive and interactive graphical user interfaces for configuring and controlling the image processing engine, and visualizing cell segmentation and feature extraction results (Figure 4). We have also designed a point-and-click interface to allow flexible configuration of feature extraction based on different combinations of feature types, sub-cellular regions, and fluorescent markers (Figure 5). Our graphical user interfaces are based on the cross-platform wxWidgets library [20], which provides a consistent look and feel across the Windows and Linux operating systems. Together, all of these components of cellXpress make it a fast and user-friendly software platform for high-throughput image-based phenotypic profiling.

Figure 4
figure 4

Graphical User Interface of cellXpress. A common user interface is used to (a) interactively adjust segmentation parameters and display the resulting cellular outlines, (b) dynamically compose and display multi-channel fluorescence images, (c) visualize and compare results of object detection, (d) overlay display of extracted feature values on top of original images, and (e) browse and compare images from different wells.

Figure 5
figure 5

Point-and-click interface to configure feature and region types.

Seeded-watershed-based cell segmentation algorithm

We have implemented and optimized a seeded-watershed-based cell segmentation algorithm [2] for the cellXpress platform. The segmentation algorithm is general and was previously used to identify individual mouse fat cells, human cancer cells, and neutrophil-like cells from fluorescence microscopy images [2, 21, 22]. In brief, the algorithm consists of two major steps. The first step is to identify nuclear regions from the image background using a combination of h-dome operator [23], Laplacian-of-Gaussian edge detector, and Otsu's thresholding algorithm [24]. Then, a watershed algorithm [25] is used to break apart connected nuclear regions. In the second step, a composite cell image obtained from the linear combination of the images of all fluorescence channels is used to identify cellular regions based on Otsu's thresholding algorithm. Finally, a seeded watershed algorithm that uses the nuclear regions as seeds is used to break apart connected cellular regions. In the future, we plan to include additional segmentation algorithms in the cellXpress platform.

Feature extraction

The cellXpress platform has a flexible feature extraction module that can be used to measure cellular features based on different combinations of feature types, fluorescent markers, and subcellular regions. We have designed a user-friendly graphical interface to configure this feature extraction module (Figure 5) and automatically expand feature selections based on the chosen regions. For example, region-level intensity ratios will be computed for all possible pairs of the selected sub-cellular regions. Information about the markers and regions used in a feature is encoded in its name, which follows the following format: XXXX:YYYY:ZZZZ, where XXXX is the feature type, YYYY is the fluorescent markers used, and ZZZZ is the subcellular regions used. For example, "fraction_total_intensity:ERK:dna_region-cell_region" measures the fraction of total ERK intensity level in the nuclear region to the entire cellular region, and "total_intensity_ratio:Tubulin-ERK:nondna_region-dna_region" measures the ratio of total tubulin intensity level in the cytoplasmic region over total ERK intensity level in the nuclear region. The names of the extracted features are included in all cellXpress HDF5 data files or CSV export files. Users can load specific subsets of extracted features into the R environment by using the load_wells() function in the cXlibrary.

Phenotypic profiling

To transform extracted features into discriminative profiles, we implemented a support-vector-machine-(SVM)-based phenotypic profiling algorithm called "drug profiling" (d-profiling) [2] in the cellXpress platform. Given two sets of feature values for cells under treated and control conditions, respectively, the algorithm trains a linear SVM to obtain a hyperplane that optimally separates these two set of values in high-dimensional feature space. Then, the unit vector normal to the hyperplane is used as a profile to represent changes in the phenotypes of the treated cells with respect to the control cells [2]. Our implementation is based on the LIBLINEAR library [26].

Evaluation methods

Comparisons with existing tools

To evaluate the performance of cellXpress, we considered several other alternative free biological image analysis software platforms (Figure 1). The functions of many of these platforms may be extended through third-party plugins or custom scripting/programming. However, most biological scientists will have limited resources or expertise in developing such custom plugins or programs. Therefore, we only considered built-in functions or plugins that are bundled with default installation packages. We chose to compare the performance of cellXpress (version pro 1.0) [27] to the Broad Institute's CellProfiler (version 2.0) [28] because they have the most similar functions (Figure 1). We also included NIH's ImageJ (version 1.47) [29] with plugins from the Fiji package [30] because it is a standard image analysis tool and widely used by biological scientists. We focused on evaluating the processing speed, cell segmentation accuracy, and profile clustering performance of these software packages.

Applications to Kc167, HT29, and HeLa datasets

To evaluate cell segmentation performance of cellXpress, we used two standard image benchmark datasets, namely Kc167 and HT29, which represent different cell types and numbers of image frames [31, 32]. The first dataset was collected from a Drosophila melanogaster cell line, Kc167. We used the dataset's DNA marker for detecting nuclear regions, and actin marker for detecting cellular regions. This dataset has three image frames (an image frame refers to an imaging position in a well), but we only used one of them for testing cell segmentation speed to mimic the situation when computation cannot be parallelized at the image-frame level. Each image has a resolution of 1000 × 1006 pixels, and there are ~200 cells per frame. The second dataset [33] was collected from a human colon cancer cell line, HT29. We only used the dataset's DNA marker for detecting nuclear regions, and actin marker for detecting cellular regions. The dataset was generated in a shRNA screen for finding mitotic gene regulators [33]. It has 56 image frames, and was used to test cell segmentation when computation may be parallelized at the frame-level. Each image has a resolution of 512 × 512 pixels, and there are ~100 cells per frame. We followed the procedures recommended on the CellProfiler website [31], and used the original images and the provided pipeline without any further image pre-processing.

To evaluate the phenotypic-profiling performance of cellXpress, we used an image dataset from a previous high-throughput siRNA screen [34, 35] on HeLa cells stained for DNA, tubulin, and actin markers. The dataset was generated by transfecting HeLa cells with a genome-wide siRNA library for 48 hours, and used to predict functions of genes based on their knockdown phenotypes. There are four 670 × 510 pixel image frames per gene knockdown, each of which has around 50 cells. siRNAs for a non-human gene, renilla luciferase (Rluc), were used as negative controls. We selected 32 genes, which can be categorized into four groups representing structural components of actins or microtubules, or the synthesis machineries for RNAs or proteins (Additional file 1). The RNA and protein synthesis genes were selected from genes encoding the subunits of RNA polymerase II and ribosome, respectively. Microtubule structural components were selected from the α-tubulin, β-tubulin and γ-tubulin families. For structural components of actins, we included three actin isoforms (alpha, beta and gamma) and genes from the spectrin family, which are actin-crosslinking proteins that link the plasma membrane to the actin cytoskeleton [36].

Evaluation criteria for segmentation accuracy

We used two different segmentation accuracy criteria: the boundary and Rand error indices [37]. The boundary error index ( E boundary ) measures the averaged distance between the boundaries of cellular masks obtained from manual and automated segmentation, respectively. Smaller boundary error index values mean higher automated segmentation accuracy. We define the boundary error index between two sets of boundary pixels (B and B ′ ) from a manual segmentation mask (M) and an automated segmentation mask ( M ′ ), respectively, to be:

E boundary M , M ′ = 1 B ∑ b ∈ B min b ′ ∈ B ′ ∥ b - b ′ ∥ 2 ,

where b and b ′ are individual pixels within sets B and B ′ , respectively; ⋅ is the cardinality operator; and ⋅ is the Euclidean norm.

We also used the Rand error index [37], which measures the frequency with which the two segmentation masks disagree over whether a pair of pixels belongs to same or different segmented cellular regions. Let the set of labelled regions in a manual segmentation mask be L= R i and the set of labelled regions in an automated segmentation mask be L ′ = R j ′ , where R i and R j ′ are the i-th and j-th connected pixels within the respective masks. Furthermore, we denote c as the number of pixel pairs in M that belongs to the same sets in L and the same sets in L ′ , and d as the number of pixel pairs in M that belongs to different sets in L and different sets in L ′ . Then, the Rand error index is:

E Rand M , M ′ = 1 - c + d N 2 .

where N is the total number of pixels in the segmentation mask M.

Generation of phenotypic profiles for HeLa dataset

To construct phenotypic profiles for HeLa cells, we first segmented the dataset using cellXpress. Actin and tubulin were used as cell markers and DNA as a nuclear marker for the watershed algorithm. Then, we measured the morphology, intensity, intensity ratio, and pixel-level intensity correlation features for actin and tubulin in the whole cell, nuclear and non-nuclear regions; and for DNA in the nuclear region only. In total, we measured 290 features for every cell (Additional file 2). Then, we constructed three different types of phenotypic profiles for the dataset. The first type of profiles is based on the arithmetic mean of each feature across all cells that have been treated with a specific siRNA. The second type of profiles is based on principal component analysis (PCA) [38]. We kept the number of principal components needed to explain 95% of the variation in our data, and used the scores vector as the phenotypic profiles. The last type of profiles is the SVM-based "d-profiles" [2] (see Implementation Section).

Evaluation criteria for phenotypic profiling

To evaluate the performance of these three phenotypic profiling methods, we measured the intra-group and inter-group dissimilarities for the four groups of siRNAs (Additional file 1). Other criteria based on centroids or medoids of the groups are not suitable for this dataset, because most of the profiles have highly-asymmetrical and non-Gaussian-like distributions. We computed the cosine dissimilarity between two profiles g r and g s as:

d g r , g s =1- g r g s T g r T g r g s T g s ,

where g T is the vector transpose of g. To determine the average 'compactness' of profiles within a group, we computed the average maximum intra-group dissimilarity score as:

D intra = 1 N ∑ j = 1 N max g r , g s ∈ G j d g r , g s ,

where G j is the set of all profiles in the j- th group, and N is the total number of groups.

To determine the average inter-group profile dissimilarity, we first sorted all pair-wise dissimilarities between profiles from two different groups, G j and G k from the lowest to the highest, where d 1 < d 2 < d 3 < d 4 < … , and d i =d g r , g s for all g r ∈ G j and g s ∈ G k . For a n-nearest neighbours analysis, we denote the set of n lowest distances between two groups, G j and G k , as W j k n = d 1 , d 2 , d 3 , … , d n . Then, the inter-group profile dissimilarity for the n-nearest neighbours is:

D inter = 2 N N - 1 ∑ j = 1 N ∑ k ≠ j E W j k ( n ) ,

where E() is the mean operator. This evaluation is repeated for different values of n.

Computer software and hardware platforms

The evaluations were performed on a desktop computer with a Intel Core i7 3.07 GHz processor, 8 GB of memory, 64-bit Windows 7 operating system, and Java version 7 Update 9 (build 1.7.0_09-b05). All image and data files were stored in a local harddrive. For the evaluation of processing speed and segmentation accuracy, we implemented a script in Matlab version R2007b (Mathworks, USA) to compute and compare both the boundary and Rand error indices. For the evaluation of phenotypic profiling, we generated multidimensional scaling (MDS) plots for all the constructed profiles using the MASS [40] and the rgl libraries [41] under the R computing environment (version 2.14.2).

Results and discussion

Processing speed and segmentation accuracy

A fast and accurate bioimage analysis software platform is required to process the huge amount of microscopy images generated from high-throughput phenotypic profiling experiments. We compared the processing speed and accuracy of cellXpress, CellProfiler [6], and ImageJ/Fiji [42] in segmenting the Kc167, HT29, and HeLa datasets. These three software packages implement variants of similar seeded watershed segmentation algorithms [25]. For CellProfiler [43], we used the segmentation pipeline and optimized parameters included in the Kc167 dataset zip file [31]. We disabled the image cropping function, "show all windows on run" option, and feature-extraction steps in the original pipeline. The pipeline identified DNA regions and the cellular regions using Otsu's thresholding algorithm [43]. For Fiji [42], we implemented a macro script to perform watershed segmentation. The script identified cellular regions using Li's Minimum-Cross-Entropy [44] and Triangle-thresholding algorithms [45] implemented in Fiji for the Kc167 and HT29 datasets, respectively. We found that these two thresholding algorithms gave the best segmentation results for the respective datasets for Fiji.

To evaluate processing speed, we measured the processing time of the whole segmentation process, which includes image loading, processing, and saving. We repeated the measurement five times and computed the mean and standard error of the measurements (Additional file 3). To avoid memory caching, we re-started each software package after every measurement. We found that cellXpress was ~2.3-17.5 times faster than CellProfiler and Fiji (Figure 6a and Additional file 3) on the three tested datasets. For the Kc167 dataset with only one image frame, cellXpress, Fiji and CellProfiler needed 1.65, 3.7, and 7.6 seconds, respectively, to complete the segmentation jobs. For the HeLa dataset with 176 image frames, cellXpress, Fiji and CellProfiler took 32.1, 220.7, and 512.8 seconds respectively, to complete the segmentation jobs. This higher per image performance of cellXpress was partially due to the dynamics job scheduler in cellXpress. Based on our results, we estimate that cellXpress would only take ~5-9 hours to process a typical genome-wide gene knockdown image dataset (~20,000 genes × 9 frames/gene = ~180,000 frames) on a personal desktop similar to our test system, while other software tools could take ~2-6 days. The fast processing speed of cellXpress makes it more efficient for analyzing data generated from high-throughput experiments, such as gene-knockdown or small-molecule screens, on modern desktop computers without requiring expensive computer clusters.

Figure 6
figure 6

Evaluation of processing speed and segmentation accuracy. (a) Processing time of CellProfiler, ImageJ/Fiji, and cellXpress in segmenting Kc167, HT29 and HeLa image datasets. (b) Segmentation accuracy of CellProfiler, ImageJ/Fiji, and cellXpress. (k = total number of image frames, *** = P<0.001, n.s. = P>0.05; two-sided t-test).

To evaluate segmentation accuracy, we compared cell masks obtained automatically from the three software platforms to cell masks obtained from manual segmentation. For the Kc167 dataset, we manually segmented each individual cell based on the actin channel. For the HT29 dataset, we used the manual segmentation masks from the Broad Institute's website [32]. The image frame "10779.DIB" was excluded from analysis, as suggested from the website, because of insufficient image quality. We found that the cellXpress had slightly better or similar segmentation accuracies than Fiji and CellProfiler (Figure 6b). The boundary error of cellXpress was significantly lower than CellProfiler (P<0.001), but the Rand errors of the three tested tools were not significantly different from each other (P>0.05, both using two-sided t-tests). Therefore, the faster speed of cellXpress does not come at the cost of segmentation accuracy.

Evaluation of phenotypic profiling

To demonstrate the ability of cellXpress to identify functional relationships from large-scale gene knockdown studies, we considered an image dataset from a siRNA screen on HeLa cells stained for DNA, tubulin and actin [35]. We focused on four groups of genes that are part of the structural components of actins or microtubules, or the synthesis machineries for RNAs or proteins (Additional file 1); and constructed three types of phenotypic profiles, namely mean, PCA, and d-profiles, for the dataset (Figure 7a). We found that d-profiles separate these groups better, with smaller intra-group and larger inter-group average dissimilarity, than mean- or PCA-based profiles (Figure 7b). We tested n = 5, 10 and 30, and found that d-profiles had the highest average inter-group distance, irrespective of n (Figure 7c).

Figure 7
figure 7

Evaluation of phenotypic profiling. (a) Multidimensional scaling plot based on the cosine dissimilarities among the d-profiles for the 32 siRNAs, which are color-coded according to their known biological functions. (b) Mean intra- and inter-group dissimilarities of phenotypic profiles constructed for 32 siRNAs in the HeLa dataset based on mean-, principal-component-analysis-(PCA)-based, and "d-profiles" (error bars = SEM, * = P<0.05, ** = P<0.01, *** = <0.001; two-sided paired t-test.). (c) Inter-group dissimilarities of mean-, PCA-based and d-profiles for different numbers of nearest neighbors. (Error bars = SEM).

The better performance of d-profiles may be attributed to its ability to capture more informative features. Mean profiles are the arithmetic means of the extracted features across all cells, and PCA profiles are based on an orthogonal transformation of the features into a new set of linearly uncorrelated variables with descending variance (see Evaluation Methods). Both methods do not remove or penalize non-informative features that show high-variance but similar values in both siRNA-treated and control cells. However, d-profiles are based on SVM hyperplanes that optimally separate between treated and control cells, and thus will give lower weights to these non-informative features. Interestingly, we found that d-profiles could distinguish genes involved in the synthesis machineries of RNAs or proteins (Figure 7a), although the cells were only stained with markers for cytoskeleton components. This shows the potential of using morphological and intensity features of a small set of markers to distinguish genes with different biological functions.

Conclusions

The cellXpress platform is specifically designed to make fast and efficient high-throughput phenotypic profiling more accessible to the wider scientific community. Other biological image analysis software platforms may be more appropriate for analyzing time-lapse or 3D microscopy images, or managing large image databases (Figure 1). The cellXpress platform is actively maintained and updated. Future planned improvements include graphics-processing-unit (GPU)-based acceleration, and gene or chemical annotation analysis. The cellXpress software package can be downloaded from http://www.cellXpress.org.

References

  1. Boland MV, Murphy RF: A neural network classifier capable of recognizing the patterns of all major subcellular structures in fluorescence microscope images of HeLa cells. Bioinformatics. 2001, 17 (12): 1213-1223. 10.1093/bioinformatics/17.12.1213.

    Article  CAS  PubMed  Google Scholar 

  2. Loo LH, Wu LF, Altschuler SJ: Image-based multivariate profiling of drug responses from single cells. Nat Methods. 2007, 4 (5): 445-453.

    CAS  PubMed  Google Scholar 

  3. Neumann B, Walter T, Heriche JK, Bulkescher J, Erfle H, Conrad C, Rogers P, Poser I, Held M, Liebel U: Phenotypic profiling of the human genome by time-lapse microscopy reveals cell division genes. Nature. 2010, 464 (7289): 721-727. 10.1038/nature08869.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  4. Bakal C, Aach J, Church G, Perrimon N: Quantitative morphological signatures define local signaling networks regulating cell morphology. Science. 2007, 316 (5832): 1753-1756. 10.1126/science.1140324.

    Article  CAS  PubMed  Google Scholar 

  5. Collinet C, Stoter M, Bradshaw CR, Samusik N, Rink JC, Kenski D, Habermann B, Buchholz F, Henschel R, Mueller MS: Systems survey of endocytosis by multiparametric image analysis. Nature. 2010, 464 (7286): 243-249. 10.1038/nature08779.

    Article  CAS  PubMed  Google Scholar 

  6. Kamentsky L, Jones TR, Fraser A, Bray MA, Logan DJ, Madden KL, Ljosa V, Rueden C, Eliceiri KW, Carpenter AE: Improved structure, function and compatibility for CellProfiler: modular high-throughput image analysis software. Bioinformatics. 2011, 27 (8): 1179-1180. 10.1093/bioinformatics/btr095.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  7. Collins TJ: ImageJ for microscopy. Biotechniques. 2007, 43 (1 Suppl): 25-30.

    Article  PubMed  Google Scholar 

  8. Kankaanpaa P, Paavolainen L, Tiitta S, Karjalainen M, Paivarinne J, Nieminen J, Marjomaki V, Heino J, White DJ: BioImageXD: an open, general-purpose and high-throughput image-processing platform. Nature methods. 2012, 9 (7): 683-689. 10.1038/nmeth.2047.

    Article  PubMed  Google Scholar 

  9. de Chaumont F, Dallongeville S, Chenouard N, Herve N, Pop S, Provoost T, Meas-Yedid V, Pankajakshan P, Lecomte T, Le Montagner Y: Icy: an open bioimage informatics platform for extended reproducible research. Nature methods. 2012, 9 (7): 690-696. 10.1038/nmeth.2075.

    Article  CAS  PubMed  Google Scholar 

  10. Allan C, Burel JM, Moore J, Blackburn C, Linkert M, Loynton S, Macdonald D, Moore WJ, Neves C, Patterson A: OMERO: flexible, model-driven data management for experimental biology. Nature methods. 2012, 9 (3): 245-253. 10.1038/nmeth.1896.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  11. Pau G, Fuchs F, Sklyar O, Boutros M, Huber W: EBImage--an R package for image processing with applications to cellular phenotypes. Bioinformatics. 2010, 26 (7): 979-981. 10.1093/bioinformatics/btq046.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  12. Fourment M, Gillings MR: A comparison of common programming languages used in bioinformatics. BMC Bioinformatics. 2008, 9: 82-10.1186/1471-2105-9-82.

    Article  PubMed Central  PubMed  Google Scholar 

  13. Prechelt L: An empirical comparison of C, C++, Java, Perl, Python, Rexx and Tcl. IEEE Computer. 2000, 33: 23-29. 10.1109/2.876288.

    Article  Google Scholar 

  14. Feng Y, Mitchison TJ, Bender A, Young DW, Tallarico JA: Multi-parameter phenotypic profiling: using cellular effects to characterize small-molecule compounds. Nat Rev Drug Discov. 2009, 8 (7): 567-578. 10.1038/nrd2876.

    Article  CAS  PubMed  Google Scholar 

  15. [http://www.hdfgroup.org/HDF5/]

  16. Bradski G: The OpenCV Library. Dr Dobb's Journal of Software Tools. 2000, 25 (11): 122-125.

    Google Scholar 

  17. Raman SK, Pentkovski V, Keshava J: Implementing streaming SIMD extensions on the Pentium III processor. IEEE Micro. 2000, 20 (4): 47-57. 10.1109/40.865866.

    Article  Google Scholar 

  18. [http://www.openmp.org]

  19. [http://www.r-project.org]

  20. [http://www.wxwidgets.org]

  21. Loo LH, Lin HJ, Singh DK, Lyons KM, Altschuler SJ, Wu LF: Heterogeneity in the physiological states and pharmacological responses of differentiating 3T3-L1 preadipocytes. J Cell Biol. 2009, 187 (3): 375-384. 10.1083/jcb.200904140.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  22. Loo LH, Lin HJ, Steininger RJ, Wang Y, Wu LF, Altschuler SJ: An approach for extensibly profiling the molecular states of cellular subpopulations. Nat Methods. 2009, 6 (10): 759-765. 10.1038/nmeth.1375.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  23. Vincent L: Morphological grayscale reconstruction in image analysis: applications and efficient algorithms. IEEE Trans on Image Processing. 1993, 2: 176-201. 10.1109/83.217222.

    Article  CAS  Google Scholar 

  24. Otsu N: A threshold selection method from grey-level histograms. IEEE Trans Systems, Man and Cybernetics. 1979, 9: 62-66.

    Article  Google Scholar 

  25. Vincent L, Soille P: Watersheds in digital spaces: an efficient algorithm based on immersion simulations. IEEE Trans on Pattern Analysis and Machine Intelligence. 1991, 13: 583-598. 10.1109/34.87344.

    Article  Google Scholar 

  26. Fan R-E, Chang K-W, Hsieh C-J, Wang X-R, Lin C-J: LIBLINEAR: A library for large linear classification. Journal of Machine Learning Research. 2008, 9: 1871-1874.

    Google Scholar 

  27. [http://www.cellXpress.org]

  28. [http://www.cellprofiler.org]

  29. [http://rsbweb.nih.gov/ij]

  30. [http://fiji.sc]

  31. (downloaded on 1st December 2012), [http://www.cellprofiler.org/linked_files/Examplezips/ExampleFlyImages.zip]

  32. (downloaded on 1st December 2012), [http://www.broadinstitute.org/bbbc/BBBC018]

  33. Moffat J, Grueneberg DA, Yang X, Kim SY, Kloepfer AM, Hinkle G, Piqani B, Eisenhaure TM, Luo B, Grenier JK: A lentiviral RNAi library for human and mouse genes applied to an arrayed viral high-content screen. Cell. 2006, 124 (6): 1283-1298. 10.1016/j.cell.2006.01.040.

    Article  CAS  PubMed  Google Scholar 

  34. (downloaded on 20 Dec 2010), [http://www.ebi.ac.uk/huber-srv/cellmorph]

  35. Fuchs F, Pau G, Kranz D, Sklyar O, Budjan C, Steinbrink S, Horn T, Pedal A, Huber W, Boutros M: Clustering phenotype populations by genome-wide RNAi and multiparametric imaging. Mol Syst Biol. 2010, 6: 370-

    Article  PubMed Central  PubMed  Google Scholar 

  36. Bennett V, Healy J: Membrane domains based on ankyrin and spectrin associated with cell-cell interactions. Cold Spring Harb Perspect Biol. 2009, 1 (6): a003012-10.1101/cshperspect.a003012.

    Article  PubMed Central  PubMed  Google Scholar 

  37. Unnikrishnan R, Pantofaru C, Hebert M: Toward objective evaluation of image segmentation algorithms. IEEE Trans Pattern Anal Mach Intell. 2007, 29 (6): 929-944.

    Article  PubMed  Google Scholar 

  38. Pearson K: On Lines and Planes of Closest Fit to Systems of Points in Space. Philosophical Magazine. 1901, 2 (11): 559-572. 10.1080/14786440109462720.

    Article  Google Scholar 

  39. Loo LH, Wu LF, Altschuler SJ: Image-based multivariate profiling of drug responses from single cells. Nat Methods. 2007, 4 (5): 445-453.

    CAS  PubMed  Google Scholar 

  40. Venables WN, Ripley BD: Modern Applied Statistics with S. 2002, Springer, New York, 4

    Chapter  Google Scholar 

  41. [http://cran.r-project.org/web/packages/rgl]

  42. Schindelin J, Arganda-Carreras I, Frise E, Kaynig V, Longair M, Pietzsch T, Preibisch S, Rueden C, Saalfeld S, Schmid B: Fiji: an open-source platform for biological-image analysis. Nat Methods. 2012, 9 (7): 676-682. 10.1038/nmeth.2019.

    Article  CAS  PubMed  Google Scholar 

  43. Carpenter AE, Jones TR, Lamprecht MR, Clarke C, Kang IH, Friman O, Guertin DA, Chang JH, Lindquist RA, Moffat J: CellProfiler: image analysis software for identifying and quantifying cell phenotypes. Genome Biol. 2006, 7 (10): R100-10.1186/gb-2006-7-10-r100.

    Article  PubMed Central  PubMed  Google Scholar 

  44. Li C, Lee C: An Iterative Algorithm for Minimum Cross Entropy Thresholding. Pattern Recognition. 1998, 26 (4): 617-625.

    Article  Google Scholar 

  45. Zack G, Rogers W, Latt S: Automatic measurement of sister chromatid exchange frequency. J Histochem Cytochem. 1977, 25 (7): 741-753. 10.1177/25.7.70454.

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

We thank Cecilia Wei-Ling Tan for her comments and help in performing manual cell segmentation.

Declarations

Publication of the work is supported by Biomedical Research Council of A*STAR (Agency for Science, Technology and Research), Singapore.

This article has been published as part of BMC Bioinformatics Volume 14 Supplement 16, 2013: Twelfth International Conference on Bioinformatics (InCoB2013): Bioinformatics. The full contents of the supplement are available online at http://www.biomedcentral.com/bmcbioinformatics/supplements/14/S16.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Lit-Hsin Loo.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

LHL conceived the software architecture. LHL and DL designed and implemented the software packages. RZT and DL performed the performance comparisons and analyses. GWLT prepared the documentation and website. All authors participated in the writing of the manuscript, and approved the final manuscript.

Danai Laksameethanasan, Rui Zhen Tan contributed equally to this work.

Electronic supplementary material

12859_2013_6124_MOESM1_ESM.PDF

Additional file 1: Plate layout for the genes in the RNA synthesis (blue), ribosomal (yellow), actin (red) and tubulin (green) groups. (PDF 14 KB)

Additional file 2: Feature list for the HeLa siRNA dataset. (PDF 23 KB)

12859_2013_6124_MOESM3_ESM.PDF

Additional file 3: Total processing time for cell segmentation (unit = second, k = frame number, CP = CellProfiler, cX = cellXpress) (PDF 13 KB)

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly credited. The Creative Commons Public Domain Dedication waiver ( https://creativecommons.org/publicdomain/zero/1.0/ ) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Cite this article

Laksameethanasan, D., Tan, R.Z., Toh, G.WL. et al. cellXpress: a fast and user-friendly software platform for profiling cellular phenotypes. BMC Bioinformatics 14 (Suppl 16), S4 (2013). https://doi.org/10.1186/1471-2105-14-S16-S4

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-14-S16-S4

Keywords