Alternating Minimization Algorithm with Iteratively Reweighted Quadratic Penalties for Compressive Transmission Tomography

Size: px
Start display at page:

Download "Alternating Minimization Algorithm with Iteratively Reweighted Quadratic Penalties for Compressive Transmission Tomography"

Transcription

1 Alternating Minimization Algorithm with Iteratively Reweighted Quadratic Penalties for Compressive Transmission Tomography Yan Kaganovsky a, Soysal Degirmenci b, Shaobo Han a, Ikenna Odinaka a, David G. Politte c, David J. Brady a, Joseph A. O Sullivan b and Lawrence Carin a a Department of Electrical and Computer Engineering, Duke University, Durham, NC, USA b Electrical and Systems Engineering, Washington University in St. Louis, MO, USA c Mallinckrodt Institute of Radiology, Washington University in St. Louis, MO, USA ABSTRACT We propose an alternating minimization (AM) algorithm for estimating attenuation functions in x-ray transmission tomography using priors that promote sparsity in the pixel/voxel differences domain. As opposed to standard maximum-a-posteriori (MAP) estimation, we use the automatic relevance determination (ARD) framework. In the ARD approach, sparsity(or compressibility) is promoted by introducing latent variables which serve as the weights of quadratic penalties, with one weight for each pixel/voxel; these weights are then automatically learned from the data. This leads to an algorithm where the quadratic penalty is reweighted in order to effectively promote sparsity. In addition to the usual obect estimate, ARD also provides measures of uncertainty (posterior variances) which are used at each iteration to automatically determine the trade-off between data fidelity and the prior, thus potentially circumventing the need for any tuning parameters. We apply the convex decomposition lemma in a novel way and derive a separable surrogate function that leads to a parallel algorithm. We propose an extension of branchless distance-driven forward/back-proections which allows us to considerably speed up the computations associated with the posterior variances. We also study the acceleration of the algorithm using ordered subsets. Keywords: Alternating minimization algorithms, automatic relevance determination, reweighted L2, posterior variance estimation, separable surrogates, edge preserving priors, image reconstruction, helical CT.. Statement of the Problem. INTRODUCTION We consider x-ray transmission computed tomography (CT) with Poisson noise. The statistical model for the observations y N n is given by p(y x) = Pois[η exp( Φx)], () where denotes an elementwise product; each row in the matrix Φ R n p + represents the lengths of intersection ofaraywitheachpixel/voxelandapproximatesalineintegral;x R p + arethelinearattenuationcoefficientstobe determined and η are the mean of the measurements in the absence of the obect. Image reconstruction methods based on penalized log-likelihood can be interpreted from a Bayesian perspective as finding the maximum-a posteriori (MAP) solution (Type I) for the parameters x. Often the penalty is chosen to promote sparsity of the pixel/voxel differences. More specifically, the MAP solution can be written as x map = argmax x [ logp(y x) + logp(x) ] where p(y x) is the likelihood function, given by Eq. (), and p(x) is the prior. Further author information: s: yankagan@gmail.com, s.degirmenci@wustl.edu, shaobohan@gmail.com, ikenna.odinaka@duke.edu, politted@wustl.edu, dbrady@duke.edu, ao@wustl.edu, lcarin@duke.edu.

2 .2 Automatic Relevance Determination (ARD) A different approach to sparse estimation is automatic relevance determination (ARD), where sparsity is promoted by treating x as latent variables with prior p(x γ), where γ are newly introduced hyperparameters, and then seeking the γ that maximizes the marginal (Type II) likelihood p(y γ). A special case of ARD, called sparse Bayesian learning (SBL), 2 is based on a Gaussian noise model for y where each parameter x is assigned a zero-mean Gaussian prior with variance γ. Learning the hyperparameters γ from the data results in γ 0 for some, so the corresponding parameters are effectively pruned from the model. Searching for the maximum of the ARD Type II likelihood p(y γ) is intractable. For Gaussian likelihoods, an expectation-maximization (EM) algorithm 2 is used. For non-gaussian likelihoods, the E-step is not tractable and one solution is to use the Laplace approximation 2 where the posterior distribution is approximated by a Gaussian with mean equal the MAP solution and covariance matrix equal to the inverse of the Hessian at this point. Unfortunately, the resulting EM-like algorithm is not based upon a consistent obective function, which prevents monitoring convergence. In addition, it requires expensive inversions of the Hessian matrix, which is not practical for large-scale problems..3 Extending ARD We propose a computationally efficient extension of ARD which can be used for Poisson noise models and that can be applied in practice to large-scale problems such as x-ray CT. We propose the prior p(x;γ) = N(x;0,(Ψ T Γ Ψ) ), Γ = diag(γ), (2) which as opposed to the original SBL, 2 promotes sparsity in the transform domain s = Ψx R p, i.e., we desire s to have many near-zero elements, but not necessarily x. For now, we assume that Ψ is a square matrix but this requirement will be relaxed later. We propose an alternating-minimization (AM) algorithm to compute the hyperparameters in (2). The algorithm will be shown to promote sparsity in the pixel/voxel differences domain. The proposed AM algorithm provides an image of the obect estimate, which can be compared to standard image reconstruction methods. It also provides a variance image which reflects the confidence in the estimated quantities. The latter is not computed automatically by standard image reconstruction algorithms. Importantly, we will show that the variances have a key role in automatically determining the balance between the data-fit and the prior, leading to a tuning-free algorithm. We term this framework variational automatic relevance determination (VARD). The obective of this paper is to study the performance of VARD for helical CT and medical applications. We also propose a method to compute new types of forward/back-proections that are required by VARD and are associated with the posterior variances. The method is an extension of branchless distance-driven forward/backproections proposed by Basu and De Man. 3,4 In addition, we study ordered subsets implementations ALTERNATING-MINIMIZATION ALGORITHM FOR ARD 2. Extending the EM-ARD Algorithm to Poisson Likelihoods First, we address the intractability of the E-step in the EM algorithm for the Poisson model in (). We use a well-known alternative view of the EM algorithm based on minimizing the free variational energy (FVE) 6 where E : q (t+) = argmin q F[q(x),γ (t) ] (3) M : γ (t+) = argmin γ F[q (t+) (x),γ], (4) F[q(x),γ] = E q(x) log[q(x)/p(y,x γ)], (5) and E q denotes the expectation with respect to the probability distribution q. In the EM algorithm, q (t+) (x) = p(x y,γ (t) ), i.e., the exact posterior distribution, and F is the free variational energy (FVE). Instead of finding

