Expand this Topic clickable element to expand a topic
Skip to content
Optica Publishing Group

Alternating minimization of the negative Poisson likelihood function for the global analysis of fluorescence lifetime imaging microscopy data

Open Access Open Access

Abstract

We investigate a fast optimization method for determining the minimizer of the negative Poisson likelihood function for the global analysis of fluorescence lifetime microscopy. Using the alternating optimization strategy, we iteratively solve a non-convex optimization problem to estimate the lifetime parameters and a convex optimization problem to estimate the concentration parameters. We effectively determine the minimizer of the non-convex optimization using the Gauss-Newton method and that of the convex optimization by applying the optimization transfer strategy, which is based on the convex inequality. In the simulation studies, the proposed method was able to determine the minimizer of the objective function significantly faster than the conventional simultaneous optimization method.

© 2014 Optical Society of America

1. Introduction

In order to successfully use fluorescence lifetime imaging microscopy (FLIM) to study the molecular environments of a cell, high performance lifetime estimations of decaying fluorescence signals is vital because the lifetime is an indicator of environments [1, 2]. The performance of the lifetime estimation may improve as the photon count increases owing to the signal to noise ratio (SNR) of the decaying fluorescence signals being higher when the photon count is larger [3]. Therefore, one may attempt to increase the exposure time for acquiring high photon count signals, thereby improving the performance of the lifetime estimation. However, the attempt often fails due to photo bleaching and limitations of the acquisition time [3].

Since poor SNR signals often result in noisy lifetime images, several investigations attempted to reduce the effect of the noise in estimated lifetime images using methods such as the penalized maximum likelihood method [2], the wavelet based denoising method [4] and the total variation based denoising method [4, 5]. In addition, denoising methods such as the non-local PCA based method [6] and the sparsity based denoising method using dictionary leaning [7] have possibility to be applied for denoising fluorescence lifetime images. Besides that, the compressive sensing strategy, which was applied to reduce the acquisition time for fluorescence microscopy [8], might be applied for improving the performance of lifetime estimation.

Another very useful method that can improve the performance of the lifetime estimation without increasing exposure time is the global analysis method [3, 9, 10]. The main idea of the global analysis method is that simultaneous using of all the data from the locations within the area, which may significantly improve the performance of the lifetime estimation. This can be accomplished by fitting an exponentially decaying model with the same lifetime but different concentrations at various locations to the measured fluorescence signals from the area. Several studies reported that the global analysis was able to dramatically improve the performance of the lifetime estimation [3, 9, 10].

One of the most serious problems of the global analysis method is the difficulty of optimization since it requires a simultaneous optimization of large amount of variables [10]. For example, if one fits an exponentially decaying model with J lifetimes to the data from I pixels, the global analysis requires the simultaneous optimization of J lifetime and I × J amplitude variables with the non-convex objective function. As the number of variables increases, the computational requirement for the optimization can become more demanding. To improve the speed of the optimization, a previous investigation applied an image segmentation method for a good initial guess [10]. However, even with a good initial guess, optimization may be intractable using the general optimization methods that require the inversion of the Hessian matrix because the computational requirement for the inversion increases almost cubically with the number of variables. In addition, the previous investigation used the χ2-based method, which has been shown to perform worse than the maximum likelihood estimation (MLE) method, which is based on the maximization of the Poisson likelihood function [11]. Another investigation on the rapid global analysis also used the χ2-based objective function to utilize the special structure of the sum of square errors in the objective function [12]. However, the method may not be applied for maximizing the Poisson likelihood function.

