Abstract
Background
Analyzing the three-dimensional (3D) refractive index distribution of a single cell makes it possible to describe and characterize its inner structure in a marker-free manner. A dense, full-view tomographic data set is a set of images of a cell acquired for multiple rotational positions, densely distributed from 0 to 360 degrees. The reconstruction is commonly realized by projection tomography, which is based on the inversion of the Radon transform. The reconstruction quality of projection tomography is greatly improved when first order scattering, which becomes relevant when the imaging wavelength is comparable to the characteristic object size, is taken into account. This advanced reconstruction technique is called diffraction tomography. While many implementations of projection tomography are available today, there is no publicly available implementation of diffraction tomography so far.
Results
We present a Python library that implements the backpropagation algorithm for diffraction tomography in 3D. By establishing benchmarks based on finite-difference time-domain (FDTD) simulations, we showcase the superiority of the backpropagation algorithm over the backprojection algorithm. Furthermore, we discuss how measurment parameters influence the reconstructed refractive index distribution and we also give insights into the applicability of diffraction tomography to biological cells.
Conclusion
The present software library contains a robust implementation of the backpropagation algorithm. The algorithm is ideally suited for the application to biological cells. Furthermore, the implementation is a drop-in replacement for the classical backprojection algorithm and is made available to the large user community of the Python programming language.
Electronic supplementary material
The online version of this article (doi:10.1186/s12859-015-0764-0) contains supplementary material, which is available to authorized users.
Keywords: Refractive index, Single-cell analysis, Diffraction tomography, Backprojection, Backpropagation, Rytov, Born, Radon
Background
The measurement of the refractive index of a biological cell is always connected to the observable phase change of light as it passes through the cell. For example, phase contrast microscopy in combination with refractive index matching is used to obtain an average value for the refractive index of a cell population [1]. Accuracy and flexibility of this approach are greatly improved with quantitative phase imaging techniques, such as digital holographic microscopy (DHM) [2]. Nevertheless, the reconstruction of the refractive index with sub-cellular resolution and in three dimensions requires a tomographic approach.
Optical projection tomography
Optical projection tomography (OPT) is a well-studied technique that is used to reconstruct and quantify volumetric data of biological specimens [3, 4]. What distinguishes OPT from conventional 3D imaging techniques in biology, such as e.g. confocal microscopy or selective plane illumination microscopy (SPIM), is the type of measurement data that is acquired and the way it is processed to reconstruct the 3D measurement volume. Tomographic data sets (sinograms) consist of multiple angular projections of the 3D specimen, whereas the techniques mentioned above directly acquire sclices of the reconstruction volume. In OPT-based refractive index measurements, the projections from multiple angles are quantitative phase images. From these phase projections, the 3D refractive index can be reconstructed by means of the filtered backprojection algorithm [5, 6], an efficient algorithm that computes the inverse Radon transform. In the context of this paper, we refer to the filtered backprojection algorithm as the Radon approximation, because it assumes that light travels along straight lines. The Radon approximation is only valid for small wavelengths (e.g. x-ray radiation). Thus, when light with wavelengths in the visible spectrum (e.g. 400–600 nm) propagates through a biological cell, with structures on similar length scales, diffraction takes place and significant interference effects emerge.
Optical diffraction tomography
Optical diffraction tomography (ODT) takes this wave nature of light into account. The diffraction of waves at objects is described by the Helmholtz equation. To simplify the complex description of waves by the Helmholtz equation, two known approximations are commonly applied; the Born and Rytov approximations. While the Born approximation assumes that only a small fraction of the wave is diffracted by the cell, the Rytov approximation assumes that the local refractive index variation inside the cell is small. The Rytov approximation is known to be superior to the Born approximation in ODT [7], but its implementation requires a phase unwrapping step that is not present in the implementation of the Born approximation. Note that OPT with the Radon approximation requires a similar phase unwrapping step. Furthermore, OPT operates on the measured phase data only, whereas ODT additionally incorporates the amplitude data in the reconstruction process. The principles of ODT were first introduced in [8] and a backpropagation algorithm was then described in [9]. The theoretical basis of ODTbrain, as well as a derivation of the full 3D backpropagation algorithm in the Rytov approximation are given in [6].
Our contribution
We present what to our knowledge is the first publicly available software implementation of the 3D backpropagation algorithm. The algorithm can be used to reconstruct 3D refractive index maps from projections of biological or artificial phase objects. We showcase our implementation by reconstructing simulated cells and comparing the reconstruction qualities of OPT (Radon) and ODT (Born, Rytov). Furthermore, we investigate the contribution of several physical parameters to the overall reconstruction quality, complement previously conducted two-dimensional (2D) studies [7, 10, 11] with 3D data, and draw conclusions concerning the validity of the backpropagation algorithm in three dimensions.
Implementation
The ODTbrain library is implemented in the Python programming language. To make the reconstruction process more transparent and to allow user-defined modifications of the reconstruction, we split the reconstruction process into three steps: a) apply a filter to the complex wave sinogram that corresponds to the required approximation (Born, Radon, or Rytov), b) reconstruct the object data from the sinogram (backproject or backpropagate), c) compute the refractive index distribution from the obtained object data. A full documentation, including a method reference and multiple examples, is available at the project home page.
The filtering step (a) is necessary for the application of the Radon and Rytov approximations. For 3D data sets, we rely on the 2D phase-unwrapping algorithm described in [12]. Step (b) is the main part of the reconstruction algorithm. To speed up the computation of Fourier transforms for the 3D reconstruction, ODTbrain employs the FFTW library [13].
In practice, for a successfull reconstruction a pre-processing step is required: the presented implementation requires a sinogram whose projections are distributed equally from 0 to 360° and a rotational axis that is located at the center of each projection. Phase retrieval and image alignment are not part of the reconstruction process and therefore not discussed in this paper.
Results and discussion
Finite-difference time-domain simulations
In order to test the ODTbrain library, we created tomographic data sets from artificial cell phantoms. We performed 2D and 3D finite-difference time-domain (FDTD) simulations with the software MEEP [14] to obtain in silico sinograms containing phase and amplitude of the scattered wave field. We decided to use the FDTD technique, because it describes the vectorial propagation of light according to the Maxwell equations, allowing us to test the approximations against the most realistic in silico data sets for optical tomography. The MEEP implementation of FDTD is also very robust, easy to use, and thus more practical than simulations based on the exact generalized Lorenz-Mie theory [15, 16]. In order to obtain an image as it would be seen through a microscope, we numerically autofocus the measured field from one wavelength (1 λ) behind the phantom to the center of the phantom by minimizing the gradient of the field amplitude [17–19]. Note that the resulting field at the detector is effectively measured with a numerical aperture of N A=1. Thus, the FDTD simulation technique is ideal for the investigation of arbitrary cell phantom geometries.
An exemplary 2D FDTD simulation is shown in Fig. 1. The figure depicts the 2D cell phantom (Fig. 1 a) and the phase of the sinogram which was computed using FDTD simulations (Fig. 1 b). The values of the refractive index for cytoplasm, nucleus, and nucleolus were taken from [20]. A detailed description of the 2D cell phantom is given in Additional file 1. The 2D reconstructions shown in Fig. 1 c, d, e and the corresponding line plots in Fig. 1 f illustrate the superiority of the Rytov approximation over the Born and Radon approximations. The Born approximation entirely fails to reproduce absolute refractive index values [7, 10, 11] and the Radon approximation produces smeared-out refractive index distributions, which becomes visible when comparing the shape of the nucleolus (red) in Fig. 1 d and e with a. The reconstruction with the Rytov and Born approximations were performed with ODTbrain, while the reonstruction with the Radon approximation was performed with the backprojection algorithm as implemented in [21]. The Rytov approximation yields the best reproduction of the initial phantom.
The 3D analog to Fig. 1 is shown in Fig. 2. The cell phantom is rotated about the y-axis and the resulting 3D sinogram consists of 2D projections for the different rotational positions ϕ of the cell phantom. The line plots through the nucleolus of the reconstructed volume in Fig. 2 g and h show the same trend as the 2D line plots in Fig. 1 f. A visualization of the 3D cell phantom is given in the Additional file 2. The reconstructed slice shown in Fig. 2 f exhibits a directional blur that is visible at the upper and lower perimeter of the cell. This directional blur is the result of an incomplete data coverage in the object spectrum commonly referred to as missing apple-core artifacts [22]. Furthermore, it is known that the values at the center of the reconstruction volume along the axis of rotation are error-prone due to coherent noise in the measured sinogram [17]. We documented the artifacts resulting from the incomplete object spectrum and from the noise introduced during simulation and reconstruction in Additional file 3. As in the 2D case, the Rytov approximation yields the best reconstruction in the 3D case.
Reconstruction quality measures
In order to obtain a measure for the reconstruction quality, we introduce two metrics; the normalized root-mean-square (RMS) error and the normalized total-variation (TV) error. We compute the normalized RMS error ERMS according to
(1) |
where n rec is the real-valued refractive index distribution of the reconstruction and n ph that of the phantom. The summation runs over all points that are within the circular (2D) or spherical (3D) reconstruction volume. Points that are outside of this reconstruction volume do not have contributions from all projections and are thus not considered. The RMS error quantifies the error in the refractive index at each point of the reconstruction.
As briefly mentioned in the previous section, the reconstruction with the Radon approximation leads to a blurred reconstruction. Furthermore, the Born approximation cannot reconstruct the correct magnitude of the refractive index values, but produces less blurry images than the Radon approximation. We quantify this blurriness by introducing the TV norm of the differences between phantom n ph and reconstruction n rec. We compute the normalized TV error ETV according to
(2) |
with an averaged TV norm computed for N = 2 or N = 3 dimensions according to the dimensionality of the simulation
(3) |
(4) |
The normalization implies a normalized RMS error of 100 %, when the reconstruction n rec deviates from the phantom n ph at magnitudes that are comparable to the difference between the phantom n ph and a refractive index value of 1. In the same manner, the normalized TV error becomes 100 % if the averaged TV norm is equal to the squared difference between phantom n ph and 1. The chosen RMS and TV metrics lead to error values that allow a direct comparison between the 2D and 3D reconstruction algorithms (see below).
Quality dependence on total number of projections
In order to determine the number of projections that are necessary for full-view and dense diffraction tomography, we performed 2D and 3D simulations with varying total numbers of projections, equally distributed between 0 and 360°. The cell phantoms used for the 2D and 3D simulations are those described above. The RMS and TV error in dependence of the total number of projections are shown in Fig. 3 a and b. At about 160 projections, both RMS and TV errors reach a plateau, which suggests that above this point, the reconstruction cannot be improved any further. For this reason, we set the number of projections to 200 for all subsequent simulations.
Besides the determination of the required number of projections, one can observe two other important facts in Fig. 3. First, the Rytov approximation results in the best reconstruction in 2D as well as in 3D. Second, the RMS and TV errors for the 3D reconstruction follow the RMS and TV errors of the 2D reconstruction. Apparently, the choice of the two error metrics defined in Eqs. 1 (RMS) and 2 (TV) results in similar error estimates for 2D and 3D reconstructions, independent of the number of projections. This similarity of the 2D and 3D errors suggests that the error of a 3D reconstruction may be inferred from the error of a 2D reconstruction. Even though no proof exists for such a connection, this observation potentially saves time or, in the case of limited computational resources, allows to make error estimates in 3D possible at all (see below).
Quality dependence on refractive index variation
In all the cases discussed above, we used fixed refractive index values for the cell phantom. Here, we show how the reconstruction quality varies with different refractive index values for cytoplasm, nucleus and nucleolus. Figure 4 a shows the different combinations of intracellular refractive index values (see figure caption). In the first simulation, the refractive index values of cytoplasm, nucleus, and nucleolus were set to a fixed value of just above water. The resulting RMS and TV errors are very small (Fig. 4 b and c, first simulation) which results in a good reconstruction of the homogeneous refractive index distribution (Fig. 4 d). The RMS and TV errors both increase as the refractive index values of the cell phantom increase. At refractive index values that are above the values for biological cells (1.36 – 1.39 [20]), the reconstruction of the cell phantom with the Rytov approximation is still successful (Fig. 4 e). At very large refractive index values (cytoplasm 1.455, nucleus 1.435, nucleolus 1.543), the reconstruction starts to show artifacts, as shown in Fig. 4 f. Quantitative line plots through the nucleolus are shown in Additional file 4. In comparison to Fig. 3, we again observe that the Rytov approximation yields the lowest reconstruction error and that the 3D error follows the 2D error. Furthermore, the Rytov approximation is valid across a large range of refractive index values, even outside of the regime of biological cells.
Quality dependence on object size
The size of the cell phantom influences the reconstruction quality. For fixed resolution and detector size, small cells are more reliably reconstructed than large cells, because less pixel or voxel values have to be reconstructed. To illustrate this fact, we conducted simulations for different diameters of the cell phantom. In order to be able to compare the different reconstructions in terms of RMS and TV errors, the size of the simulation volume was kept constant. Due to limited computational power, a 3D simulation for cell diameters above 20 wavelengths was not feasible. Figure 5 shows the dependence of the reconstruction quality on the size of the cell. As noted in the previous sections, the RMS and TV errors of the 3D reconstruction follow that of the 2D reconstruction for the number of projections (Fig. 3) and for different refractive index distributions (Fig. 4). We make the same observation for different cell sizes (Fig. 5 a, c) when the simulation volume is small (30 λ). Therefore, we assume that the 2D errors depicted in Fig. 5 b and d may serve as an approximation for the 3D errors that we would observe for very large cells or small cell clusters. The graphs show that up until a cell diameter of 60 wavelengths the reconstruction with the Rytov approximation is very accurate (see also Additional file 5). Above this critical size, phase unwrapping errors lead to reconstruction artifacts. In summary, the correct reconstruction below object sizes of 60 wavelengths justifies the application of the Rytov approximation to 3D arrangements like biological cell clusters.
Conclusions
The presented algorithm is an extension to optical projection tomography that takes into account diffraction of light due to the refractive index of the sample. We verified previous reports of the superiority of the Rytov approximation over the Born and Radon approximations in 2D for the 3D case. As predicted by the theory, the Born approximation breaks down quickly for large cells and for large RI changes [6]. We have shown that full-view, dense data sets must contain at least 160 projections to achieve the best possible reconstruction of a biological cell with a diameter of 17 wavelengths or less. In contrast, few-view and sparse data sets usually require some form of regularization (see [23, 24]). To improve reconstruction quality, the presented implementation in ODTbrain can be extended by regularization methods such as missing-angle artifact minimization, artifact removal by total variation minimization, and iterative reconstruction algorithms [24, 25].
The refractive index range covered successfully by the Rytov approximation is large and includes the range of values found in most biological cells (up to 1.40). Furthermore, the Rytov approximation yields good results for large objects (diameter ≈50 λ). This versatile validity makes the Rytov approximation interesting for the investigation of complex biological samples like cell clusters or even small embryos but also non-biological structures such as optical fibers.
Availability and requirements
Project name: ODTbrainProject home page: http://odtbrain.craban.de Operating system: Platform independentProgramming language: PythonOther requirements: Python 2.7 or Python 3.4License: BSD (3 clause)Any restrictions to use by non-academics: None
Acknowledgements
We acknowledge helpful discussions with Ivo Sbalzarini, Pavel Tomancak, Moritz Kreysing, Martin Weigert (Max Planck Institute of Molecular Cell Biology and Genetics, Dresden, Germany), and Kevin Chalut (Cavendish Laboratory, University of Cambridge, Cambridge, UK; Wellcome Trust - Medical Research Council, Cambridge Stem Cell Institute, Cambridge, UK). This project has received funding from the European Union’s Seventh Framework Programme for research, technological development and demonstration under grant agreement no 282060. We thank the Dresden International Graduate School for Biomedicine and Bioengineering (DIGS-BB) and the German Research Foundation (DFG) for their support with the publication costs in the context of the Excellence Initiative.
Abbreviations
- 2D
Two-dimensional
- 3D
Three-dimensional
- DHM
Digital holographic microscopy (quantitative phase imaging technique)
- FDTD
Finite-difference time-domain (simulation technique used for forward process)
- ODT
Optical diffraction tomography (e.g. backpropagation)
- OPT
Optical projection tomography (e.g. backprojection)
- RMS
Root-mean-square (used for error estimation)
- TV
Total variation (used for error estimation)
Additional files
Footnotes
Competing interests
The authors declare that they have no competing interests.
Authors’ contributions
PM designed and implemented the software, performed the simulations, and carried out the data analysis. MS contributed to key mechanisms of the reconstruction methods and revised the documentation. MS and JG contributed to the design of the study. PM and MS drafted the manuscript. JG supervised the study and helped to draft the manuscript. All authors read and approved the final manuscript.
Contributor Information
Paul Müller, Email: paul.mueller@biotec.tu-dresden.de.
Mirjam Schürmann, Email: mirjam.schuermann@biotec.tu-dresden.de.
Jochen Guck, Email: jochen.guck@biotec.tu-dresden.de.
References
- 1.Barer R. Refractometry and interferometry of living cells. JOSA. 1957;47(6):545–56. doi: 10.1364/JOSA.47.000545. [DOI] [PubMed] [Google Scholar]
- 2.Schürmann M, Scholze J, Müller P, Chan CJ, Ekpenyong AE, Chalut KJ, et al. Refractive index measurements of single, spherical cells using digital holographic microscopy. In: Paluch EK, et al., editors. Biophysical Methods in Cell Biology. Methods in Cell Biology, vol. 125. USA: Academic; 2015. [DOI] [PubMed] [Google Scholar]
- 3.Sharpe J. Optical projection tomography. Annu Rev Biomed Eng. 2004;6(1):209–28. doi: 10.1146/annurev.bioeng.6.040803.140210. [DOI] [PubMed] [Google Scholar]
- 4.Charrière F, Pavillon N, Colomb T, Depeursinge C, Heger TJ, Mitchell EAD, et al. Living specimen tomography by digital holographic microscopy: morphometry of testate amoeba. Opt Express. 2006;14(16):7005–13. doi: 10.1364/OE.14.007005. [DOI] [PubMed] [Google Scholar]
- 5.Kak AC, Slaney M. Principles of Computerized Tomographic Imaging. Philadepphia, USA: SIAM; 2001. [Google Scholar]
- 6.Müller P, Schürmann M, Guck J. The theory of diffraction tomography. 2015. ArXiv e-prints. http://arxiv.org/abs/1507.00466 [DOI] [PMC free article] [PubMed]
- 7.Slaney M, Kak AC, Larsen LE. Limitations of imaging with first-order diffraction tomography. IEEE Trans Microw Theory Tech. 1984;32(8):860–74. doi: 10.1109/TMTT.1984.1132783. [DOI] [Google Scholar]
- 8.Wolf E. Three-dimensional structure determination of semi-transparent objects from holographic data. Opt Commun. 1969;1(4):153–6. doi: 10.1016/0030-4018(69)90052-2. [DOI] [Google Scholar]
- 9.Devaney AJ. A filtered backpropagation algorithm for diffraction tomography. Ultrason Imaging. 1982;4(4):336–50. doi: 10.1177/016173468200400404. [DOI] [PubMed] [Google Scholar]
- 10.Wedberg TC, Stamnes JJ, Singer W. Comparison of the filtered backpropagation and the filtered backprojection algorithms for quantitative tomography. Appl Opt. 1995;34(28):6575–81. doi: 10.1364/AO.34.006575. [DOI] [PubMed] [Google Scholar]
- 11.Chen B, Stamnes JJ. Validity of diffraction tomography based on the first born and the first Rytov approximations. Appl Opt. 1998;37(14):2996–3006. doi: 10.1364/AO.37.002996. [DOI] [PubMed] [Google Scholar]
- 12.Herráez MA, Burton DR, Lalor MJ, Gdeisat MA. Fast two-dimensional phase-unwrapping algorithm based on sorting by reliability following a noncontinuous path. Appl Opt. 2002;41(35):7437–44. doi: 10.1364/AO.41.007437. [DOI] [PubMed] [Google Scholar]
- 13.Frigo M, Johnson SG. Acoustics, Speech and Signal Processing, 1998. Proceedings of the 1998 IEEE International Conference On, vol. 3. Piscataway, New Jersey, USA: IEEE; 1998. FFTW: an adaptive software architecture for the FFT. [Google Scholar]
- 14.Oskooi AF, Roundy D, Ibanescu M, Bermel P, Joannopoulos JD, Johnson SG. MEEP: A flexible free-software package for electromagnetic simulations by the FDTD method. Comput Phys Commun. 2010;181:687–702. doi: 10.1016/j.cpc.2009.11.008. [DOI] [Google Scholar]
- 15.Boyde L, Chalut KJ, Guck J. Near- and far-field scattering from arbitrary three-dimensional aggregates of coated spheres using parallel computing. Phys Rev E. 2011;83(2):26701. doi: 10.1103/PhysRevE.83.026701. [DOI] [PubMed] [Google Scholar]
- 16.Boyde L, Ekpenyong A, Whyte G, Guck J. Comparison of stresses on homogeneous spheroids in the optical stretcher computed with geometrical optics and generalized Lorenz-Mie theory. Appl Opt. 2012;51(33):7934–44. doi: 10.1364/AO.51.007934. [DOI] [PubMed] [Google Scholar]
- 17.Kostencka J, Kozacki T, Dudek M, Kujawińska M. Noise suppressed optical diffraction tomography with autofocus correction. Opt Express. 2014;22(5):5731–45. doi: 10.1364/OE.22.005731. [DOI] [PubMed] [Google Scholar]
- 18.Wu SY, Dugan N, Hennelly BM. Investigation of autofocus algorithms for Brightfield microscopy of Unstained cells. Bellingham, Washington USA: SPIE; 2014. [Google Scholar]
- 19.Müller P. nrefocus: Python algorithms for numerical focusing (Version 0.1.4) [Software]. 2013. https://pypi.python.org/pypi/nrefocus/. Accessed date 19 September 2015.
- 20.Choi WJ, Park KS, Eom TJ, Oh MK, Lee BH. Tomographic imaging of a suspending single live cell using optical tweezer-combined full-field optical coherence tomography. Opt Lett. 2012;37(14):2784–6. doi: 10.1364/OL.37.002784. [DOI] [PubMed] [Google Scholar]
- 21.Müller P. radontea: Python algorithms for the inversion of the Radon transform (Version 0.1.7) [Software]. 2013. https://pypi.python.org/pypi/radontea/. Accessed date 19 September 2015.
- 22.Vertu S, Delaunay JJ, Yamada I, Haeberlé O. Diffraction microtomography with sample rotation: influence of a missing apple core in the recorded frequency space. Central Eur J Phys. 2009;7(1):22–31. [Google Scholar]
- 23.LaRoque SJ, Sidky EY, Pan X. Accurate image reconstruction from few-view and limited-angle data in diffraction tomography. J Opt Soc Am A. 2008;25(7):1772–82. doi: 10.1364/JOSAA.25.001772. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 24.Su JW, Hsu WC, Chou CY, Chang CH, Sung KB. Digital holographic microtomography for high-resolution refractive index mapping of live cells. J Biophoton. 2013;6(5):416–24. doi: 10.1002/jbio.201200022. [DOI] [PubMed] [Google Scholar]
- 25.Behrooz A, Zhou HM, Eftekhar AA, Adibi A. Total variation regularization for 3D reconstruction in fluorescence tomography: experimental phantom studies. Appl Opt. 2012;51(34):8216–27. doi: 10.1364/AO.51.008216. [DOI] [PubMed] [Google Scholar]