3 the posterior distribution during the E-step (which is intractable), we limit the minimization of the FVE to a tractable parametric family of distributions q(x;m,v) = N(x ;m,v ), (6) where the mean m represents our estimate for the attenuation image and the entries in v are the estimates of the posterior variances which provide confidence intervals about m. We consider a factorized distribution in (6) for computational efficiency. Substituting p(y, x γ) = p(y x)p(x γ) into (5) and limiting q according to (6), we obtain the following alternating-minimization (AM) algorithm Backward : (m (t+),v (t+) ) = arg min m 0,v 0 E q(x;m;v) [ logp(y x) ] +DKL [q(x;m,v) p(x;γ (t) )] (7) Forward: γ (t+) = argmin γ D KL [q(x;m (t+),v (t+) ) p(x;γ)], (8) where D KL denotes the Kullback Leibler (KL) divergence. The first term of the right side of (7) does not depend on γ and was omitted in (8). In the B-step in (7) we update the approximation to the posterior q by searching for (m,v). Note that the B-step is equivalent to minimizing the KL divergence between q and the true posterior p(x y), so for a given γ, this q is the best approximation to the true posterior in the KL sense. In the F-step in (8) we update the generative (forward) model by finding γ. By definition, the FVE is reduced at each iteration and the two steps are repeated until convergence. Importantly, as shown below, the iterations of the AM algorithm lead to near-sparse solutions, i.e., in the s = Ψx domain, q of (6) is highly concentrated about zero for many s i. In contrast, a single B-step in (7) for the ARD model does not promote sparsity. For additional discussions on the sparsity promoting mechanism of VARD we refer the reader to Kaganovsky et al. 7 The obective function in (7) can be written explicitly as F = F (m,v)+f 2 (m,γ) (9) F (m,v) = i [ {}}{ y i φ i m + η i exp( φ i m + ] φ 2 i v /2) i T2 {}}{ F 2 (m,γ) = γi ( ψ i m ) 2 + γi ψi v logv + logγ i, () 2 2 i where ψ i and φ i denote the entry on the ith row and th column of the matrices Ψ and Φ, respectively; we have marked the terms which are not additively separable by T and T2 for future reference. The solution to the F-step in (8) is obtained in closed form by solving γ D KL [q p] = 0 and is given by T i (0) γ (t+) i = ( ψ i m ) 2 + ψ 2 iv. (2) One choice for Ψ in (2) is logp(x γ) = i γ (x i χ i x / χ ) 2 +Const, where χ i is the neighborhood of the ith voxel and χ is the number of neighbors. To make Ψ invertible, one can enforce zero differences at the boundaries (Neumann boundary conditions). This prior will promote sparsity in the differences between each mean voxel m and the average of its neighboring mean voxels. However, we have found in some preliminary experiments 7 that the image quality improves if instead we use the following Ψ Ψ = [Ψ x ;Ψ y ;Ψ z ], (Ψ x,y,z ) k = { if = k if {,k} Θ x,y,z 0 otherwise, (3) where [; ] denotes concatenation, and Θ x, Θ y and Θ z define pairs of neighboring voxels located along the x, y and z directions, with corresponding matrices Ψ x,ψ y, and Ψ z respectively. We assign the same weight to each voxel difference, so γ is replaced by [γ;γ;γ]. In this case, the F-step in (8) can no longer be interpreted as minimizing KL divergence, but the obective function in (9) () remains the same as before.

4 2.2 Separable Surrogates for Parallel Computing First, we make several definitions to simplify the following derivations, p (t) i φ i m (t), p(t) i φ 2 i v(t), (4) µ (t) [ i E q(x;m (t),v (t) ) ηi exp( φ i x ) ] = η i exp( p (t) i /2)exp( p (t) i ), (5) b y i φ i y i, b (t) i φ i µ (t) i, b(t) i φ 2 iµ (t) i /2, (6) where y i and η i are defined in (). To distinguish between quantities associated with the mean and variance, we denote any quantities associated with the variance using a tilde. In (4), p (t) i is the proection of the posterior mean m (t) along the ith line, which we shall call a mean-type proection; p (t) i is a proection of the posterior variance v (t) along the ith line using an elementwise squared forward operator, which we term a variance-type proection. In (5), µ (t) i is the predicted Poisson rate for the ith measurement, based on the expectation with respect to the posterior distribution q computed at iteration t. In (6), b y is the back-proectionof measurements y to the th pixel; b (t) and b (t) are the back-proections of the predicted Poisson rate in (5) to the th pixel, using the backward (adoint) operator and the squared backward operator, respectively, which we call mean-type and variance-type backproections. We modify the B-step in (7) by applying the convex decomposition lemma 8 to the non-separable terms in (0) () marked by T and T2. This leads to a separable surrogate obective S which has the following properties, and it is given by F(m,v γ (t) ) S(m,v;m (t),v (t) ) (7) F(m (t),v (t) γ (t) ) = S(m (t),v (t) ;m (t),v (t) ), (8) S(m,v;m (t),v (t) ) = S m (m ;m (t),v (t) )+ S v (v ;m (t),v (t) )+h (t), (9) S m (m ;m (t),v (t) ) = b y m + b(t) exp [ Z (m m (t) Z )] +f (t) (m m (t) S v (v ;m (t),v (t) ) = )+ g(t) (m m (t) )2, (20) b(t) Z exp [ Z (v v (t) ) ] +ξ (t) v /2 logv /2, (2) where b (t) (t), b are given in (6) and the rest of the parameters are defined by Z = max i g (t) φ i +φ 2 i/2, Z 2 k ψ k /2γ (t) k, d (t) k Z 2 = max k ψ k m (t), f(t) k ψ k, ξ (t) k ψ k d (t) k /γ(t) k, (22) ψ 2 k/γ (t) k, h(t) k (d (t) k )2 /2γ (t) k. (23) Note that the surrogate function S in (9) is separable with respect to the components of both m and v. This yields a modified B-step where S is minimized by simultaneous (parallel) line search procedures, each with respect to a different component m or v. The iterations are defined as m (t+) v (t+) = argmins m (m ;m (t),v (t) ) (24) m 0 = argmins(v v ;m (t),v (t) ). (25) v 0

5 Combining the modified B-step in (24) (25) with the F-step in (2), we obtain the parallel VARD algorithm described in Algorithm. Each iteration requires a mean-type forward-proection p (t) (line 4 in Algorithm ) and a variance type forward-proection p (t) (line 5 in Algorithm ) which can be computed in parallel. It also requires a mean-type backproection b (t) (line 8 in Algorithm ) and a variance-type backproection (line 9 in Algorithm ), which also can be computed in parallel. For proof of convergence we refer the reader to Kaganovsky et al BRANCHLESS DISTANCE-DRIVEN VARIANCE-TYPE PROJECTION AND BACKPROJECTION Basu and De Man 3 proposed a variation of their distance-driven proection and backproection method 4 that is highly parallelizable and amenable to vectorization in highly pipelined architectures. They consider the usual proection and backproection operations where the system matrix Φ and its transpose are implicitly applied on a vectorized image. We use their method for the mean-type proections/backproections required by VARD (lines 4 and 8 in Algorithm ). However, in addition to these operations, the VARD algorithm also requires variance-type proection and backproection (see lines 5 and 9 in Algorithm ) where the system matrix is squared element-wise and then applied to a vector. Next, we propose an extension of the branchless distance-driven method 3 that allows us to perform the variance-type operations while maintaining the same computational advantages as for the mean-type operations. Note that ray-tracing-based proections are easily extendable to these variance-type operations, however, as explained in Basu and De Man, 3,4 the distance-driven approach allows one to eliminate artifacts that are associated with ray-based proections and can allow more efficient memory access patterns leading to reduced computational time in highly pipelined architectures. For simplicity, we present the algorithm for the 2D case, since the extension to 3D is straightforward. To simplify the presentation we shall present the original method by Basu and De Man 3 used for the mean type operations and then state our modification for the variance type operations. Distance-driven proection and backproection consist of two maor steps: () proections of detector and pixel boundaries onto a common axis (see Fig. ); (2) application of the overlap kernel. The overlap kernel for the mean operations can be described in an abstract way as follows. Suppose we are given a set of points p i on the x axis for i {,...,I} that are sorted p i < p i+. Associated with each successive pair of points {i,i+} is a signal value p i,i+. We are also given a second set of ordered points d for {,.,,,J} such that d < d + which define intervals [d,d + ) on which we wish to compute the value d,+ associated with this interval. Each signal value p i,i+ is weighted accordingto the overlapbetween the intervals[p i,p i+ ) and [d,d + ), as defined in (30). In the case of forward proection, d,+ is the proection along a ray and [p i,p i+ ) [d,d + ) /(d + d ) b (t) Algorithm VARD with Separable Surrogates : Initialize m (),v (),γ () 2: Compute b y in (6) % backproection of data % 3: for t = to N do % AM iterations % 4: p (t) Φm (t) % mean-type proections % 5: p (t) (Φ Φ)v (t) % variance-type proections % 6: µ (t) η exp( p (t) /2) exp( p (t) ) 7: Compute g (t), ξ (t) and f (t) defined in (22) (23) 8: b (t) Φ T µ (t) % mean-type backproections of µ (t) % 9: b(t) (Φ Φ) T µ (t) % variance-type backproections of µ (t) % 0: for = to p do % executed in Parallel % : m (t+) argmin m 0S m(m ;b (t),f(t),g (t) ) % see (20) % 2: v (t+) argmin v 0 Sv (v ; b (t),ξ(t) ) % see (2) % 3: γ (t+) [Ψm (t) ] [Ψm (t) ]+[Ψ Ψ]v (t) % see (2) %

6 p,2 p 2,3 x p p 2 p 3 x d d 2 d d 2 d,2 d,2 Figure. Left: an example of the proections of detector boundaries onto the x axis; Right: enlarged view of two of the proected detector boundaries shown on the left (red circles) with the relevant pixel boundaries (magenta circles). The pixel values are denoted by p,2 and p 2,3; the proection corresponding to the considered detector is denoted by d,2. The expressions for calculating the proections for mean and variance are given in (32) and (33), respectively. represents the ith entry in the system matrix. Similarly, we can define the overlap kernel for the variance-type operations, where the coefficients of the system matrix are squared. This corresponds to the overlap kernel defined in (3) with the weight of each signal value squared. Examples corresponding to Fig. are shown in (32) and (33). The main idea behind the branchless method by Basu and DeMan is to express the proections/backproections as resampling operations. They define the integral in (34), which is then expressed as a difference between two integrals; their values are determined by linear interpolation from the knowledge of the integral values on a chosen grid (exploiting the piecewise nature of the function in (35)). Here we follow a similar route, but we need to define a two-dimensional (2D) piecwise constant function in (37) and a 2D integral in (36), which is then expressed as d+ d+ d,+ = (d + d ) 2 p v (x,y)dxdy (26) d d = (d + d ) 2[P(d +,d + ) 2P(d +,d )+P(d,d )], (27) where we defined P(τ,τ 2 ) = τ τ2 p v (x,y)dxdy +C, (28) and used the symmetry in p v (x,y), with C being an arbitrary constant. The value of P(τ,τ 2 ) is obtained by a bilinear (quadratic) interpolation from its values on the pixel grid, which are given by P(i, ) = min(i,) k= p k,k+, (29) where = p i+ p i is the size of the grid. Note that the function p v (x,y) in (37) is non-zero only in diagonal blocks in the (x,y) space, where x and y belong to the same pixel. To summarize, the steps for a forward variance-type proection are: () Calculate the partial accumulations of the image (Eq. 29); (2) Bilinear interpolation; (3) Evaluation of Eq. (27). The backproection is obtained by performing the transposed operations in reverse order RESULTS USING CLINICAL DATASET Next we present some preliminary results. We note that optimization of the algorithm/software is still in progress. The latest images will be presented at the conference; they will also be available through the author s

7 Mean Overlap Kernel: Variance Overlap Kernel: d,+ = I i= pm i,i+ [p i,p i+ ) [d,d + ) (d + d ) (30) d,+ = I i= pv i,i+ [p i,p i+ ) [d,d + ) 2 (d + d ) 2 (3) Example (see Fig. ) d,2 = pm,2 (p 2 d )+p m 2,3 (d 2 p 2 ) d 2 d (32) Overlap Kernel can be written as d,+ = d+ p m (x)dx (34) (d + d ) d Example (see Fig. ) d,2 = pv,2(p 2 d ) 2 +p v 2,3(d 2 p 2 ) 2 (d 2 d ) 2. (33) Overlap Kernel can be written as d,+ = d+ d+ (d + d ) 2 p v (x,y)dxdy (36) d d where I ( ) p m x (pi+ +p i )/2 (x) = p i,i+ π p i= i+ p i (35) where p v (x,y) = I ( ) ( ) x (pi+ +p i )/2 y (pi+ +p i )/2 p i,i+ π π p i+ p i p i+ p i i= see definition of π(x) below (37) π(x) = for 0.5 x < 0.5, and zero otherwise Table. Definitions of the overlap kernels used in the distance-driven proections with mean and variance operations shown on the left and right, respectively. The kernel for mean-type operations has been introduced by Basu and DeMan. The kernel for variance-type operations is proposed here as a modification to their method. (37) personal webpage. 9 We used the HECTARE (Helical CT Advanced Reconstruction Engine) software package implemented in C++ by Daniel B. Keesing 0 and modified it to include the proposed VARD algorithm and the proposed variance-type branchless distance-driven operators. With approval from the Washington University Institutional Review Board (IRB), patient data was acquired on a Siemens Sensation 6 scanner at St. Louis Childrens Hospital using a standard abdominal imaging protocol with contrast agent. The Sensation 6 is a third-generation multi-detector-row computed tomography (CT) scanner and was operated in spiral scanning mode. The x-ray source orbits around the isocenter of the system every 0.5 seconds at a distance of 570 mm. The number of uniformly-spaced views per rotation is 60. The source is collimated to a width of.5 cm at the isocenter of the system. The detectors are arranged in 6 rows of 672 detectors, each on a cylindrical arc with radius 040 mm and centered at the source. Each detector subtends an arc of radians, so the entire fan subtends approximately 52. The center of the detector array was offset by /4 of a detector to improve sampling. The voltage and current of the x-ray tube were 20 kv and 50 mas, respectively. The patient bed traveled 24 mm per rotation of the gantry at a uniform speed. Figure 2 shows examples of reconstructed mean (left column) and variance (right column) images using VARD. Each column in Fig. 2 has three figures, showing the axial, coronal, and sagittal cuts through the center of the volume. The mean image was initialized using the FDK algorithm after negative values have been set to zero. The variance image was initialized to 0 2 cm 2 (the square of the average expected attenuation value) and the penalty weights (γ ) were initialized to 0 6 cm so that at the first mean update most of the weight is on the data-fit term. We used 29 ordered subsets; for each subset we updated the mean and variance images, followed by an update of the penalty weights before proceeding to the next subset. It can be seen that the highest values of the variance are obtained around boundaries of organs or bones, where the attenuation values change considerably, i.e., voxels with the highest neighborhood differences. This is mainly due to the learned prior variances γ (hyperparameters) which assign low/high values to low/high voxel differences, respectively.

8 Importantly, γ determines the neighborhood penalty weights locally (with a different weight for each voxel difference) and mitigates the need for tuning global parameters that control the balance between the data-fit term and the penalty. Another potential use of the variances could be image segmentation as can be seen from Fig. 2. Figure 3 shows the reconstruction using the FDK algorithm. By comparing Fig. 3 and Fig. 2 one can notice a slight loss of contrast in the mean images produced by VARD. A similar effect can occur using standard MAP reconstruction algorithms when the global tuning parameters are not chosen correctly. In fact, MAP reconstruction is quite sensitive to the choice of global tuning parameters and can result in considerable artifacts for some values of the tuning parameters. 7 In contrast, VARD does not require any manual tuning of global parameters so one can expect a certain trade-off between automation and quality. There is still room for improvement and we are currently studying different penalties/neighborhoods for VARD that might improve the quality of the mean images. We are also investigating cases where the data is undersampled, in which case FDK is known to produce aliasing artifacts. In addition, the variance images are a unique feature of the VARD algorithm and are interesting by themselves. Acknowledgments This work was supported by the Department of Homeland Security, Science and Technology Directorate, Explosives Division, through contract HSHQDC--C We thank Daniel B. Keesing for providing us the HECTARE software package. REFERENCES [] Neal, R. M., [Bayesian Learning for Neural Network], Springer-Verlag, New York (996). [2] Tipping, M. E., Sparse Bayesian learning and the relevance vector machine, J. Mach. Learn. Res., (200). [3] Basu, S. and De Man, B., Branchless distance-driven proection and backproection, In Proc. Electronic Imaging, SPIE 6065 (2006). [4] De Man, B. and Basu S., Distance-driven proection and backproection in three dimensions, in Phys. Med. Biol. 49, (2004). [5] Erdogan, H. and Fessler, J. A., Ordered subsets algorithms for transmission tomography, Phys. Med. Biol. 44(), (999). [6] Neal, R. M. and Hinton, G. E., A view of the EM algorithm that ustifies incremental, sparse, and other variants, [Learning in graphical models], Springer Netherlands, (998). [7] Kaganovsky, Y., Han, S., Degirmenci, S., Politte, D. G., Brady, D. J., O Sullivan, J. A., and Carin, L., Alternating minimization algorithm with automatic relevance determination for transmission tomography under Poisson noise, arxiv preprint, (204). [8] O Sullivan, J. A. and Benac, J., Alternating minimization algorithms for transmission tomography, IEEE Trans. Med. Imaging 26(3), (2000). [9] [0] Keesing, D. B., O Sullivan, J. A., Politte D. G. and Whiting, B. R., Parallelization of a fully 3D CT iterative reconstruction, In Biomedical Imaging: Nano to Macro, 3rd IEEE International Symposium on, (2006). [] Feldkamp, L. A., Davis, L. C. and Kress, J. W., Practical cone-beam algorithm, J. Opt. Soc. Am. A (6), (984).

9 x x x Figure 2. Cross sections through the reconstruction of pediatric patient data after 0 iterations with 29 ordered subsets (290 updates of all images). The mean image was initialized with FDK while setting negative values to zero. The axial, coronal, and sagittal views are shown from top to bottom. The left column shows the mean images, i.e., reconstruction of the linear attenuation coefficients; values from cm to 5cm (approximately bone) are shown in the range from black to white, respectively. The right column shows the variance images (Bayesian confidence intervals) with values in units of cm 2. The image volume is voxels, with voxel dimensions of mm by mm by 2 mm. We used a neighborhood penalty with 6 neighbors for each voxel (2 neighbors along each direction).

10 Figure 3. Reconstruction using the FDK algorithm. The cross sections are the same as in Fig. 2.

A Study of Sampling Strategies for Helical CT

A Study of Sampling Strategies for Helical CT Washington University in St. Louis Washington University Open Scholarship Engineering and Applied Science Theses & Dissertations Engineering and Applied Science Spring 5-15-2014 A Study of Sampling Strategies

More information

Improvement of Efficiency and Flexibility in Multi-slice Helical CT

Improvement of Efficiency and Flexibility in Multi-slice Helical CT J. Shanghai Jiaotong Univ. (Sci.), 2008, 13(4): 408 412 DOI: 10.1007/s12204-008-0408-x Improvement of Efficiency and Flexibility in Multi-slice Helical CT SUN Wen-wu 1 ( ), CHEN Si-ping 2 ( ), ZHUANG Tian-ge

More information

Axial block coordinate descent (ABCD) algorithm for X-ray CT image reconstruction

Axial block coordinate descent (ABCD) algorithm for X-ray CT image reconstruction Axial block coordinate descent (ABCD) algorithm for X-ray CT image reconstruction Jeffrey A. Fessler and Donghwan Kim EECS Department University of Michigan Fully 3D Image Reconstruction Conference July

More information

An approximate cone beam reconstruction algorithm for gantry-tilted CT

An approximate cone beam reconstruction algorithm for gantry-tilted CT An approximate cone beam reconstruction algorithm for gantry-tilted CT Ming Yan a, Cishen Zhang ab, Hongzhu Liang a a School of Electrical & Electronic Engineering, Nanyang Technological University, Singapore;

More information

A numerical simulator in VC++ on PC for iterative image reconstruction

A numerical simulator in VC++ on PC for iterative image reconstruction Journal of X-Ray Science and Technology 11 (2003) 61 70 61 IOS Press A numerical simulator in VC++ on PC for iterative image reconstruction Xiang Li a,, Ming Jiang c and Ge Wang a,b a Department of Biomedical

More information

Optimization of GPU-Accelerated Iterative CT Reconstruction Algorithm for Clinical Use

Optimization of GPU-Accelerated Iterative CT Reconstruction Algorithm for Clinical Use Washington University in St. Louis Washington University Open Scholarship Engineering and Applied Science Theses & Dissertations Engineering and Applied Science Spring 5-18-2018 Optimization of GPU-Accelerated

More information

A Weighted Least Squares PET Image Reconstruction Method Using Iterative Coordinate Descent Algorithms

A Weighted Least Squares PET Image Reconstruction Method Using Iterative Coordinate Descent Algorithms A Weighted Least Squares PET Image Reconstruction Method Using Iterative Coordinate Descent Algorithms Hongqing Zhu, Huazhong Shu, Jian Zhou and Limin Luo Department of Biological Science and Medical Engineering,

More information

Scaling Calibration in the ATRACT Algorithm

Scaling Calibration in the ATRACT Algorithm Scaling Calibration in the ATRACT Algorithm Yan Xia 1, Andreas Maier 1, Frank Dennerlein 2, Hannes G. Hofmann 1, Joachim Hornegger 1,3 1 Pattern Recognition Lab (LME), Friedrich-Alexander-University Erlangen-Nuremberg,

More information

Feldkamp-type image reconstruction from equiangular data

Feldkamp-type image reconstruction from equiangular data Journal of X-Ray Science and Technology 9 (2001) 113 120 113 IOS Press Feldkamp-type image reconstruction from equiangular data Ben Wang a, Hong Liu b, Shiying Zhao c and Ge Wang d a Department of Elec.

More information

Portability of TV-Regularized Reconstruction Parameters to Varying Data Sets

Portability of TV-Regularized Reconstruction Parameters to Varying Data Sets Portability of TV-Regularized Reconstruction Parameters to Varying Data Sets Mario Amrehn 1, Andreas Maier 1,2, Frank Dennerlein 1, Joachim Hornegger 1,2 1 Pattern Recognition Lab, FAU Erlangen-Nürnberg

More information

Multi-slice CT Image Reconstruction Jiang Hsieh, Ph.D.

Multi-slice CT Image Reconstruction Jiang Hsieh, Ph.D. Multi-slice CT Image Reconstruction Jiang Hsieh, Ph.D. Applied Science Laboratory, GE Healthcare Technologies 1 Image Generation Reconstruction of images from projections. textbook reconstruction advanced

More information

Arion: a realistic projection simulator for optimizing laboratory and industrial micro-ct

Arion: a realistic projection simulator for optimizing laboratory and industrial micro-ct Arion: a realistic projection simulator for optimizing laboratory and industrial micro-ct J. DHAENE* 1, E. PAUWELS 1, T. DE SCHRYVER 1, A. DE MUYNCK 1, M. DIERICK 1, L. VAN HOOREBEKE 1 1 UGCT Dept. Physics

More information

Iterative CT Reconstruction Using Curvelet-Based Regularization

Iterative CT Reconstruction Using Curvelet-Based Regularization Iterative CT Reconstruction Using Curvelet-Based Regularization Haibo Wu 1,2, Andreas Maier 1, Joachim Hornegger 1,2 1 Pattern Recognition Lab (LME), Department of Computer Science, 2 Graduate School in

More information

A GPU Implementation of Distance-Driven Computed Tomography

A GPU Implementation of Distance-Driven Computed Tomography University of Tennessee, Knoxville Trace: Tennessee Research and Creative Exchange Masters Theses Graduate School 8-2017 A GPU Implementation of Distance-Driven Computed Tomography Ryan D. Wagner University

More information

DEVELOPMENT OF CONE BEAM TOMOGRAPHIC RECONSTRUCTION SOFTWARE MODULE

DEVELOPMENT OF CONE BEAM TOMOGRAPHIC RECONSTRUCTION SOFTWARE MODULE Rajesh et al. : Proceedings of the National Seminar & Exhibition on Non-Destructive Evaluation DEVELOPMENT OF CONE BEAM TOMOGRAPHIC RECONSTRUCTION SOFTWARE MODULE Rajesh V Acharya, Umesh Kumar, Gursharan

More information

Splitting-Based Statistical X-Ray CT Image Reconstruction with Blind Gain Correction

Splitting-Based Statistical X-Ray CT Image Reconstruction with Blind Gain Correction Splitting-Based Statistical X-Ray CT Image Reconstruction with Blind Gain Correction Hung Nien and Jeffrey A. Fessler Department of Electrical Engineering and Computer Science University of Michigan, Ann

More information

Collaborative Sparsity and Compressive MRI

Collaborative Sparsity and Compressive MRI Modeling and Computation Seminar February 14, 2013 Table of Contents 1 T2 Estimation 2 Undersampling in MRI 3 Compressed Sensing 4 Model-Based Approach 5 From L1 to L0 6 Spatially Adaptive Sparsity MRI

More information

Convexization in Markov Chain Monte Carlo

Convexization in Markov Chain Monte Carlo in Markov Chain Monte Carlo 1 IBM T. J. Watson Yorktown Heights, NY 2 Department of Aerospace Engineering Technion, Israel August 23, 2011 Problem Statement MCMC processes in general are governed by non

More information

2D rendering takes a photo of the 2D scene with a virtual camera that selects an axis aligned rectangle from the scene. The photograph is placed into

2D rendering takes a photo of the 2D scene with a virtual camera that selects an axis aligned rectangle from the scene. The photograph is placed into 2D rendering takes a photo of the 2D scene with a virtual camera that selects an axis aligned rectangle from the scene. The photograph is placed into the viewport of the current application window. A pixel

More information

Reconstruction of CT Images from Sparse-View Polyenergetic Data Using Total Variation Minimization

Reconstruction of CT Images from Sparse-View Polyenergetic Data Using Total Variation Minimization 1 Reconstruction of CT Images from Sparse-View Polyenergetic Data Using Total Variation Minimization T. Humphries and A. Faridani Abstract Recent work in CT image reconstruction has seen increasing interest

More information

Comparison of Probing Error in Dimensional Measurement by Means of 3D Computed Tomography with Circular and Helical Sampling

Comparison of Probing Error in Dimensional Measurement by Means of 3D Computed Tomography with Circular and Helical Sampling nd International Symposium on NDT in Aerospace - We..A. Comparison of Probing Error in Dimensional Measurement by Means of D Computed Tomography with Circular and Helical Sampling Jochen HILLER, Stefan

More information

Estimating 3D Respiratory Motion from Orbiting Views

Estimating 3D Respiratory Motion from Orbiting Views Estimating 3D Respiratory Motion from Orbiting Views Rongping Zeng, Jeffrey A. Fessler, James M. Balter The University of Michigan Oct. 2005 Funding provided by NIH Grant P01 CA59827 Motivation Free-breathing

More information

Evaluation of Spectrum Mismatching using Spectrum Binning Approach for Statistical Polychromatic Reconstruction in CT

Evaluation of Spectrum Mismatching using Spectrum Binning Approach for Statistical Polychromatic Reconstruction in CT Evaluation of Spectrum Mismatching using Spectrum Binning Approach for Statistical Polychromatic Reconstruction in CT Qiao Yang 1,4, Meng Wu 2, Andreas Maier 1,3,4, Joachim Hornegger 1,3,4, Rebecca Fahrig

More information

Outline Introduction Problem Formulation Proposed Solution Applications Conclusion. Compressed Sensing. David L Donoho Presented by: Nitesh Shroff

Outline Introduction Problem Formulation Proposed Solution Applications Conclusion. Compressed Sensing. David L Donoho Presented by: Nitesh Shroff Compressed Sensing David L Donoho Presented by: Nitesh Shroff University of Maryland Outline 1 Introduction Compressed Sensing 2 Problem Formulation Sparse Signal Problem Statement 3 Proposed Solution

More information

Non-Stationary CT Image Noise Spectrum Analysis

Non-Stationary CT Image Noise Spectrum Analysis Non-Stationary CT Image Noise Spectrum Analysis Michael Balda, Björn J. Heismann,, Joachim Hornegger Pattern Recognition Lab, Friedrich-Alexander-Universität Erlangen Siemens Healthcare, Erlangen michael.balda@informatik.uni-erlangen.de

More information

Statistical iterative reconstruction using fast optimization transfer algorithm with successively increasing factor in Digital Breast Tomosynthesis

Statistical iterative reconstruction using fast optimization transfer algorithm with successively increasing factor in Digital Breast Tomosynthesis Statistical iterative reconstruction using fast optimization transfer algorithm with successively increasing factor in Digital Breast omosynthesis Shiyu Xu a and Zhenxi Zhang b and Ying Chen a,* a Department

More information

A Fast GPU-Based Approach to Branchless Distance-Driven Projection and Back-Projection in Cone Beam CT

A Fast GPU-Based Approach to Branchless Distance-Driven Projection and Back-Projection in Cone Beam CT A Fast GPU-Based Approach to Branchless Distance-Driven Projection and Back-Projection in Cone Beam CT Daniel Schlifske ab and Henry Medeiros a a Marquette University, 1250 W Wisconsin Ave, Milwaukee,

More information

GPU acceleration of 3D forward and backward projection using separable footprints for X-ray CT image reconstruction

GPU acceleration of 3D forward and backward projection using separable footprints for X-ray CT image reconstruction GPU acceleration of 3D forward and backward projection using separable footprints for X-ray CT image reconstruction Meng Wu and Jeffrey A. Fessler EECS Department University of Michigan Fully 3D Image

More information

Generative and discriminative classification techniques

Generative and discriminative classification techniques Generative and discriminative classification techniques Machine Learning and Category Representation 013-014 Jakob Verbeek, December 13+0, 013 Course website: http://lear.inrialpes.fr/~verbeek/mlcr.13.14

More information

Convolution-Based Truncation Correction for C-Arm CT using Scattered Radiation

Convolution-Based Truncation Correction for C-Arm CT using Scattered Radiation Convolution-Based Truncation Correction for C-Arm CT using Scattered Radiation Bastian Bier 1, Chris Schwemmer 1,2, Andreas Maier 1,3, Hannes G. Hofmann 1, Yan Xia 1, Joachim Hornegger 1,2, Tobias Struffert

More information

Computer-Tomography II: Image reconstruction and applications

Computer-Tomography II: Image reconstruction and applications Computer-Tomography II: Image reconstruction and applications Prof. Dr. U. Oelfke DKFZ Heidelberg Department of Medical Physics (E040) Im Neuenheimer Feld 280 69120 Heidelberg, Germany u.oelfke@dkfz.de

More information

ML reconstruction for CT

ML reconstruction for CT ML reconstruction for CT derivation of MLTR rigid motion correction resolution modeling polychromatic ML model dual energy ML model Bruno De Man, Katrien Van Slambrouck, Maarten Depypere, Frederik Maes,

More information

Low-Dose Dual-Energy CT for PET Attenuation Correction with Statistical Sinogram Restoration

Low-Dose Dual-Energy CT for PET Attenuation Correction with Statistical Sinogram Restoration Low-Dose Dual-Energy CT for PET Attenuation Correction with Statistical Sinogram Restoration Joonki Noh, Jeffrey A. Fessler EECS Department, The University of Michigan Paul E. Kinahan Radiology Department,

More information

Corso di laurea in Fisica A.A Fisica Medica 4 TC

Corso di laurea in Fisica A.A Fisica Medica 4 TC Corso di laurea in Fisica A.A. 2007-2008 Fisica Medica 4 TC Computed Tomography Principles 1. Projection measurement 2. Scanner systems 3. Scanning modes Basic Tomographic Principle The internal structure

More information

Simplified statistical image reconstruction algorithm for polyenergetic X-ray CT. y i Poisson I i (E)e R } where, b i

Simplified statistical image reconstruction algorithm for polyenergetic X-ray CT. y i Poisson I i (E)e R } where, b i implified statistical image reconstruction algorithm for polyenergetic X-ray C omesh rivastava, tudent member, IEEE, and Jeffrey A. Fessler, enior member, IEEE Abstract In X-ray computed tomography (C),