In this investigation, to maximize the Poisson likelihood function, we propose an efficient optimization strategy that is based on the alternating minimization method and the optimization transfer approach [1315]. The alternating optimization strategy has been used effectively for optimization problems that become easier if some variables are fixed [16, 17]. The strategy was also successfully applied for the restoration of Poissonian image [18]. Using this strategy, we alternatively optimize the lifetime and the amplitude variables. We apply the Gauss-Newton method for the optimization of the lifetime variables and the optimization transfer approach for the optimization of the amplitude variables. We note that there exists a previous investigation on the expectation maximization (EM) based estimation of lifetime parameters [19], which has the similar spirit to the optimization transfer approach. However, the EM based method in the previous investigation is limited for estimating parameters in single exponential function. Moreover, it is difficult to apply the method for global analysis [19]. In comparison, the proposed method rapidly fits multi-exponentially decaying functions to acquired signals using global analysis. In simulation studies, we show that the proposed method is able to maximize the Poisson likelihood function much faster than the conventional simultaneous optimization method.

2. Theory

2.1. Problem formulation

We model the number of photon counts detected at a particular location xi at the time instance tk using the Poisson random variable, yi(tk), as follows [1]:

yi(tk)~Poisson{λi(tk;τ,Ai)},k=0,1,,K1.
The mean of the Poisson random variable is defined as
λi(tk;τ,Ai)=j=0J1aijg(tk;τj),
where aij is the amplitude of the j-th decaying function g(t; τj), which is defined by the convolution of an exponentially decaying function with the j-th decay constant τj and the impulse response function (IRF) of the measurement system, h(t), as follows:
g(t;τj)=etτj*h(t).
We denote the collection of decay constants τ = [τj|j = 0,,J − 1] and the collection of amplitudes Ai = [aij|j = 0,,J − 1] by the lifetime parameter vector and the concentration parameter vector at xi, respectively. Note that the lifetime parameter vector τ is the same for every pixel location, while the concentration parameter vector is allowed to have different values at different locations. The log-likelihood function of the entire parameter vector τ and A = {Ai|i = 0,,I − 1} from the entire measurement data is defined as
L(τ,A;y)=k=0K1i=0I1λi(tk;τ,Ai)+yi(tk)logλi(tk;τ,Ai)logyi(tk)!,
where yi = [yi(tk)|k = 0,,K − 1] is the measured data vector at xi and y = [yi|i = 0,,I − 1] is the collection of the measurements from all locations. The maximum likelihood estimation (MLE) of (τ, A) from the measured data y = [yi|i = 0,,I − 1] is given by
(τ^,A^)=argminτ,A>0L(τ,A;y).
Note that the minimization problem defined in Eq. (5) is a coupled optimization problem because τ is a common parameter vector for every pixel location. Therefore, solving the optimization problem requires the simultaneous optimization of a large sized variable. One may attempt to solve the optimization problem using a software package such as the Optimization toolbox in MATLAB® (Mathworks, USA), as in a previous investigation [10]. However, the computation time can be demanding as the size of variables increases because the inversion of the large size Hessian matrix is often involved. Note that the size of the variable increases as more data points are simultaneously analyzed.

We note that there exist investigations based on different noise model from the one adopted in this research. For example, several investigations used the space variant Gaussian noise model [5, 20] based on the approximation of the Poisson distribution to the Gaussian distribution. However, it was shown that the performance of lifetime estimation using such approximation was worse than that of the Poisson noise based method [2]. There also exist investigations based on the sum of the Poisson and the Gaussian noise model [21, 22]. This model might be more accurate than ours since it considers both random photon arrivals and electric circuit noise. However, because the Poisson noise is dominant over the Gaussian noise in low photon signals (such as signals that require global analysis), we mainly focus on the Poisson noise in this investigation. We note that our optimization strategy in this investigation can be easily extended for the sum of the Poisson and the Gaussian noise model as it was done previously in medical image reconstruction [14].

2.2. Proposed method

To design an efficient method to determine the minimizer of the negative Poisson log-likelihood function defined in Eq. (4), reducing the variable size during the optimization is desirable to avoid inverting the large size Hessian matrix. In addition, if the lifetime parameters are fixed, then the minimization of the negative Poisson likelihood function with respect to the concentration parameters is a convex optimization problem, which may be handled more easily than the non-convex optimization problem. These two facts suggest the following alternating optimization method that iteratively solves two optimization problems, which are the minimizations of the negative log-likelihood function with respect to the lifetime parameters (concentration parameters) while fixing the concentration parameters (lifetime parameters) using the most recently determined values, as follows:

τn+1=argminτ>0L(τ;An,y),
An+1=argminA>0L(A;τn+1,y).
Because the dimensionality of the lifetime parameter vector is usually small, e.g., J for an exponential decay model with J different lifetimes, the computational complexity to determine the inverse of the Hessian matrix for the optimization problem defined in Eq. (6) is not high. We solved the optimization problem using the Gauss-Newton method defined as follows:
τn+1=τn+H1(τn;A,y)L(τn;An,y),
where we approximated the J × J Hessian matrix H(τn; A, y) = [hpq] as
hpq=k=0K1i=0I1(yi(tk)(jaijg(tk;τjn))2)(aijtkτp2g(tk;τpn))(aijtkτq2g(tk;τqn)).
We ignored the second order derivative terms when calculating the Hessian matrix because including these terms may destabilize the optimization [11, 23]. Unlike the optimization problem defined in Eq. (6), the optimization of the concentrations defined in Eq. (7) is a convex optimization problem with large amount of variables. Because the size of the concentration parameters is usually much larger than the size of lifetime parameters, it may not be effective to apply a general optimization method that requires the inversion of the Hessian matrix. We solve the optimization problem by applying an optimization transfer strategy, which is based on the fact that the sequence of minimizers of surrogate functions Q(θ; θm), in which θm denotes the estimated value of θ at the m-th iteration, converges to the minimizer of the original objective function Φ(θ) if the surrogate functions satisfy the following two conditions [14, 15]:
Q(θ;θm)Φ(θ),
Q(θm;θm)=Φ(θm).
If the minimizer of the surrogate function can be easily determined, then minimizing the sequences of surrogate functions can be more effective than the direct minimization of the original objective function. The optimization transfer approach has been successfully applied for image restoration and reconstruction problems, which require simultaneous optimizations of large sized variables for a convex objective function [14,24]. We design an additively separable surrogate function for the objective function in Eq. (7) to determine aijn+1. We construct a separable surrogate function so that the minimizer of the surrogate function can be independently determined. Furthermore, we design the surrogate function such that the minimizer of the surrogate function can be determined in a closed form without using an iterative optimization. To construct such a separable surrogate function, we apply De Pierros’s method using the Jansen’s inequality [24]. Note that the log-likelihood function in Eq. (7) can be represented as
L(A;τn+1,y)=k=0K1i=0I1{j=0J1aijg(tk;τjn+1)yi(tk)log(j=0J1aijg(tk;τjn+1))}.
First, we note the following relationship,
jaijg(tk;τjn+1)=j(aij(n,m)g(tk;τjn+1)jaij(n,m)g(tk;τjn+1))(aijaij(n,m)jaij(n,m)g(tk;τjn+1)),
where aij(n,m) is the estimated value of aij during the m-th sub-iteration to determine aij(n+1). Substituting the argument of the logarithm function in Eq. (12) into Eq. (13) and applying the Jansen’s inequality yields the following inequality:
log(j(aij(n,m)g(tk;τjn+1)jaij(n,m)g(tk;τjn+1))(aijaij(n,m)jaij(n,m)g(tk;τjn+1)))j(aij(n,m)g(tk;τjn+1)jaij(n,m)g(tk;τjn+1))log(aijaij(n,m)jaij(n,m)g(tk;τjn+1)).
Furthermore, the equality in Eq. (14) holds if aij=aij(n,m). Therefore, the following function can be a valid surrogate function:
Q(A;A(n,m))=i,j,kaijg(tk;τjn+1)(yi(tk)aij(n,m)g(tk;τjn+1)jaij(n,m)g(tk;τjn+1))log(aijaij(n,m)jaij(n,m)g(tk;τjn+1)).
The next estimate can be determined using the following derivative with respect to aij:
Q(A;A(n,m))aij=kg(tk;τjn+1)kyi(tk)(aij(n,m)g(tk;τjn+1)jaij(n,m)g(tk;τjn+1))1aij.
By equating the gradient with zero, the next estimate is determined as follows:
aij(n,m+1)=aij(n,m)kg(tk;τjn+1)k(yi(tk)g(tk;τjn+1)jaijng(tk;τjn+1)).
One may perform this sub-iteration M times to define aijn+1. In other words,
aijn+1=aij(n,M).
Note that as M approaches infinity, aijn,M converges to the minimizer of the objective function defined in Eq. (7). However, in practice, a few sub-iterations that increase the log-likelihood function may be sufficient.