More information

Joint System and Algorithm Design for Computationally Efficient Fan Beam Coded Aperture X-ray Coherent Scatter Imaging

Joint System and Algorithm Design for Computationally Efficient Fan Beam Coded Aperture X-ray Coherent Scatter Imaging 1 Joint System and Algorithm Design for Computationally Efficient Fan Beam Coded Aperture X-ray Coherent Scatter Imaging Ikenna Odinaka, Joseph A. O Sullivan, David G. Politte, Kenneth P. MacCabe, Yan

More information

A Projection Access Scheme for Iterative Reconstruction Based on the Golden Section

A Projection Access Scheme for Iterative Reconstruction Based on the Golden Section A Projection Access Scheme for Iterative Reconstruction Based on the Golden Section Thomas Köhler Philips Research Laboratories Roentgenstrasse - Hamburg Germany Abstract A new access scheme for projections

More information

An Automated Image-based Method for Multi-Leaf Collimator Positioning Verification in Intensity Modulated Radiation Therapy

An Automated Image-based Method for Multi-Leaf Collimator Positioning Verification in Intensity Modulated Radiation Therapy An Automated Image-based Method for Multi-Leaf Collimator Positioning Verification in Intensity Modulated Radiation Therapy Chenyang Xu 1, Siemens Corporate Research, Inc., Princeton, NJ, USA Xiaolei Huang,