2.3. Initial estimates

It is important to select initial parameters judiciously to avoid possible local minima and achieve fast convergence. We determine the initial lifetime parameters by the results of a time invariant fit based on the sum of observed signals, which was shown to be more accurate than pixel-wise independent lifetime estimation methods [10]. We initialize the concentration parameters at each pixel location using the maximum value of observed signal divided by the number of exponential functions in the signal model.

3. Results

3.1. Simulation 1

To compare the performance of the proposed method with the simultaneous optimization strategy, we conducted simulation studies using Poisson random variables yi(tk), the means of which are double-exponentially decaying values defined as

λi(tk;τ1,τ2,ci1,A)=A*{ci1g(tk;τ1)+(1ci1)g(tk;τ2)},
where A is an intensity value and ci1 is the intensity ratio of the lifetime τ1 at the i-th pixel location. Note that a similar model to the one defined in Eq. (19) was used in a previous investigation [10]. In the model defined in Eq. (19), the product of A and cij is equivalent to aij in the model defined in Eq. (3). We generated a 32 × 32 size synthetic image based on Eq. (19) with ci1 varying from 0 to 1. Figure 1(a) shows the true ci1 for every pixel location. We set the true values to τ1 = 2 ns and τ2 = 4 ns and used the IRF of the Gaussian function with σ = 1 and 5 nonzero points. The average total photon counts at each pixel location was 2938.

 figure: Fig. 1

Fig. 1 Intensity parameter images from different optimization methods: (a) true intensity parameter image; (b) estimated intensity parameter image using pixel-wise independent optimization without global analysis; (c) estimated intensity parameter image using the trust region reflective simultaneous optimization method; (d) estimated intensity parameter image using the proposed method

Download Full Size | PDF

First, we attempted to recover the lifetime and amplitude parameters without a global analysis. This was done by maximizing the Poisson log-likelihood function at each pixel independently. Next, we applied the global analysis method to improve the performance of the lifetime and amplitude parameters estimation. To determine the minimizer of the negative Poisson likelihood function defined in Eq. (4), we simultaneously optimized all parameters using the f mincon function in the Optimization toolbox in MATLAB®, which is based on the trust region reflective method [2527]. We further applied the proposed method to solve the optimization problem defined in Eq. (4) with an improved speed. We ran these optimizations on a workstation equipped with 12 core Intel Xeon E5 processor (2.7 GHz) and 64 GB of memory.

Figure 1(b) through Fig. 1(d) show the estimated ci1 images using the pixel-wise independent Poisson likelihood function maximization method, global analysis using simultaneous optimization method, and global analysis using the proposed optimization method, respectively. As shown in Fig. 1(b), the independent Poisson likelihood maximization at each pixel yielded a noisy image due to the poor SNR. The global analysis method was able to improve the performance of the estimation as shown in Fig. 1(c) and Fig. 1(d), which are closer to the true image shown in Fig. 1(a). Both the simultaneous optimization method and proposed method generated nearly identical results, implying that the two methods found the same minimum point during the optimization. However, the proposed method determined the minimum point significantly faster than the conventional simultaneous optimization method. Figure 2(a) reports the convergence of the negative Poisson likelihood function for the global analysis using the simultaneous optimization and proposed alternating optimization method as the function of central processing unit (CPU) time. As shown in Fig. 2(a), the proposed alternating optimization method decreases the Poisson likelihood function much faster than the simultaneous optimization method. The CPU time required to reach the negative Poisson likelihood function value of −5.837 × 106, the almost converged value, using the proposed method was approximately 1 seconds, while that required by the conventional method was approximately 1050 seconds. Note that the proposed method was able to decrease the objective function monotonically without using a line search algorithm. Figure 2(b) through Fig. 2(e) show the change of parameters (τ1, τ2, ai1, and ai2) during the optimization. Since the amplitude value at each pixel location is different, we report parameter values at one pixel location: the (8, 16) location. The true ci1 value of the pixel location was 0.2424. Therefore, the amplitude of the first exponential function was ai1 = 50 × ci1 = 12.12 and that for the second exponential function was ai2 = 50 × (1 − ci1) = 37.88. As shown in Fig. 2, the proposed method converged significantly faster than the conventional simultaneous optimization. Note that even in the time interval where the change of the negative Poisson likelihood function is very small, after approximately 500 s CPU time, the parameters were still changing in the conventional method. As shown in Fig. 2, both the proposed method and simultaneous optimization method converged to nearly the same parameter values (τ1 = 2.0026 ns, τ2 = 4.0072 ns, A1 = 17.49, and A2 = 35.42). However, as mentioned before, the convergence of the proposed alternating optimization method was much faster (by at least 100 times) than the simultaneous optimization method.

 figure: Fig. 2

Fig. 2 Likelihood value and estimated parameters as functions of CPU time for different optimization methods: (a) likelihood; (b) τ1; (c) τ2; (d) A1 of (8, 16) location; (e) A2 of (8, 16) location;

Download Full Size | PDF

3.2. Simulation 2

We conducted another simulation study using Poisson random variables yi(tk), whose means are tri-exponentially decaying signals defined as follows:

λi(tk;τ1,τ2,A1,A2,A3)=A1ig(tk;τ1)+A2ig(tk;τ2)+A3ig(tk;τ2),
where the decay constants are the same (τ1=1ns, τ2=2ns, τ3=4ns) for every pixel but associated amplitudes (A1i, A2i, A3i) may be different at different pixel location. The number of data points at each pixel location was 256. Figs. 3(a)–3(c) shows the images of true amplitude 1, 2 and 3, respectively. We attempted to estimate the decay constants and the amplitudes by fitting bi-exponentially decaying functions to noisy tri-exponentially decaying signals. Note that this sort of modeling error may happen in real experiments since the number of exponential functions which are present in acquired signals may not always be available.

 figure: Fig. 3

Fig. 3 True amplitude images in simulation 2: (a) amplitude 1; (b) amplitude 2; (c) amplitude 3;

Download Full Size | PDF

Figs. 4(a) and 4(b) show the convergence of the two decay constants during optimization. As one can see in the figures, the convergence of the proposed method is much faster than that of the conventional simultaneous optimization method while the two methods determine almost identical decay constants, τ1=1.3ns and τ2=3.76ns. Note that the presence of un-modeled exponential function results in inaccurate estimation of the decay constants. Figs. 4(c) and 4(d) show estimated amplitude images using the global analysis while Figs. 4(e) and 4(f) show those without using the global analysis strategy. As in the previous simulation, the amplitude images determined using the proposed method and the simultaneous global analysis were almost identical. However, the pixel-wise independent estimation yielded very noisy image. In this case, estimated decay constants were 2.76 ns and 29.36ms, which were very inaccurate. We note that the purpose of this simulation is to show that the proposed method converges much faster than the global method with simultaneous optimization even if there exist errors in signal modeling.

 figure: Fig. 4

Fig. 4 Estimated decay parameters as functions of CPU time for different optimization methods: (a) τ1; (b) τ2; (c) amplitude 1 using the global analysis; (d) amplitude 2 using the global analysis; (e) amplitude 1 using the pixel-wise independent estimation; (f) amplitude 2 using the pixel-wise independent estimation;

Download Full Size | PDF

4. Conclusion