More information

Penalized-Likelihood Reconstruction for Sparse Data Acquisitions with Unregistered Prior Images and Compressed Sensing Penalties

Penalized-Likelihood Reconstruction for Sparse Data Acquisitions with Unregistered Prior Images and Compressed Sensing Penalties Penalized-Likelihood Reconstruction for Sparse Data Acquisitions with Unregistered Prior Images and Compressed Sensing Penalties J. W. Stayman* a, W. Zbijewski a, Y. Otake b, A. Uneri b, S. Schafer a,

More information

Introduction to Medical Imaging. Cone-Beam CT. Klaus Mueller. Computer Science Department Stony Brook University

Introduction to Medical Imaging. Cone-Beam CT. Klaus Mueller. Computer Science Department Stony Brook University Introduction to Medical Imaging Cone-Beam CT Klaus Mueller Computer Science Department Stony Brook University Introduction Available cone-beam reconstruction methods: exact approximate algebraic Our discussion:

More information

Unmatched Projector/Backprojector Pairs in an Iterative Reconstruction Algorithm

Unmatched Projector/Backprojector Pairs in an Iterative Reconstruction Algorithm 548 IEEE TRANSACTIONS ON MEDICAL IMAGING, VOL. 19, NO. 5, MAY 2000 Unmatched Projector/Backprojector Pairs in an Iterative Reconstruction Algorithm Gengsheng L. Zeng*, Member, IEEE, and Grant T. Gullberg,

More information

Limited View Angle Iterative CT Reconstruction

Limited View Angle Iterative CT Reconstruction Limited View Angle Iterative CT Reconstruction Sherman J. Kisner 1, Eri Haneda 1, Charles A. Bouman 1, Sondre Skatter 2, Mikhail Kourinny 2, Simon Bedford 3 1 Purdue University, West Lafayette, IN, USA

More information

FMA901F: Machine Learning Lecture 3: Linear Models for Regression. Cristian Sminchisescu

FMA901F: Machine Learning Lecture 3: Linear Models for Regression. Cristian Sminchisescu FMA901F: Machine Learning Lecture 3: Linear Models for Regression Cristian Sminchisescu Machine Learning: Frequentist vs. Bayesian In the frequentist setting, we seek a fixed parameter (vector), with value(s)

More information

08 An Introduction to Dense Continuous Robotic Mapping

08 An Introduction to Dense Continuous Robotic Mapping NAVARCH/EECS 568, ROB 530 - Winter 2018 08 An Introduction to Dense Continuous Robotic Mapping Maani Ghaffari March 14, 2018 Previously: Occupancy Grid Maps Pose SLAM graph and its associated dense occupancy

More information

Medical Image Processing: Image Reconstruction and 3D Renderings

Medical Image Processing: Image Reconstruction and 3D Renderings Medical Image Processing: Image Reconstruction and 3D Renderings 김보형 서울대학교컴퓨터공학부 Computer Graphics and Image Processing Lab. 2011. 3. 23 1 Computer Graphics & Image Processing Computer Graphics : Create,