We investigated a fast optimization method for the global analysis for FLIM. Unlike the existing simultaneous optimization of concentration and lifetime parameters, the proposed method is based on the alternating optimization strategy, which makes the optimization of concentration parameters a convex optimization problem. We effectively determined the minimizer of the convex objective function using the optimization transfer strategy based on the convex inequality, and we solved a non-convex optimization problem to estimate the lifetime parameters using the Gauss-Newton method. In the simulation studies, the proposed method determined nearly the same parameters as the ones found by the conventional simultaneous optimization method, within a significantly reduced time. As a result, we believe that the proposed optimization method is very useful for the global analysis of FLIM.

Acknowledgments

This research was supported by the Basic Science Research Program through the National Research Foundation of Korea (NRF) funded by the Ministry of Education, Science and Technology ( NRF-2012R1A1A2009370) and Ewha Global Top 5 Grant 2011 of Ewha Womans University.

References and links

1. J. R. Lakowicz, Principles of Fluorescence Spectroscopy (Kluwer Academic/Plenum, 1999). [CrossRef]  

2. J. Kim, J. Seok, H. Lee, and M. Lee, “Penalized maximum likelihood estimation of lifetime and amplitude images from multi-exponentially decaying fluorescence signals,” Opt. Express 21, 20240–20253 (2013). [CrossRef]   [PubMed]  

3. P. J. Verveer, A. Squire, and P. I. Bastiaens, “Global analysis of fluorescence lifetime imaging microscopy data,” Biophys. J. 78, 2127–2137 (2000). [CrossRef]   [PubMed]  

4. C. W. Chang and M.-A. Mycek, “Total variation versus wavelet-based methods for image denoising in fluorescence lifetime imaging microscopy,” J. Biophotonics 5, 449–457 (2012). [CrossRef]   [PubMed]  

5. C. W. Chang and M.-A. Mycek, “Enhancing precision in time-domain fluorescence lifetime imaging,” J. Biomed. Opt. 15, 056013 (2010). [CrossRef]   [PubMed]  

6. J. Salmon, C.-A. Deledalle, R. Willett, and Z. Harmany, “Poisson noise reduction with non-local PCA,” in proceedings of IEEE International Conference on Acoustics, Speech and Signal Processing (IEEE, 2012), pp. 1109–1112.

7. R. Giryes and M. Elad, “Sparsity based poisson denoising,” in proceedings of IEEE Convention of Electrical Electronics Engineers in Israel (IEEE, 2012), pp. 1–5.

8. V. Studer, J. Bobin, M. Chahid, H. S. Mousavi, E. Candes, and M. Dahan, “Compressive fluorescence microscopy for biological and hyperspectral imaging,” Proceedings of the National Academy of Sciences 109, E1679–E1687 (2012). [CrossRef]  

9. H. E. Grecco, P. Roda-Navarro, and P. J. Verveer, “Global analysis of time correlated single photon counting FRER-FLIM data,” Opt. Express 17, 6493–6508 (2009). [CrossRef]   [PubMed]  

10. S. Pelet, M. J. R. Previte, L. H. Laiho, and P. T. C. So, “A fast global fitting algorithm for fluorescence lifetime imaging microscopy based on image segmentation,” Biophys. J. 87, 2807–2817 (2004). [CrossRef]   [PubMed]  

11. J. Kim and J. Seok, “Statistical properties of amplitude and decay parameter estimators for fluorescence lifetime imaging,” Opt. Express 21, 6061–6075 (2013). [CrossRef]   [PubMed]  

12. S. C. Warren, A. Margineanu, D. Alibhai, D. J. Kelly, C. Talbot, Y. Alexandrov, I. Munro, M. Katan, C. Dunsby, and P. M. W. French, “Rapid global fitting of large fluorescence lifetime imaging microscopy datasets,” PLoS ONE 8, e70687 (2013). [CrossRef]   [PubMed]  

13. J. Fessler, E. Ficaro, N. Clinthorne, and K. Lange, “Grouped-coordinate ascent algorithms for penalized-likelihood transmission image reconstruction,” IEEE Trans. Med. Imag. 16, 166–175 (1997). [CrossRef]  

14. J. Fessler, “Image reconstruction: Algorithms and analysis,” Online preprint of book in preparation.

15. K. Lange, Optimization, Springer Texts in Statistics (Springer, 2004). [CrossRef]  