More information

Advanced Image Reconstruction Methods for Photoacoustic Tomography

Advanced Image Reconstruction Methods for Photoacoustic Tomography Advanced Image Reconstruction Methods for Photoacoustic Tomography Mark A. Anastasio, Kun Wang, and Robert Schoonover Department of Biomedical Engineering Washington University in St. Louis 1 Outline Photoacoustic/thermoacoustic

More information

An overview of fast convergent ordered-subsets reconstruction methods for emission tomography based on the incremental EM algorithm

An overview of fast convergent ordered-subsets reconstruction methods for emission tomography based on the incremental EM algorithm An overview of fast convergent ordered-subsets reconstruction methods for emission tomography based on the incremental EM algorithm Ing-Tsung Hsiao a Parmeshwar Khurd b Anand Rangaraan c and Gene Gindi

More information

Estimation of Missing Fan-Beam Projections using Frequency Consistency Conditions

Estimation of Missing Fan-Beam Projections using Frequency Consistency Conditions Estimation of Missing Fan-Beam Projections using Frequency Consistency Conditions Marcel Pohlmann, Martin Berger, Andreas Maier, Joachim Hornegger and Rebecca Fahrig Abstract Reducing radiation dose is

More information

FAST KVP-SWITCHING DUAL ENERGY CT FOR PET ATTENUATION CORRECTION

FAST KVP-SWITCHING DUAL ENERGY CT FOR PET ATTENUATION CORRECTION 2009 IEEE Nuclear Science Symposium Conference Record M03-7 FAST KVP-SWITCHING DUAL ENERGY CT FOR PET ATTENUATION CORRECTION Wonseok Huh, Jeffrey A. Fessler, Adam M. Alessio, and Paul E. Kinahan Department

More information

TESTING OF THE CIRCLE AND LINE ALGORITHM IN THE SETTING OF MICRO-CT

TESTING OF THE CIRCLE AND LINE ALGORITHM IN THE SETTING OF MICRO-CT SCA2016-080 1/7 TESTING OF THE CIRCLE AND LINE ALGORITHM IN THE SETTING OF MICRO-CT Alexander Katsevich 1, 2 and Michael Frenkel 1 1 itomography Corp., 2 University of Central Florida (UCF) This paper

More information

Probabilistic Graphical Models

Probabilistic Graphical Models Overview of Part Two Probabilistic Graphical Models Part Two: Inference and Learning Christopher M. Bishop Exact inference and the junction tree MCMC Variational methods and EM Example General variational

More information

Generative and discriminative classification techniques

Generative and discriminative classification techniques Generative and discriminative classification techniques Machine Learning and Category Representation 2014-2015 Jakob Verbeek, November 28, 2014 Course website: http://lear.inrialpes.fr/~verbeek/mlcr.14.15

More information

Spiral ASSR Std p = 1.0. Spiral EPBP Std. 256 slices (0/300) Kachelrieß et al., Med. Phys. 31(6): , 2004

Spiral ASSR Std p = 1.0. Spiral EPBP Std. 256 slices (0/300) Kachelrieß et al., Med. Phys. 31(6): , 2004 Spiral ASSR Std p = 1.0 Spiral EPBP Std p = 1.0 Kachelrieß et al., Med. Phys. 31(6): 1623-1641, 2004 256 slices (0/300) Advantages of Cone-Beam Spiral CT Image quality nearly independent of pitch Increase

More information

CS 229 Midterm Review