16. U. Niesen, D. Shah, and G. W. Wornell, “Adaptive alternating minimization algorithms,” IEEE Trans. Inf. Theory 55, 1423–1429 (2009). [CrossRef]  

17. Y. Wang, J. Yang, W. Yin, and Y. Zhang, “A new alternating minimization algorithm for total variation image reconstruction,” SIAM J. Imaging Sci.248–272 (2008). [CrossRef]  

18. M. Figueiredo and J. Bioucas-Dias, “Restoration of poissonian images using alternating direction optimization,” IEEE Trans. Image Process. 19, 3133–3145 (2010). [CrossRef]   [PubMed]  

19. A. Jezierska, C. Chaux, J.-C. Pesquet, H. Talbot, and G. Engler, “An EM approach for time-variant poisson-gaussian model parameter estimation,” IEEE Trans. Signal Process. 62, 17–30 (2014). [CrossRef]  

20. C. W. Chang and M.-A. Mycek, “Precise fluorophore lifetime mapping in live-cell, multi-photon excitation microscopy,” Opt. Express 18, 8688–8696 (2010). [CrossRef]   [PubMed]  

21. P. Roudot, C. Kervrann, F. Waharte, and J. Boulanger, “Lifetime map reconstruction in frequency-domain fluorescence lifetime imaging microscopy,” in proceedings of IEEE International Conference on Image Processing, (IEEE, 2012), pp. 2537–2540.

22. P. Roudot, C. Kervrann, J. Boulanger, and F. Waharte, “Noise modeling for intensified camera in fluorescence imaging: Application to image denoising,” in proceedings of IEEE International Symposium on Biomedical Imaging (IEEE, 2013), pp. 600–603.

23. W. H. Press, Numerical recipes : the art of scientific computing, 3rd ed. (Cambridge University, 2007).

24. A. De Pierro, “A modified expectation maximization algorithm for penalized likelihood estimation in emission tomography,” IEEE Trans. Med. Imag. 14, 132–137 (1995). [CrossRef]  

25. J. Moré and D. Sorensen, “Computing a trust region step,” SIAM J. Sci. Comput. 4, 553–572 (1983). [CrossRef]  

26. M. A. Branch, T. F. Coleman, and Y. Li, “A subspace, interior, and conjugate gradient method for large-scale bound-constrained minimization problems,” SIAM J. Sci. Comput. 21, 1–23 (1999). [CrossRef]  

27. R. Byrd, R. Schnabel, and G. Shultz, “Approximate solution of the trust region problem by minimization over two-dimensional subspaces,” Math. Program. 40, 247–263 (1988). [CrossRef]  

Cited By

Optica participates in Crossref's Cited-By Linking service. Citing articles from Optica Publishing Group journals and other participating publishers are listed here.

Alert me when this article is cited.


Figures (4)

Fig. 1
Fig. 1 Intensity parameter images from different optimization methods: (a) true intensity parameter image; (b) estimated intensity parameter image using pixel-wise independent optimization without global analysis; (c) estimated intensity parameter image using the trust region reflective simultaneous optimization method; (d) estimated intensity parameter image using the proposed method
Fig. 2
Fig. 2 Likelihood value and estimated parameters as functions of CPU time for different optimization methods: (a) likelihood; (b) τ1; (c) τ2; (d) A1 of (8, 16) location; (e) A2 of (8, 16) location;
Fig. 3
Fig. 3 True amplitude images in simulation 2: (a) amplitude 1; (b) amplitude 2; (c) amplitude 3;
Fig. 4
Fig. 4 Estimated decay parameters as functions of CPU time for different optimization methods: (a) τ1; (b) τ2; (c) amplitude 1 using the global analysis; (d) amplitude 2 using the global analysis; (e) amplitude 1 using the pixel-wise independent estimation; (f) amplitude 2 using the pixel-wise independent estimation;

Equations (20)

Equations on this page are rendered with MathJax. Learn more.

y i ( t k ) ~ Poisson { λ i ( t k ; τ , A i ) } , k = 0 , 1 , , K 1 .
λ i ( t k ; τ , A i ) = j = 0 J 1 a i j g ( t k ; τ j ) ,
g ( t ; τ j ) = e t τ j * h ( t ) .
L ( τ , A ; y ) = k = 0 K 1 i = 0 I 1 λ i ( t k ; τ , A i ) + y i ( t k ) log λ i ( t k ; τ , A i ) log y i ( t k ) ! ,
( τ ^ , A ^ ) = argmin τ , A > 0 L ( τ , A ; y ) .
τ n + 1 = argmin τ > 0 L ( τ ; A n , y ) ,
A n + 1 = argmin A > 0 L ( A ; τ n + 1 , y ) .
τ n + 1 = τ n + H 1 ( τ n ; A , y ) L ( τ n ; A n , y ) ,
h p q = k = 0 K 1 i = 0 I 1 ( y i ( t k ) ( j a i j g ( t k ; τ j n ) ) 2 ) ( a i j t k τ p 2 g ( t k ; τ p n ) ) ( a i j t k τ q 2 g ( t k ; τ q n ) ) .
Q ( θ ; θ m ) Φ ( θ ) ,
Q ( θ m ; θ m ) = Φ ( θ m ) .
L ( A ; τ n + 1 , y ) = k = 0 K 1 i = 0 I 1 { j = 0 J 1 a i j g ( t k ; τ j n + 1 ) y i ( t k ) log ( j = 0 J 1 a i j g ( t k ; τ j n + 1 ) ) } .
j a i j g ( t k ; τ j n + 1 ) = j ( a i j ( n , m ) g ( t k ; τ j n + 1 ) j a i j ( n , m ) g ( t k ; τ j n + 1 ) ) ( a i j a i j ( n , m ) j a i j ( n , m ) g ( t k ; τ j n + 1 ) ) ,
log ( j ( a i j ( n , m ) g ( t k ; τ j n + 1 ) j a i j ( n , m ) g ( t k ; τ j n + 1 ) ) ( a i j a i j ( n , m ) j a i j ( n , m ) g ( t k ; τ j n + 1 ) ) ) j ( a i j ( n , m ) g ( t k ; τ j n + 1 ) j a i j ( n , m ) g ( t k ; τ j n + 1 ) ) log ( a i j a i j ( n , m ) j a i j ( n , m ) g ( t k ; τ j n + 1 ) ) .
Q ( A ; A ( n , m ) ) = i , j , k a i j g ( t k ; τ j n + 1 ) ( y i ( t k ) a i j ( n , m ) g ( t k ; τ j n + 1 ) j a i j ( n , m ) g ( t k ; τ j n + 1 ) ) log ( a i j a i j ( n , m ) j a i j ( n , m ) g ( t k ; τ j n + 1 ) ) .
Q ( A ; A ( n , m ) ) a i j = k g ( t k ; τ j n + 1 ) k y i ( t k ) ( a i j ( n , m ) g ( t k ; τ j n + 1 ) j a i j ( n , m ) g ( t k ; τ j n + 1 ) ) 1 a i j .
a i j ( n , m + 1 ) = a i j ( n , m ) k g ( t k ; τ j n + 1 ) k ( y i ( t k ) g ( t k ; τ j n + 1 ) j a i j n g ( t k ; τ j n + 1 ) ) .
a i j n + 1 = a i j ( n , M ) .
λ i ( t k ; τ 1 , τ 2 , c i 1 , A ) = A * { c i 1 g ( t k ; τ 1 ) + ( 1 c i 1 ) g ( t k ; τ 2 ) } ,
λ i ( t k ; τ 1 , τ 2 , A 1 , A 2 , A 3 ) = A 1 i g ( t k ; τ 1 ) + A 2 i g ( t k ; τ 2 ) + A 3 i g ( t k ; τ 2 ) ,
Select as filters


Select Topics Cancel
© Copyright 2024 | Optica Publishing Group. All rights reserved, including rights for text and data mining and training of artificial technologies or similar technologies.