CS 229 Midterm Review CS 229 Midterm Review Course Staff Fall 2018 11/2/2018 Outline Today: SVMs Kernels Tree Ensembles EM Algorithm / Mixture Models [ Focus on building intuition, less so on solving specific problems. Ask

More information

Algebraic Iterative Methods for Computed Tomography

Algebraic Iterative Methods for Computed Tomography Algebraic Iterative Methods for Computed Tomography Per Christian Hansen DTU Compute Department of Applied Mathematics and Computer Science Technical University of Denmark Per Christian Hansen Algebraic

More information

DUE to beam polychromacity in CT and the energy dependence

DUE to beam polychromacity in CT and the energy dependence 1 Empirical Water Precorrection for Cone-Beam Computed Tomography Katia Sourbelle, Marc Kachelrieß, Member, IEEE, and Willi A. Kalender Abstract We propose an algorithm to correct for the cupping artifact

More information

Semantic Segmentation. Zhongang Qi

Semantic Segmentation. Zhongang Qi Semantic Segmentation Zhongang Qi qiz@oregonstate.edu Semantic Segmentation "Two men riding on a bike in front of a building on the road. And there is a car." Idea: recognizing, understanding what's in

More information

Discrete Estimation of Data Completeness for 3D Scan Trajectories with Detector Offset

Discrete Estimation of Data Completeness for 3D Scan Trajectories with Detector Offset Discrete Estimation of Data Completeness for 3D Scan Trajectories with Detector Offset Andreas Maier 1, Patrick Kugler 2, Günter Lauritsch 2, Joachim Hornegger 1 1 Pattern Recognition Lab and SAOT Erlangen,

More information

Problem Set 4. Assigned: March 23, 2006 Due: April 17, (6.882) Belief Propagation for Segmentation

Problem Set 4. Assigned: March 23, 2006 Due: April 17, (6.882) Belief Propagation for Segmentation 6.098/6.882 Computational Photography 1 Problem Set 4 Assigned: March 23, 2006 Due: April 17, 2006 Problem 1 (6.882) Belief Propagation for Segmentation In this problem you will set-up a Markov Random

More information

Spatial Resolution Properties in Penalized-Likelihood Reconstruction of Blurred Tomographic Data

Spatial Resolution Properties in Penalized-Likelihood Reconstruction of Blurred Tomographic Data Spatial Resolution Properties in Penalized-Likelihood Reconstruction of Blurred Tomographic Data Wenying Wang, Grace J. Gang and J. Webster Stayman Department of Biomedical Engineering, Johns Hopkins University,

More information

Optimization of CT Simulation Imaging. Ingrid Reiser Dept. of Radiology The University of Chicago

Optimization of CT Simulation Imaging. Ingrid Reiser Dept. of Radiology The University of Chicago Optimization of CT Simulation Imaging Ingrid Reiser Dept. of Radiology The University of Chicago Optimization of CT imaging Goal: Achieve image quality that allows to perform the task at hand (diagnostic

More information

A practical software platform of integrated reconstruction algorithms and forward algorithms for 2D industrial CT

A practical software platform of integrated reconstruction algorithms and forward algorithms for 2D industrial CT Journal of X-Ray Science and Technology 13 (2005) 9 21 9 IOS Press A practical software platform of integrated reconstruction algorithms and forward algorithms for 2D industrial CT Hui Li a, Zhaotian Zhang

More information

An Iterative Approach to the Beam Hardening Correction in Cone Beam CT (Proceedings)

An Iterative Approach to the Beam Hardening Correction in Cone Beam CT (Proceedings) Marquette University e-publications@marquette Biomedical Engineering Faculty Research and Publications Engineering, College of 1-1-1999 An Iterative Approach to the Beam Hardening Correction in Cone Beam

More information

Respiratory Motion Compensation for Simultaneous PET/MR Based on Strongly Undersampled Radial MR Data

Respiratory Motion Compensation for Simultaneous PET/MR Based on Strongly Undersampled Radial MR Data Respiratory Motion Compensation for Simultaneous PET/MR Based on Strongly Undersampled Radial MR Data Christopher M Rank 1, Thorsten Heußer 1, Andreas Wetscherek 1, and Marc Kachelrieß 1 1 German Cancer

More information

CIS 520, Machine Learning, Fall 2015: Assignment 7 Due: Mon, Nov 16, :59pm, PDF to Canvas [100 points]

CIS 520, Machine Learning, Fall 2015: Assignment 7 Due: Mon, Nov 16, :59pm, PDF to Canvas [100 points] CIS 520, Machine Learning, Fall 2015: Assignment 7 Due: Mon, Nov 16, 2015. 11:59pm, PDF to Canvas [100 points] Instructions. Please write up your responses to the following problems clearly and concisely.

More information

PSU Student Research Symposium 2017 Bayesian Optimization for Refining Object Proposals, with an Application to Pedestrian Detection Anthony D.

PSU Student Research Symposium 2017 Bayesian Optimization for Refining Object Proposals, with an Application to Pedestrian Detection Anthony D. PSU Student Research Symposium 2017 Bayesian Optimization for Refining Object Proposals, with an Application to Pedestrian Detection Anthony D. Rhodes 5/10/17 What is Machine Learning? Machine learning

More information

Level-set MCMC Curve Sampling and Geometric Conditional Simulation

Level-set MCMC Curve Sampling and Geometric Conditional Simulation Level-set MCMC Curve Sampling and Geometric Conditional Simulation Ayres Fan John W. Fisher III Alan S. Willsky February 16, 2007 Outline 1. Overview 2. Curve evolution 3. Markov chain Monte Carlo 4. Curve

More information

Accelerating CT Iterative Reconstruction Using ADMM and Nesterov s Methods

Accelerating CT Iterative Reconstruction Using ADMM and Nesterov s Methods Accelerating CT Iterative Reconstruction Using ADMM and Nesterov s Methods Jingyuan Chen Meng Wu Yuan Yao June 4, 2014 1 Introduction 1.1 CT Reconstruction X-ray Computed Tomography (CT) is a conventional

More information

G Practical Magnetic Resonance Imaging II Sackler Institute of Biomedical Sciences New York University School of Medicine. Compressed Sensing

G Practical Magnetic Resonance Imaging II Sackler Institute of Biomedical Sciences New York University School of Medicine. Compressed Sensing G16.4428 Practical Magnetic Resonance Imaging II Sackler Institute of Biomedical Sciences New York University School of Medicine Compressed Sensing Ricardo Otazo, PhD ricardo.otazo@nyumc.org Compressed

More information

A Novel Two-step Method for CT Reconstruction

A Novel Two-step Method for CT Reconstruction A Novel Two-step Method for CT Reconstruction Michael Felsberg Computer Vision Laboratory, Dept. EE, Linköping University, Sweden mfe@isy.liu.se Abstract. In this paper we address the parallel beam 2D

More information

Compressed Sensing Reconstructions for Dynamic Contrast Enhanced MRI

Compressed Sensing Reconstructions for Dynamic Contrast Enhanced MRI 1 Compressed Sensing Reconstructions for Dynamic Contrast Enhanced MRI Kevin T. Looby klooby@stanford.edu ABSTRACT The temporal resolution necessary for dynamic contrast enhanced (DCE) magnetic resonance

More information

Optimal Separating Hyperplane and the Support Vector Machine. Volker Tresp Summer 2018

Optimal Separating Hyperplane and the Support Vector Machine. Volker Tresp Summer 2018 Optimal Separating Hyperplane and the Support Vector Machine Volker Tresp Summer 2018 1 (Vapnik s) Optimal Separating Hyperplane Let s consider a linear classifier with y i { 1, 1} If classes are linearly

More information

Learning Splines for Sparse Tomographic Reconstruction. Elham Sakhaee and Alireza Entezari University of Florida

Learning Splines for Sparse Tomographic Reconstruction. Elham Sakhaee and Alireza Entezari University of Florida Learning Splines for Sparse Tomographic Reconstruction Elham Sakhaee and Alireza Entezari University of Florida esakhaee@cise.ufl.edu 2 Tomographic Reconstruction Recover the image given X-ray measurements

More information

CHAPTER 9 INPAINTING USING SPARSE REPRESENTATION AND INVERSE DCT

CHAPTER 9 INPAINTING USING SPARSE REPRESENTATION AND INVERSE DCT CHAPTER 9 INPAINTING USING SPARSE REPRESENTATION AND INVERSE DCT 9.1 Introduction In the previous chapters the inpainting was considered as an iterative algorithm. PDE based method uses iterations to converge

More information

F3-A5: Toward Model-Based Reconstruction in Scanned Baggage Security Applications

F3-A5: Toward Model-Based Reconstruction in Scanned Baggage Security Applications F3-A5: Toward Model-Based Reconstruction in Scanned Baggage Security Applications Abstract While traditional direct reconstruction algorithms such as filtered back projection depend on the analytic inversion

More information

MAXIMUM a posteriori (MAP) or penalized ML image

MAXIMUM a posteriori (MAP) or penalized ML image 42 IEEE TRANSACTIONS ON MEDICAL IMAGING, VOL. 25, NO. 1, JANUARY 2006 Mean and Covariance Properties of Dynamic PET Reconstructions From List-Mode Data Evren Asma and Richard M. Leahy* Abstract We derive

More information

Radiology. Marta Anguiano Millán. Departamento de Física Atómica, Molecular y Nuclear Facultad de Ciencias. Universidad de Granada

Radiology. Marta Anguiano Millán. Departamento de Física Atómica, Molecular y Nuclear Facultad de Ciencias. Universidad de Granada Departamento de Física Atómica, Molecular y Nuclear Facultad de Ciencias. Universidad de Granada Overview Introduction Overview Introduction Tecniques of imaging in Overview Introduction Tecniques of imaging

More information

Adaptive Reconstruction Methods for Low-Dose Computed Tomography

Adaptive Reconstruction Methods for Low-Dose Computed Tomography Adaptive Reconstruction Methods for Low-Dose Computed Tomography Joseph Shtok Ph.D. supervisors: Prof. Michael Elad, Dr. Michael Zibulevsky. Technion IIT, Israel, 011 Ph.D. Talk, Apr. 01 Contents of this

More information

I How does the formulation (5) serve the purpose of the composite parameterization

I How does the formulation (5) serve the purpose of the composite parameterization Supplemental Material to Identifying Alzheimer s Disease-Related Brain Regions from Multi-Modality Neuroimaging Data using Sparse Composite Linear Discrimination Analysis I How does the formulation (5)

More information

Generalized Filtered Backprojection for Digital Breast Tomosynthesis Reconstruction

Generalized Filtered Backprojection for Digital Breast Tomosynthesis Reconstruction Generalized Filtered Backprojection for Digital Breast Tomosynthesis Reconstruction Klaus Erhard a, Michael Grass a, Sebastian Hitziger b, Armin Iske b and Tim Nielsen a a Philips Research Europe Hamburg,

More information

RESTORING ARTIFACT-FREE MICROSCOPY IMAGE SEQUENCES. Robotics Institute Carnegie Mellon University 5000 Forbes Ave, Pittsburgh, PA 15213, USA

RESTORING ARTIFACT-FREE MICROSCOPY IMAGE SEQUENCES. Robotics Institute Carnegie Mellon University 5000 Forbes Ave, Pittsburgh, PA 15213, USA RESTORING ARTIFACT-FREE MICROSCOPY IMAGE SEQUENCES Zhaozheng Yin Takeo Kanade Robotics Institute Carnegie Mellon University 5000 Forbes Ave, Pittsburgh, PA 15213, USA ABSTRACT Phase contrast and differential

More information

Total Variation Denoising with Overlapping Group Sparsity

Total Variation Denoising with Overlapping Group Sparsity 1 Total Variation Denoising with Overlapping Group Sparsity Ivan W. Selesnick and Po-Yu Chen Polytechnic Institute of New York University Brooklyn, New York selesi@poly.edu 2 Abstract This paper describes

More information

Locally Weighted Least Squares Regression for Image Denoising, Reconstruction and Up-sampling

Locally Weighted Least Squares Regression for Image Denoising, Reconstruction and Up-sampling Locally Weighted Least Squares Regression for Image Denoising, Reconstruction and Up-sampling Moritz Baecher May 15, 29 1 Introduction Edge-preserving smoothing and super-resolution are classic and important

More information

Image Acquisition Systems

Image Acquisition Systems Image Acquisition Systems Goals and Terminology Conventional Radiography Axial Tomography Computer Axial Tomography (CAT) Magnetic Resonance Imaging (MRI) PET, SPECT Ultrasound Microscopy Imaging ITCS

More information

Homework #4 Programming Assignment Due: 11:59 pm, November 4, 2018

Homework #4 Programming Assignment Due: 11:59 pm, November 4, 2018 CSCI 567, Fall 18 Haipeng Luo Homework #4 Programming Assignment Due: 11:59 pm, ovember 4, 2018 General instructions Your repository will have now a directory P4/. Please do not change the name of this

More information

Digital Image Processing Laboratory: MAP Image Restoration

Digital Image Processing Laboratory: MAP Image Restoration Purdue University: Digital Image Processing Laboratories 1 Digital Image Processing Laboratory: MAP Image Restoration October, 015 1 Introduction This laboratory explores the use of maximum a posteriori

More information

Accelerated C-arm Reconstruction by Out-of-Projection Prediction

Accelerated C-arm Reconstruction by Out-of-Projection Prediction Accelerated C-arm Reconstruction by Out-of-Projection Prediction Hannes G. Hofmann, Benjamin Keck, Joachim Hornegger Pattern Recognition Lab, University Erlangen-Nuremberg hannes.hofmann@informatik.uni-erlangen.de

More information

2D Fan Beam Reconstruction 3D Cone Beam Reconstruction

2D Fan Beam Reconstruction 3D Cone Beam Reconstruction 2D Fan Beam Reconstruction 3D Cone Beam Reconstruction Mario Koerner March 17, 2006 1 2D Fan Beam Reconstruction Two-dimensional objects can be reconstructed from projections that were acquired using parallel

More information

PET Image Reconstruction using Anatomical Information through Mutual Information Based Priors

PET Image Reconstruction using Anatomical Information through Mutual Information Based Priors 2005 IEEE Nuclear Science Symposium Conference Record M11-354 PET Image Reconstruction using Anatomical Information through Mutual Information Based Priors Sangeetha Somayajula, Evren Asma, and Richard

More information

arxiv: v2 [stat.ml] 5 Nov 2018

arxiv: v2 [stat.ml] 5 Nov 2018 Kernel Distillation for Fast Gaussian Processes Prediction arxiv:1801.10273v2 [stat.ml] 5 Nov 2018 Congzheng Song Cornell Tech cs2296@cornell.edu Abstract Yiming Sun Cornell University ys784@cornell.edu

More information

Probabilistic Facial Feature Extraction Using Joint Distribution of Location and Texture Information

Probabilistic Facial Feature Extraction Using Joint Distribution of Location and Texture Information Probabilistic Facial Feature Extraction Using Joint Distribution of Location and Texture Information Mustafa Berkay Yilmaz, Hakan Erdogan, Mustafa Unel Sabanci University, Faculty of Engineering and Natural

More information

GPU-based Fast Cone Beam CT Reconstruction from Undersampled and Noisy Projection Data via Total Variation

GPU-based Fast Cone Beam CT Reconstruction from Undersampled and Noisy Projection Data via Total Variation GPU-based Fast Cone Beam CT Reconstruction from Undersampled and Noisy Projection Data via Total Variation 5 10 15 20 25 30 35 Xun Jia Department of Radiation Oncology, University of California San Diego,

More information

Object Recognition Using Pictorial Structures. Daniel Huttenlocher Computer Science Department. In This Talk. Object recognition in computer vision

Object Recognition Using Pictorial Structures. Daniel Huttenlocher Computer Science Department. In This Talk. Object recognition in computer vision Object Recognition Using Pictorial Structures Daniel Huttenlocher Computer Science Department Joint work with Pedro Felzenszwalb, MIT AI Lab In This Talk Object recognition in computer vision Brief definition

More information

IMAGE RESTORATION VIA EFFICIENT GAUSSIAN MIXTURE MODEL LEARNING

IMAGE RESTORATION VIA EFFICIENT GAUSSIAN MIXTURE MODEL LEARNING IMAGE RESTORATION VIA EFFICIENT GAUSSIAN MIXTURE MODEL LEARNING Jianzhou Feng Li Song Xiaog Huo Xiaokang Yang Wenjun Zhang Shanghai Digital Media Processing Transmission Key Lab, Shanghai Jiaotong University

More information

Classification. 1 o Semestre 2007/2008

Classification. 1 o Semestre 2007/2008 Classification Departamento de Engenharia Informática Instituto Superior Técnico 1 o Semestre 2007/2008 Slides baseados nos slides oficiais do livro Mining the Web c Soumen Chakrabarti. Outline 1 2 3 Single-Class

More information

Incorporation of Prior Knowledge for Region of Change Imaging from Sparse Scan Data in Image-Guided Surgery

Incorporation of Prior Knowledge for Region of Change Imaging from Sparse Scan Data in Image-Guided Surgery Incorporation of Prior Knowledge for Region of Change Imaging from Sparse Scan Data in Image-Guided Surgery J. Lee a, J. W. Stayman b, Y. Otake c, S. Schafer b, W. Zbijewski b, A. J. Khanna b,d, J. L.

More information

Superiorized polyenergetic reconstruction algorithm for reduction of metal artifacts in CT images

Superiorized polyenergetic reconstruction algorithm for reduction of metal artifacts in CT images 1 Superiorized polyenergetic reconstruction algorithm for reduction of metal artifacts in CT images T. Humphries 1 and A. Gibali 2 Abstract Artifacts caused by metal objects such as dental fillings, hip

More information

A Topography-Preserving Latent Variable Model with Learning Metrics

A Topography-Preserving Latent Variable Model with Learning Metrics A Topography-Preserving Latent Variable Model with Learning Metrics Samuel Kaski and Janne Sinkkonen Helsinki University of Technology Neural Networks Research Centre P.O. Box 5400, FIN-02015 HUT, Finland

More information

ADAPTIVE GRAPH CUTS WITH TISSUE PRIORS FOR BRAIN MRI SEGMENTATION

ADAPTIVE GRAPH CUTS WITH TISSUE PRIORS FOR BRAIN MRI SEGMENTATION ADAPTIVE GRAPH CUTS WITH TISSUE PRIORS FOR BRAIN MRI SEGMENTATION Abstract: MIP Project Report Spring 2013 Gaurav Mittal 201232644 This is a detailed report about the course project, which was to implement

More information

Markov Network Structure Learning

Markov Network Structure Learning Markov Network Structure Learning Sargur Srihari srihari@cedar.buffalo.edu 1 Topics Structure Learning as model selection Structure Learning using Independence Tests Score based Learning: Hypothesis Spaces

More information