11
1 Super Resolution Image Reconstruction Through Bregman Iteration using Morphologic Regularization Pulak Purkait and Bhabatosh Chanda Abstract—Multiscale morphological operators are studied ex- tensively in the literature for image processing and feature extrac- tion purpose. In this paper we model a non-linear regularization method based on multiscale morphology for edge-preserving super resolution (SR) image reconstruction. We formulate SR image reconstruction problem as a de-blurring problem and then solve the inverse problem using Bregman iterations. The proposed algorithm can suppress inherent noise generated during low-resolution (LR) image formation as well as during SR image estimation efficiently. Experimental results show the effectiveness of the proposed regularization and reconstruction method for SR image. Index Terms—Morphologic regularization, Bregman iteration, operator splitting, de-blurring, subgradients. I. I NTRODUCTION It is always desirable to generate a high resolution (HR) image as it shows more intricate details. However, available sensors have limitation in respect to maximum resolution. Thus our basic goal is to develop an algorithm to enhance the spatial resolution of images captured by an image sensor with fixed resolution. This process is called the Super Resolution (SR) method and remains an active research topic for the last two decades. A number of fundamental assumptions are made about image formation and quality which in turn lead to different SR algorithms. These assumptions include the type of motion, the type of blurring and also the type of noise. It is also to be decided whether to produce the very best HR image possible or an acceptable HR image as quickly as possible. Moreover SR algorithms may vary depending on whether only single LR image is available (single frame SR) or multiple LR images are available (multi-frame SR). Also SR image reconstruction algorithms work either in (a) Frequency domain or in (b) Spatial domain. In this work we focus only on spatial domain approach for multi-frame SR image reconstruction. Among spatial domain multi-frame SR image reconstruction algorithms, representative works include non-uniform inter- polation based approaches [1], [2]. The advantage of these approaches is that their computational cost is relatively low P. Purkait and B. Chanda are with the Electronics and Communication Sciences Unit, Indian Statistical Institute, Kolkata, India, email: (pulak r, chanda)@isical.ac.in Copyright (c) 2012 IEEE. Personal use of this material is permitted. However, permission to use this material for any other purposes must be obtained from the IEEE by sending a request to [email protected]. Manuscript received on August 10, 2011. Revised on May 7, 2012. Accepted on March 8, 2012. which makes them suitable for real-time applications. How- ever, they do not consider the blur model or noise characteris- tics, hence quality of the reconstructed HR image is not good. Projections on a convex set (POCS) based methods [3], [4] utilize the spatial domain observation model and incorporate some prior information. Though these methods are simple, their disadvantages are non-uniqueness of solutions, slow convergence rate and heavy computational cost. Iterative back projection based approaches [5] conduct SR reconstruction in a straightforward way. However, they have no unique solution due to the ill-posed nature of the inverse problem and some parameters are difficult to choose. On the other hand, Bayesian maximum a posteriori (MAP) estimation based methods [6], [7], [8] explicitly use prior information in the form of a prior probability density on HR image and provide a rigorous theoretical framework. In [8], a MAP based joint formulation is proposed that judiciously combine motion estimation, segmentation and SR together. Another class of SR reconstruction methods generate HR image from a single LR image or frame. These methods are called “Example-Based Super-Resolution” [9], [10], [11], [12] or “image hallucination” [13]. These algorithms are in general based on natural image edge prior [14], [10] or gradient profile prior [15]. Glasner et al. [11] merge the concepts of both single frame SR and multi-frame SR for HR image reconstruction from single frame. In recent years SR image reconstruction algorithms with sparse image prior [12], [13], [16] have been receiving more attention due to advancement of Sparse Coding techniques. Those algorithms are based on dual Dictionary Learning techniques on the pairs of LR and HR image patches. The approach reported in the present paper is based on the regularization framework, where HR image is estimated based on some prior knowledge about the image (e.g., degree of smoothness) in the form of regularization. The proba- bility based MAP approach, stated earlier is equivalent to the concept of regularization, only in this case it gives a probabilistic meaning to the regularization expression [17]. Tikhonov regularization [18] based on bounded variation (BV) (L 2 norm) is one of the popular regularization methods for SR reconstruction. It imposes smoothness in reconstructed image, but at the same time loses some details (e.g., edges) present in the image. First successful edge preserving regularization method for de-noising and de-blurring is total variance (TV) (L 1 norm) method [19]. Another interesting algorithm, pro- posed by Farsiu et al. [20], employs bilateral total variation (BTV) regularization. To achieve further improvement, Li et

Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

Embed Size (px)

Citation preview

Page 1: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

1

Super Resolution Image Reconstruction ThroughBregman Iteration using Morphologic

RegularizationPulak Purkait and Bhabatosh Chanda

Abstract—Multiscale morphological operators are studied ex-tensively in the literature for image processing and feature extrac-tion purpose. In this paper we model a non-linear regularizationmethod based on multiscale morphology for edge-preservingsuper resolution (SR) image reconstruction. We formulate SRimage reconstruction problem as a de-blurring problem andthen solve the inverse problem using Bregman iterations. Theproposed algorithm can suppress inherent noise generated duringlow-resolution (LR) image formation as well as during SR imageestimation efficiently. Experimental results show the effectivenessof the proposed regularization and reconstruction method for SRimage.

Index Terms—Morphologic regularization, Bregman iteration,operator splitting, de-blurring, subgradients.

I. INTRODUCTION

It is always desirable to generate a high resolution (HR)image as it shows more intricate details. However, availablesensors have limitation in respect to maximum resolution.Thus our basic goal is to develop an algorithm to enhance thespatial resolution of images captured by an image sensor withfixed resolution. This process is called the Super Resolution(SR) method and remains an active research topic for thelast two decades. A number of fundamental assumptions aremade about image formation and quality which in turn lead todifferent SR algorithms. These assumptions include the typeof motion, the type of blurring and also the type of noise. It isalso to be decided whether to produce the very best HR imagepossible or an acceptable HR image as quickly as possible.Moreover SR algorithms may vary depending on whether onlysingle LR image is available (single frame SR) or multipleLR images are available (multi-frame SR). Also SR imagereconstruction algorithms work either in (a) Frequency domainor in (b) Spatial domain. In this work we focus only on spatialdomain approach for multi-frame SR image reconstruction.

Among spatial domain multi-frame SR image reconstructionalgorithms, representative works include non-uniform inter-polation based approaches [1], [2]. The advantage of theseapproaches is that their computational cost is relatively low

P. Purkait and B. Chanda are with the Electronics and CommunicationSciences Unit, Indian Statistical Institute, Kolkata, India, email: (pulak r,chanda)@isical.ac.in

Copyright (c) 2012 IEEE. Personal use of this material is permitted.However, permission to use this material for any other purposes must beobtained from the IEEE by sending a request to [email protected].

Manuscript received on August 10, 2011. Revised on May 7, 2012.Accepted on March 8, 2012.

which makes them suitable for real-time applications. How-ever, they do not consider the blur model or noise characteris-tics, hence quality of the reconstructed HR image is not good.Projections on a convex set (POCS) based methods [3], [4]utilize the spatial domain observation model and incorporatesome prior information. Though these methods are simple,their disadvantages are non-uniqueness of solutions, slowconvergence rate and heavy computational cost.

Iterative back projection based approaches [5] conduct SRreconstruction in a straightforward way. However, they haveno unique solution due to the ill-posed nature of the inverseproblem and some parameters are difficult to choose. On theother hand, Bayesian maximum a posteriori (MAP) estimationbased methods [6], [7], [8] explicitly use prior informationin the form of a prior probability density on HR image andprovide a rigorous theoretical framework. In [8], a MAP basedjoint formulation is proposed that judiciously combine motionestimation, segmentation and SR together.

Another class of SR reconstruction methods generate HRimage from a single LR image or frame. These methods arecalled “Example-Based Super-Resolution” [9], [10], [11], [12]or “image hallucination” [13]. These algorithms are in generalbased on natural image edge prior [14], [10] or gradient profileprior [15]. Glasner et al. [11] merge the concepts of both singleframe SR and multi-frame SR for HR image reconstructionfrom single frame. In recent years SR image reconstructionalgorithms with sparse image prior [12], [13], [16] have beenreceiving more attention due to advancement of Sparse Codingtechniques. Those algorithms are based on dual DictionaryLearning techniques on the pairs of LR and HR image patches.

The approach reported in the present paper is based onthe regularization framework, where HR image is estimatedbased on some prior knowledge about the image (e.g., degreeof smoothness) in the form of regularization. The proba-bility based MAP approach, stated earlier is equivalent tothe concept of regularization, only in this case it gives aprobabilistic meaning to the regularization expression [17].Tikhonov regularization [18] based on bounded variation (BV)(L2 norm) is one of the popular regularization methods for SRreconstruction. It imposes smoothness in reconstructed image,but at the same time loses some details (e.g., edges) presentin the image. First successful edge preserving regularizationmethod for de-noising and de-blurring is total variance (TV)(L1 norm) method [19]. Another interesting algorithm, pro-posed by Farsiu et al. [20], employs bilateral total variation(BTV) regularization. To achieve further improvement, Li et

Page 2: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

2

al. [21] have used a locally adaptive bilateral total variation(LABTV) operator for the regularization. Recently, two otherregularization terms are proposed for SR image reconstruction,viz. “non-local means regularization” (NLM) [22] and “steer-ing kernel regression” (SKR) [23]. Usually, iterative SR imagereconstruction methods based on differentiable regularizationterms with Lp norm (1 < p ≤ 2) [6], [18], [21] use gradientdescent approach to obtain optimal solution. On the otherhand, quite a few techniques [24], [25], [26] are availablein the literature to efficiently handle non-differentiable reg-ularization term with L1 norm (e.g., TV regularization). Agroup of solvers, evolved from Bregman iteration [27], isone of recently developed methods for such non-differentiableconstraint optimization problems. Marquina and Osher [28] arefirst to use Bregman iteration for fast SR image reconstructionwith TV regularization.

However, even though all these regularization terms for SRimage reconstruction lead to a stable solution, their perfor-mance depends on optimization technique as well as regular-ization term. For example, with gradient descent optimizationtechnique the LABTV [21] regularization outperforms BTV[20] which gives better result than TV [19] regularization;on the other hand, based on TV regularization Marquina andOsher [28] obtain superior result employing Bregman iteration.So we envisage that even better result would be obtainedby combining Bregman iteration and a more sophisticatedregularization method that can suppress noise in LR imagesand ringing artifacts occurred during the capturing details ofHR image. We propose a new regularization method basedon multi-scale morphologic filters which are non-linear innature. Morphological operators and filters are well-knowntool that can extract structure from image [29]. They areused in image denoising [30], [31], image segmentation [32],[33] and image fusion [34], [35] successfully. Since proposedmorphologic regularization term uses non-differentiable maxand min operators, we develop an algorithm based on Breg-man iterations and forward-backward operator splitting usingsubgradients. It is seen that the results produced due to theproposed regularization are less affected by aforementionednoise evolved during iterative process.

The rest of the paper is organized as follows. Section IIintroduces the LR image formation model and inverse recon-struction of HR image from multiple LR images with state-of-art regularization methods. We introduce proposed multi-scale morphologic regularization method in Section III. InSection IV, we review Bregman iteration and develop analgorithm for SR image reconstruction with proposed mor-phologic regularization. Section V presents the experimentalresults and compares our results with that of some existingregularization methods for SR image reconstruction. Finally,some concluding remarks are made in Section VI.

II. PROBLEM FORMULATION

Observed images of a scene are usually degraded by blur-ring due to atmospheric turbulence and inappropriate camerasettings. The LR images are further degraded due to down-sampling by a factor determined by the intrinsic camera

parameters. The relationship between the LR images and theHR image can be formulated as [3], [20], [36], [37]

Yk = DFkHkX+ ek, ∀k = 1,2, ...,K (II.1)

where Yk, X and ek represent lexicographically ordered columnvectors of the k-th LR image of size M, HR image of size N andadditive noise respectively. Fk is a geometric warp matrix andHk is the blurring matrix of size N×N incorporating cameralens/CCD blurring as well as atmospheric blurring. D is thedown-sampling matrix of size M×N and k is the index ofthe LR images. Assuming that the LR images are taken undersame environmental condition and using same sensor, the Hkbecomes same for all k and may be denoted simply by H. Asa result, LR images are related to the HR image as

Yk = DFkHX+ ek, ∀k = 1,2, ...,K (II.2)

Since under our assumption, D and H are same for allLR images, we avoid down-sampling and then up-samplingat each iteration of iterative reconstruction algorithm [seeSection II-A] by merging the up-sampled and shifted back LRimages Yk togather. After applying up-sampling and reverseshifting Yk will be aligned with HR image X. Suppose Ykdenotes the up-sampled and reverse shifted k-th LR imageobtained through reverse effect of DFK of equation (II.2). Thatmeans Yk = F−1

k DT Yk, where DT is the up-sampling operatormatrix of size N×M and F−1

k is an N×N matrix that shiftsback (reverse effect of Fk) the image. Thus from equn. II.2 wecan write

F−1k DT Yk = F−1

k DT DFkHX+F−1k DT ek, ∀k = 1,2, ...,K

i.e. Yk = RkHX+ ek, ∀k = 1,2, ...,K

where Rk = F−1k DT DFk captures the contribution of pixels of

blur image HX from which LR image Yk is generated. In ourformulation we have chosen purely integer valued translationalshifts with respect to HR grid. In that case Fk has only 0 and1 entries. Since D is just a down-sample matrix applied onFk, therefore Rk has only 0 and 1 entries. For more generalformulation, if we incorporate rotational shifts as well in ourmotion model and/or if we use bilinear interpolation for non-integer translational shift, Rk has real entries in the range [0,1]and we may call it an weight matrix. However, in this workwe assume purely integer valued translational shift and Rk iscalled an index matrix.

Now, suppose Y is obtained by ensembling all the availableYk into a single HR grid [as shown in figure 1(b)], i.e. Y =∑

k1 Yk and R = ∑

k1 Rk. Then the relation between HR and LR

images can be rewritten as

Y = RHX+ e (II.3)

Note that the final index matrix R is similar to the trans-formation matrix derived in [38] except the blurring term.Now, we get Y as a blurred image of actual HR image Xexcept some pixel values may be missing if we take fewer LRimages and index matrix R keeps track of those missing values.Thus unknown elements of Y cannot participate in estimatingX suggested by equn. (II.3). Figure 1(a) shows one of fourLR images Yk (i.e., k = 1,2,3,4) with resolution factor 5 with

Page 3: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

3

(a) (b) (c)

Fig. 1. Illustrates up-sampling from LR images, (a) one of 4 LR Imageswith down-sampling factor 5, (b)-(c) combined all 4 up-sampled LR imageswith corresponding pixel shifts, and (c) cropped portion of the up-sampledimage (b)

different pixel shifts and figures 1(b)-(c) show correspondingY and its cropped portion respectively.

A. L2 error based estimation of SR image

Since number of unknowns (pixels in HR grid) in X isusually very large, a solution of equn. (II.3) to obtain X byinversion of RH may not be feasible. Instead, we estimatean HR image X̂ which when degraded minimizes ρ(RHX ,Y )i.e. X̂ = argminX [ρ(RHX,Y)], where dissimilarity measure ρ isdefined as ρ(U,V ) = 1

p‖U −V‖pp, (1 ≤ p ≤ 2). Here we choose

p = 2, then the estimated HR image satisfies equation (II.3) inleast-square sense, i.e.,

X̂ = argminX

[‖(RHX−Y)‖22

](II.4)

When K < N/M, the SR image reconstruction (II.4) becomesan ill-posed problem, therefore it becomes necessary to imposeregularization to obtain a stable solution.

B. Regularization for SR reconstruction algorithm

Regularization has already been used in conjunction withiterative methods for restoration of noisy degraded images[18], [20], [21], [39] in order to solve an ill-posed problemand prevent over-fitting. To obtain a stable solution of equn.(II.4), suppose a regularization operator ϒ(X) incorporatingprior knowledge is imposed on the estimated HR image X.Then the SR image reconstruction can simply be formulatedas:

X̂ = argminX{ϒ(X) : ‖RHX−Y‖22 < η} (II.5)

where η is a scalar constant depending on the noise variancein LR images. Now the constrained minimization problemof (II.5), may be reformulate as a unconstrained minimizationproblem as

X̂ = argminX{1

2‖RHX−Y‖22 + µϒ(X)} (II.6)

where µ is the regularization parameter that controls theemphasis between the data error term (first term) and theregularization term (second term). Choosing regularizationparameter µ for optimum solution of (II.6) is a non-trivial task.For example, a large value of µ may not satisfy the constraintin equn. (II.5) as the data error term is less emphasized, and onthe other hand, small value of µ may amplify unwanted ringingartifacts as the smoothness criteria gets less importance.

One of the commonly used regularization methods is theTikhonov cost function [6], [18], [21], [39] for estimatingstable de-noised image and is given by

ϒ(X) = ‖ΓX‖2 (II.7)

where Γ is usually a high-pass operator such as derivative orLaplacian. Since high-pass operators enhance both edge andnoise equally, minimization of ‖ΓX‖2 leads to blurring of edgesalong with removing noise. First successful edge preservingregularization method for de-noising and de-blurring is totalvariation (TV) method [19] which penalizes the spatial varia-tion in the image as measured by the L1 norm of the magnitudeof the gradient, i.e.,

ϒ(X) = ‖ΓX‖1 (II.8)

Sometimes this is also called ROF (Rudin-Osher-Fatemi)model. Farsiu et al. [20] introduced the bilateral total variation(BTV) by combining the total variation and the bilateralfilter [40], [41] as follows.

ϒ(X) =w∑

l=−w

w∑

m=−wα|m|+|l||X−Sl

xSmy X |1 (II.9)

where l + m ≥ 0 and (Slx, Sm

y ) are shift operator matrices torepresent l and m pixel shift respectively along horizontal andvertical directions. The parameter w is the window size andα (0 < α < 1) is the weighting coefficient. The amount of edgesharpness preservation as well as the degree of smoothnessdepend on the value of α and w.

Thus conventional regularization methods choose ϒ(X) ashigh-frequency energy and minimize its pth norm to ensuresmoothness. In this work we define ϒ(X) based on morpho-logic filters that preserve structures and suppress noise. It iswell known that morphological opening and closing removesbright and dark noise respectively without affecting the edgesharpness [29], [30]. An image, in general, may contain bothdetail and noise at different scales. So we propose a multiscalemorphology based regularization to remove noise and artifacts,while preserving the edge sharpness in the next section.

III. MORPHOLOGIC REGULARIZATION

Let B be a disk of unit size with origin at its center andsB be a disk structuring element (SE) of size s. Then themorphological dilation Ds(X) of an image X of size m× n atscale s is defined as:

Ds(X) =

maxr∈(sB)(1){xr}

maxr∈(sB)(2){xr}

. . .maxr∈(sB)(mn)

{xr}

(III.1)

where (sB)(i) is a set of pixels covered under SE sB translatedto the i-th pixel xi. Similarly morphological erosion Es(X) atscale s is defined as:

Es(X) =

minr∈(sB)(1){xr}

minr∈(sB)(2){xr}

. . .minr∈(sB)(mn)

{xr}

(III.2)

Page 4: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

4

Morphological opening Os(X) and closing Cs(X) by SE sB aredefined as:

Os(X) = Ds(Es(X))

Cs(X) = Es(Ds(X))

In multiscale morphological image analysis [30], [33], [42],[43], we have seen that the difference between sth scale closingand opening extracts noise particles and image artifacts inscale s and may be used for de-noising purpose. So in thiswork we propose the regularization function based on multi-scale morphology as:

ϒ(X) =S∑

s=1α

s1t [Cs(X)−Os(X)] (III.3)

where 1 is a column vector consisting of all 1’s and α is theweighting coefficient. To give more emphasis on the smallscale for noise removal, the value of α is chosen from theinterval 0 < α < 1. Therefore, with the proposed regularizationterm the SR reconstruction problem (II.5) is reduced to :

X̂ = minX{

S∑

s=1α

s1t [Cs(X)−Os(X)] : ‖RHX−Y‖2 < η} (III.4)

Since the proposed regularization term is not differentiableeverywhere, we use sub-gradient technique to solve the abovereconstruction problem as discussed in the next section.

IV. SUBGRADIENT METHODS AND BREGMAN ITERATION

Bregman iteration is successfully used by Osher et al. [27]in the field of computer vision for finding the optimal valueof energy functions in the form of a constrained convexfunctional. After that a class of efficient solvers has beenproposed for constrained problems (II.5) and unconstrainedproblems (II.6). Among them ‘fixed point continuation’ (FPC)[25] method is proposed to solve the unconstrained problemby performing gradient descent steps iteratively. LinearizedBregman algorithm [44] is derived by combining FPC andBregman iteration to solve constrained problem in a moreefficient way. Those methods are successfully used in sparsereconstruction problem viz. compressed sensing (CS) [24],[25], [44], [45], [46] and sparse coding [21], [47], [48],[49] due to their simplicity, efficiency and stability. LaterGoldstein et al. [50] have developed ‘split Bregman method’for more structured regularization in variational problems ofimage processing. Marquina and Osher [28] have formulateda model for SR based on a constrained variational modelthat uses the total variation of the signal as a regularizingfunctional. In this section, we develop an algorithm based onBregman iteration and proposed morphologic regularizationfor SR image reconstruction problem.

A. Bregman iteration

Consider the following minimization problem:

minX{ϒ(X) : T (X) = 0} (IV.1)

where ϒ and T are both convex functionals defined overRn → R+. Now the Bregman iterations [27], [28], [50] that

solve the above constrained minimization problem are asfollows:

Initialize X0 = p0 = 0X(n+1) = argminX{µBp(n)

ϒ(X,X(n))+T (X)}

p(n+1) = p(n)−∇T (X(n+1))(IV.2)

where Bp(n)ϒ

is the Bregman distance corresponding to convexfunctional ϒ(.) and is defined from point X to point V asBp

ϒ(X,V) = ϒ(X)−ϒ(V)−〈p,X−V〉. Convergence and stability

of this scheme are discussed in detail in [27], [50].Yin et al. [44] have shown that for the case of linear

constraints RHX−Y = 0 in (III.4), Bregman iterations (IV.2)can be reduced to a more simplified form [50] with l2 normX(n+1) = argmin

X{µϒ(X)+

12‖RHX−Y(n)‖22}

Y(n+1) = Y(n) +(Y−RHX(n+1))(IV.3)

In other words the error (Y−RHX(n)) in n-th estimation isadded back to Y(n) such that finally RHX(n) satisfies theconstraint RHX−Y = 0. Note that the first equation solvethe unconstrained minimization problem (II.6). As, in gen-eral, there is no explicit expression for X(n+1) to solve theunconstrained optimization subproblem (first equation) (IV.3),we go further to solve it explicitly.

B. Proximal map

Consider the following unconstrained minimization prob-lem:

minX

(µϒ(X)+T (X)) (IV.4)

where µ > 0. Combettes et. al. [51] describe a forward-backward technique to minimize the sum of two convexfunctionals based on the proximal operator introduced byMoreau [52]. By classical arguments of convex analysis, thesolution of (IV.4) satisfies the condition:

µ∂ϒ(X)+∂T (X) = 0

For any positive number γ, we have

(X+ γµ∂ϒ(X))− (X− γ∂T (X)) = 0

This leads to a forward and backward splitting algorithm:

X(k+1) = Proxϒ(X(k)− γ∂T (X(k))), (IV.5)

where the proximal operator Proxϒ(V) is defined as:

Proxϒ(V) = argminX{µϒ(X)+

12γ‖X−V‖22} (IV.6)

In our case T (X) = 12‖RHX−Y‖22. Therefore the solution of

the minimization problem (IV.4) can be computed by thefollowing two-step algorithm:

U(k+1) = X(k)− γHT RT (RHX(k)−Y)

X(k+1) = argminX{µϒ(X)+

12γ‖X−U(k+1)‖22}

(IV.7)

This algorithm (IV.7) can be used to solve the unconstrainedminimization problem presented by first equation of (IV.3) asdescribed next.

Page 5: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

5

C. Bregmanized Operator Splitting

In this section we develop an algorithm to solve theequality constrained minimization problem (IV.1) withT (X) := RHX−Y using Bregman iterations (IV.3) and operatorsplitting (IV.7), briefly introduced in the last two subsections.Now, the operator splitting technique is used to solve theunconstrained subproblem, i.e. first equation of (IV.3) asfollows:

for k ≥ 0, X(n+1, 0) = X(n)U(n+1, k+1) = X(n, k)− γHT RT (RHX(n, k)−Y(n, k))

X(n+1, k+1) = argminX{µϒ(X)+

12γ‖X−U(n+1, k+1)‖22}

(IV.8)Ideally we need to iterate (IV.8) infinite number of times [53]to obtain a convergent solution X(n+1) for the said subproblem.Instead we propose to iterate them once for small amount ofnoise, which leads to the following algorithm:

U(n+1) = X(n)− γHT RT (RHX(n)−Yn)

X(n+1) = argminX{µϒ(X)+

12γ‖X−U(n+1)‖22}

Y(n+1) = Y(n) +(Y−RHX(n+1))

(IV.9)

For optimal solution of the second equation of (IV.9), we have(replacing gradients by its corresponding subgradients)

µδϒ(X)

δX+

1γ(X−U(n+1)) = 0

So the corresponding iteration can be written as

X(n+1) = U(n+1)−µ′| δϒ(X)

δX|X(n)

where µ′= µγ and | δϒ(X)

δX |X(n) is a subgradient of ϒ(X) at

X(n).Goldstein and Osher [50] have shown that the above

algorithm (IV.9) can also be used to approximate theminimizer for linear inequality constraint of the form‖RHX−Y‖22 < η for small value of η by imposing a stoppingcriterion based on inequality constraint that leads to analgorithm for solving inequality constrained minimization(II.5). Therefore we can present the proposed SR imagereconstruction algorithm for small amount of noise usingBregman iteration and operator splitting as follows:

Proposed Iterative Algorithm for SR Image Reconstruction:Initialize Y(0) = n = 0,Y, X(0) = FillUnknown(Y);

While(‖RHX(n)−Y‖22 > η)U(n+1) = X(n)− γHT RT (RHX(n)−Yn)

X(n+1) = U(n+1)−µ′| δϒ(X)

δX |X(n)

Y(n+1) = Y(n) +(Y−RHX(n+1))n = n+1

end

(IV.10)

FillUnknown(Y) in the initialization step of the above algo-rithm fills the unknown pixels in Y by the correspondingknown neighboring pixels. The parameter η is a predefinedthreshold chosen depending on variance of noise in LR imagesand significantly small for noise-free LR images. So we iterateuntil constraint in (II.5) is satisfied.

Note that, for LR images with high noise to satisfy in-equality constraint in (II.5), a fraction β (where β < 1) ofthe error (Y− RHX(n)) in n-th estimation is added back toY(n), i.e. last equation of (IV.10) is replaced by Y(n+1) =Y(n) + β (Y− RHX(n+1)) and is iterated once after every literations of first two equation.

Since proposed regularization function ϒ(X) as definedin equn. (III.3) consists of non-differentiable max and minoperators (Ds(X),Es(X)), we go for computing subgradients| δϒ(X)

δX |X(n) of the morphological regularization ϒ(X) in the

following subsection.

D. Subgradients of Morphologic Regularization function

Here we derive the subgradients of the dilated (III.1) anderoded (III.2) image with respect to its pixel values. Let usdenote the subgradient of a dilated image Ds(X) by δDs

δX . Fromthe definition of Ds(X), as given in (III.1), jth element of ith

column of the subgradient δDsδX is:

δDs, jδxi

=

1 if xi = maxr∈(sB)( j)

{xr} and

∀t ∈ (sB)( j), t 6= i,xt < xi0 if xi < maxr∈(sB)( j)

{xr}

∈ [0,1] elsewhere(IV.11)

Similarly subgradient of an eroded image Es(X) can be writtenas follows:

δEs, jδxi

=

1 if xi = minr∈(sB)( j)

{xr} and

∀t ∈ (sB)( j), t 6= i,xt > xi0 if xi > minr∈(sB)( j)

{xr}

∈ [0,1] elsewhere(IV.12)

Now in (IV.11) and (IV.12) if we choose subgradient equalto 1 out of the range [0,1]. Then the subgradients become:

δDs, jδxi

=

1 if xi = maxr∈(sB)( j){xr}

0 if xi < maxr∈(sB)( j){xr}

(IV.13)

δEs, jδxi

=

1 if xi = minr∈(sB)( j){xr}

0 if xi > minr∈(sB)( j){xr}

(IV.14)

Since analogous chain rule holds for sub-gradients, hencewe can write down the sub-gradients of the regularizationfunction ϒ(X) (III.3) as

δϒ(X)δX := δ

δX ∑Ks=1 αs1t [Cs(X)−Os(X)]

= ∑Ks=1 αs[ δCs(X)

δX − δOs(X)δX ]1

= ∑Ks=1 αs[ δ

δX Es(Ds(X))− δ

δX Ds(Es(X))]1= ∑

Ks=1 αs[ δ

δDs(X)Es(Ds(X)) δ

δX Ds(X))−δ

δEs(X)Ds(Es(X)) δ

δX Es(X)]1(IV.15)

Clearly, δ

δDs(X)Es(Ds(X)) and δ

δEs(X)Ds(Es(X)) can be cal-

culated following (IV.13) and (IV.14) with respect to sth

Page 6: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

6

scale dilation Ds(X) = [ds,1,ds,2, . . .ds,mn] and erosion Es(X)= [es,1,es,2, . . .es,mn] respectively as follows:

qEs, ji :=

δEs, jδds,i

=

1 if ds,i = minr∈(sB)( j){ds,r}

0 if ds,i > minr∈(sB)( j){ds,r}

(IV.16)

qDs, ji :=

δDs, jδes,i

=

1 if es,i = maxr∈(sB)( j){es,r}

0 if es,i < maxr∈(sB)( j){es,r}

(IV.17)

Substituting equn. (IV.14), (IV.13), (IV.16) and (IV.17) in equn.(IV.15), we compute the subgradient δϒ(X)

δX which is requiredin computing third step of (IV.10). In Appendix we discussa method to compute subgradients of Ds(X) and Es(X) usingchain rule efficiently.

V. EXPERIMENTAL RESULTS

In this section we study and analyze the performance ofthe proposed method as well as that of some other existingSR reconstruction methods. In this discussion the proposedalgorithm (IV.10) is referred to as ‘Breg + Morph’, whilethe other methods are referred to as ‘Grd + TV’ [19], ‘Grd+ BTV’ [20], ‘Breg + TV’ [28] and ‘Grd + LABTV’ [21]respectively. Here ‘Grd’ stands for iterative gradient descenttechnique and ‘Breg’ stands for Bregman iteration techniquefor optimization. ‘Morph’, ‘TV’, ‘BTV’ and ‘LABTV’ standsfor morphological, total variation, bi-lateral total variationand locally adaptive bi-lateral total variation regularizationrespectively. Note that the methods associated with ‘Breg’solve constrained SR reconstruction formulation (II.5) whereasthose with ‘Grd’ solve the unconstrained formulation (II.6).

Experimental Setting: For performance evaluation a typical512× 512 gray-level HR image (e.g., Chart image) is chosen[see figure 2(a)]. We synthetically generate some LR imagesfrom this HR image and later reconstruct a HR image fromthese generated LR images. Finally, we compute PSNR andSSIM as quantitative measure of quality of reconstructed HRimage with respect to the original HR image. The blurringis chosen as 5× 5 Gaussian smoothing kernel with scaleparameter σ = 2.5 and the matrix H is formed accordingly.The down-sampling factor is chosen to be 5 and the matrix Dis constructed to achieve this. We assume purely translationalshifts by integer value and Fk is formed accordingly. Thereare 25 possible choices of integer shifts for resolution factor5 to generate 25 LR images. In our experiment we haveobserved that only 10 LR images among 25 are sufficient toreconstruct HR image of acceptable quality with resolutionfactor 5. Hence, in our experiment we take 10 randomlychosen LR images and determine the index matrix R of equn.(II.3) accordingly. The same setup is followed throughoutthis experimental section unless stated otherwise. Second, aninteresting portion is marked on each resultant HR imageand is displayed on the top-right/left corner after zoomingit for careful study of the visual quality. The parametersfor each algorithm are chosen to maximize the PSNR withrespect to the ground truth. In our reconstruction algorithm(IV.10), we have chosen the model parameters γ = 1 andµ′= 0.5 respectively and have got good results in most of the

TABLE ITIME COMPARISON OF DIFFERENT METHODS FOR THE EXPERIMENT IN

FIGURE 2.

Method Grd+TV Grd+BTV Grd+LABTV Breg+TV Breg+MorphIteration 221 211 308 68 63Time 19.72s 32.47s 290.48s 6.83s 12.45s

experiments. For the experiments with noisy LR images afterevery 5 iterations of the first two steps of the algorithm (IV.10)the third step is executed once and β is chosen as reciprocalof the noise variance. We have implemented the algorithmsusing MATLAB 7.6 and run on a regular Desktop with 3GzIntel quad-core processor and 8GB of RAM.

In the first experiment, LR images contain small amountof noise (σ = 2) and the up-sampled-merged image obtainedfrom 10 LR images is shown in figure 2(c). The resultsof different algorithms are shown in figures 2(d)-(h). Fig-ures 2(d)-(f) present SR reconstructed images using gradientdescent method for optimization with TV, BTV and LABTVregularizations respectively. Similarly figures 2(g)-(h) presentthe results using Bregman iteration method for optimizationwith TV and morphologic regularizations respectively. In eachcase algorithm is terminated if the residue is less than certainthreshold (e.g. η in the algorithm (IV.10)) or number ofiterations is more than 1000. In figure 3(a) we plot howdifferent algorithms approach the terminating condition. TableI shows the number of iterations and corresponding numericaltime comparison of the results shown in figure 2. It is seen thatthe morphologic regularization yields SR reconstructed imageof better quality compared to other regularization methodswith less number of iterations. In section IV-A it is mentionedthat the convergence and stability of Bregman iteration basedscheme are discussed in detail in [27], [50]. However, here wegive an indication of the same based on experimental data. Forthis purpose in Figure 3(b) we plot the objective function of‘Breg+TV’ and ’Breg+Morph’ upto the number of iterations asgiven in Table I. The figure shows that after initial irregularitiesvalues of the objective function follows overall a decreasing innature. Caption of figure 2 provides the quantitative measure ofquality of the methods. In Figure 3(c), we plot improvementin PSNR of the estimated image X(n) versus n for differentSR reconstruction methods. These two plots, viz. Figures3(a) and 3(c), together show the reconstruction qualities ofdifferent methods with number of iterations. Hence, with achosen bound on residue as the stopping criterion for SRalgorithms, the proposed method can achieve better qualitywith less number of iterations.

We have applied the proposed SR reconstruction and alsoother methods over some more images and the results of onlyman, boat and Lena images are shown in figure 4. In each ofthe images the proposed method reconstructs more detail thanother existing state-of-art reconstruction methods and we alsoachieve higher PSNR and SSIM in each case.

In the next experiment, we add high Gaussian noise withzero mean and standard deviation σ = 12.0 to the LR images.The results of different approaches are shown in figure 5. Here

Page 7: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

7

(a) Original (b) Synthesized (c) Merged LRHR image LR image ( Upsampled )

(d) Grd + TV [19] (e) Grd + BTV [20] (f) Grd + LABTV [21](PSNR = 31.29, (PSNR = 31.61, (PSNR = 30.97,SSIM = 0.9910) SSIM = 0.9938) SSIM = 0.9945)

(g) Breg + TV [28] (h) Breg + Morph [prop.](PSNR = 32.41, (PSNR = 32.46,SSIM = 0.9917) SSIM = 0.9945)

Fig. 2. Illustrates results of various SR image reconstruction methods withsmall amount of noise (σ = 2): (a) Original HR image of a Chart, (b) Oneof the generated LR images, (c) Up-sampled and merged 10 LR images,(d)-(f) SR reconstructed image using gradient descent method with TV,BTV and LABTV regularization respectively, (g)-(h) SR reconstructed imageusing Bregman Iteration method with TV and morphologic regularizationrespectively. Number of iterations in each case are shown in Table I.

(a) (b)

(c)

Fig. 3. Comparison of reconstruction qualities of different methods versusnumber of iterations for the experiment in figure 2. (a) Illustrates how residueof data fidelity term approaches the threshold value to terminate the algorithmIV-A, (b) variation in objective function with iteration for ‘Breg+TV’ and‘Breg+Morph’[see text] and (c) PSNR up to 100 iterations for differentalgorithms as indicated in (a). Actual number of iterations and run time areshown in Table I.

(a)i Farsiu et al. [20] (a)ii Marquina et al. [28] (a)iii Proposed method(PSNR = 29.80, (PSNR = 31.10, (PSNR = 31.45,SSIM = 0.9431) SSIM = 0.9656) SSIM = 0.9707)

(b)i Farsiu et al. [20] (b)ii Marquina et al. [28] (b)iii Proposed method(PSNR = 29.86, (PSNR = 31.60, (PSNR = 32.02,SSIM = 0.9505) SSIM = 0.9724) SSIM = 0.9755)

(c)i Farsiu et al. [20] (c)ii Marquina et al. [28] (c)iii Proposed method(PSNR = 31.12, (PSNR = 32.56, (PSNR = 32.81,SSIM = 0.9562) SSIM = 0.9714) SSIM = 0.9727)

Fig. 4. Comparison of reconstruction result of (a) man, (b) boat and(c) Lena images of proposed method over some existing methods: (i) SRimage reconstructed using ‘Grd + BTV’ [20], (ii) SR image reconstructedusing ‘Breg + TV’ [28], and (ii) SR image reconstructed using ‘Breg + Morph’(Proposed method).

we see that proposed method is comparable to best performingmethods ‘Grd + BTV’ [20] and ‘Grd + LABTV’ [21] in termsof both PSNR and SSIM.

In case of salt-and-pepper noise or impulse noise withrandom values, we can identify the position of noisy pixels byemploying the concept of of Center-Weighted Median Filters(CWM) [54], [55] filters. So that such blur and noisy LRimages may be handled by a two-phase algorithm. In the firstphase, we find the locations of the pixels affected by noise, andin the second phase, those pixels are ignored for reconstructionof HR image. In the next experiment we consider LR imageshaving 10% impulse noise with uniform distribution in therange [−128,128]. Now CWM replaces the noisy pixel withthe median value of the neighboring pixels and keeps theunaffected pixel as it is. The search for the noisy pixelsusing CWM filter depends on the neighborhood statistics ofthe pixels. Since the neighboring pixels of a pixel in a LRimage does not remain neighboring ones when they are up-sampled and ensembled into an HR image Y (see figure 1), weconsider required number of closest known neighboring pixelsin Y of the candidate pixel. However, unlike [54], [55] in thiswork after detecting the noisy pixels we do not modify theirvalues, rather we mark them as unknown pixels and modify the

Page 8: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

8

(a) LR image (b) Grd + TV [19] (c) Grd + BTV [20](PSNR = 25.47, (PSNR = 26.45,SSIM = 0.8786) SSIM = 0.9523)

(d) Grd + LABTV [21] (e) Breg + TV [28] (f) Breg + Morph [prop.](PSNR = 26.17, (PSNR = 25.25, (PSNR = 26.40,SSIM = 0.9361) SSIM = 0.8745) SSIM = 0.9384)

Fig. 5. Illustrates results of various SR image reconstruction methods: (a) Oneof the generated LR images with high Gaussian noise (mean µ = 0 andstandard deviation σ = 12), (b)-(d) SR reconstructed image using gradientdescent method with TV, BTV and LABTV regularization respectively, (e)-(f) SR reconstructed image using Bregman Iteration method with TV andmorphologic regularization (proposed method) respectively.

(a) LR image (b) Farsiu et al. [20] (c) Li et al. [21](PSNR = 24.59, (PSNR = 22.08,SSIM = 0.8061) SSIM = 0.5884)

(d) Marquina et al. [28] (e) Proposed Method (f) Proposed Method(single phase) (two phase)

(PSNR = 23.01, (PSNR = 24.10, (PSNR = 26.51,SSIM = 0.6052) SSIM = 0.8434) SSIM = 0.9827)

Fig. 6. Illustrates results of various SR image reconstruction methods:(a) One of the generated LR images with impulse noise (Probability= 0.1) withuniform distribution in the range∈[-128,128]), (b)-(d) SR image reconstructedusing ‘Grd + BTV’ [20], ‘Grd + LABTV’ [21], ‘Breg + TV’ [28], and (e)-(f) reconstructed using ‘Breg + Morph’ (Proposed method) in single step andmulti-step respectively.

index matrix R accordingly, so that, those noisy pixels cannoteffect the SR image reconstruction process. Figure 6 showsthe results of the proposed method and other existing methods.Image shown in figure 6(f) present the result of proposed two-phase process.

In the next experiment we evaluate the performance of

(a) Farsiu et al. [20] (b) Marquina et al. [28] (c) Proposed method(PSNR = 25.69, (PSNR = 25.85, (PSNR = 26.30,SSIM = 0.9827) SSIM = 0.9646) SSIM = 0.9748)

Fig. 7. Comparison of reconstruction result of Chart image for misestimatedmotion model and erroneous Gaussian blur parameter (a) SR image recon-struction using ‘Grd + BTV’ [20] (b) using ‘Breg + BTV’ [28] and (c) using‘Breg + Morph’ (proposed method) respectively.

the proposed reconstruction method under miss-estimation ofmotion parameter and also the parameter of Gaussian blur. Wecorrupt the actual shifts of LR images by adding Gaussian dis-tributed random values with zero mean and standard deviation0.1 provided the changed values lie within the allowable range.For example, in case of resolution factor 5, the allowable rangeof shifts is [0, 5). If a noisy shift goes beyond this range it maybe either truncated to lie within this range or a new randomvalue is selected to corrupt the shift value. Here we adoptthe later approach. However, this choice is not critical. Nowthe matrix F−1

k is formed based on these noisy shifts and thecorresponding matrix R of equn. (II.3) would no longer bean index matrix rather an weight matrix. Moreover, thoughwe generate the LR images using Gaussian blur with σ = 2.5,while reconstructing HR image we consider σ = 2.35. Figure 7shows the results of this experiment. From the experiment itis seen that even under mispredicted motion parameter andscale of Gaussian blur the proposed SR reconstruction givescomparable result over the existing methods in terms of bothPSNR and SSIM.

A more systematic study of performance of different al-gorithms for different amount of noise and different blurringparameter is conducted. In Figure. 8, we plot the averagePSNR and SSIM of all the methods mentioned earlier appliedon different images. In the experiment we have added differentamount of Gaussian noise (standard deviation σ = 0 to 10) toLR images and applied various SR reconstruction algorithms.This is done on a set of images and then average PSNR andaverage SSIM are plotted. We observe that most of the casesproposed method is superior to the existing methods. Onlyexception is that with large amount of noise ‘Grd + BTV’ and‘Grd + LABTV’ perform slightly better than the proposedmethod. Same experiment is done for varying blur parameterin reconstruction algorithms also. Here the blurring parameterin reconstruction model is varied from 1 to 4, while actualblurring parameter is 2.5. It is seen that the proposed methodperforms the best and the performance of all the methods ispeaked at σ = 2.5 and falls off on either side.

VI. CONCLUSION

In this paper, we have presented an edge-preserving SRimage reconstruction problem as de-blurring problem (II.3)with a new robust morphologic regularization method. Then

Page 9: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

9

Fig. 8. Analysis of the performance of SR image reconstruction algorithmsapplied on different gray images and then average PSNR and average SSIMare plotted. Top row : PSNR and SSIM of SR algorithms for noisy LR imageswith additive Gaussian noise. Bottom row : PSNR and SSIM for differentamount of miss-prediction in blurring parameter.

we put forward two major contributions. First, we have pro-posed a morphologic regularization function based on multi-scale opening and closing which can remove noise efficientlywhile preserving edge information. Secondly, we employBregman iteration method to solve the inverse problem forSR reconstruction with proposed morphologic regularization.It is well studied that multi-scale morphological filtering canreduce noise efficiently, so we have built up successfully aregularization method based on multiscale morphology andour experimental section shows that it works quite well,in fact better than existing methods. Non-linearity of theregularization function is handled in a linear fashion duringoptimization by means of sub-gradient and proximal mapconcept.

We also showed that if there are ‘impulse noise with randomvalues’ or ‘salt-and-pepper’ noise in LR images, they canbe handled efficiently using our two-step SR reconstructionalgorithm. It first detects the noisy pixels (note: it does notsubstitute their values) and then considering those detectedpixels as unknown pixels, it reconstructs SR image using onlythose pixels which are not corrupted by noise.

The morphologic regularization method proposed here istested only on SR reconstruction problem, but one can easilyextend this work to other ill-posed problem as well. Alsoone can extend this regularization method to be adaptive bychoosing SE of different shapes and sizes depending on thelocal statistics of neighboring pixels.

ACKNOWLEDGMENT

We gratefully acknowledge the Associate Editor BrendtWohlberg for his constructive criticism and valuable sugges-tions to upgrade the manuscript to its present form.

REFERENCES

[1] S. Lertrattanapanich and N. K. Bose, “High resolution image formationfrom low resolution frames using Delaunay triangulation,” IEEE Trans.Image Process., vol. 11, no. 12, pp. 1427–1441, Dec. 2002.

[2] N. Nguyen and P. Milanfar, “An efficient wavelet-based algorithm forimage super resolution,” in Proceedings of ICIP, vol. 2, Vancouver, BC,Canada, Sep. 2000, pp. 351–354.

[3] H. Stark and P. Oskoui, “High resolution image recovery from imageplane arrays, using convex projections,” J. of the Optical Society ofAmerica A, vol. 6, no. 11, pp. 1715–1726, Nov. 1989.

[4] A. J. Patti and Y. Altunbasak, “Artifact reduction for set theoreticsuper resolution image reconstruction with edge adaptive constraints andhigher-order interpolants,” IEEE Trans. Image Process., vol. 10, no. 1,pp. 179–186, Jan. 2001.

[5] M. Irani and S. Peleg, “Improving resolution by image registration,”CVGIP: Graphical Models and Image Process., vol. 53, no. 3, pp. 231–239, May 1991.

[6] M. Elad and A. Feuer, “Restoration of a single super-resolution imagefrom several blurred, noisy and under-sampled measured images,” IEEETrans. Image Process., vol. 6, no. 12, pp. 1646–1658, Dec. 1997.

[7] L. Xiao and Z. Wei, “A super-resolution reconstruction via local and con-textual information driven partial differential equations,” in Proceedingsof FSKD, Haikou, China, Aug. 2007, pp. 726–730.

[8] H. Shen, L. Zhang, B. Huang, and P. Li, “A MAP approach for jointmotion estimation segmentation and super resolution,” IEEE Trans.Image Process., vol. 16, no. 2, pp. 479–490, Feb. 2007.

[9] W. T. Freeman and T. R. Jones, “Example-based super resolution,” IEEEComputer Graphics and Appl., vol. 22, no. 2, pp. 56–65, Mar. 2002.

[10] M. Elad and D. Datsenko, “Example-based regularization deployed tosuper-resolution reconstruction of a single image,” The Computer J.,vol. 50, no. 4, pp. 1–16, Apr. 2007.

[11] D. Glasner, S. Bagon, and M. Irani, “Super-resolution from a singleimage,” in Proceedings of ICCV, Oct. 2009, pp. 349–356.

[12] J. Yang, J. Wright, T. S. Huang, and Y. Ma, “Image super-resolution viasparse representation,” IEEE Trans. Image Process., vol. 19, no. 11, pp.2861–2873, Nov. 2010.

[13] K. I. Kim and Y. Kwon, “Single-image super-resolution using sparseregression and natural image prior,” IEEE Trans. Pattern Anal. Mach.Intell., vol. 32, no. 6, pp. 1127–1133, Jun. 2010.

[14] S. Dai, M. Han, W. Xu, Y. Wu, and Y. Gong, “Soft edge smoothnessprior for alpha channel super resolution,” in Proceedings of CVPR, Jun.2007, pp. 1–8.

[15] J. Sun, Z. Xu, and H.-Y. Shum, “Image super-resolution using gradientprofile prior,” in Proceedings of CVPR, Jun. 2008, pp. 1–8.

[16] W. Dong, L. Zhang, G. Shi, and X. Wu, “Image deblurring and super-resolution by adaptive sparse domain selection and adaptive regulariza-tion,” IEEE Trans. Image Process., vol. 20, no. 7, pp. 533–549, Jul.2011.

[17] M. Elad and D. Datsenko, “Example-based regularization deployedto super-resolution reconstruction of a single image,” The ComputerJournal, vol. 52, no. 2, pp. 15–30, Apr. 2009.

[18] X. Zhang, E. Y. Lam, E. X. Wu, and K. K. Wong, “Application ofTikhonov regularization to super-resolution reconstruction of brain MRIimage,” Medical Imaging and Informat., vol. 49, no. 87, pp. 51–56,2008.

[19] L. Rudin, S. Osher, and E. Fatemi, “Nonlinear total variation basednoise removal algorithms,” Physica D, vol. 60, no. 1-4, pp. 259–268,Nov. 1992.

[20] S. Farsiu, M. D. Robinson, M. Elad, and P. Milanfar, “Fast and robustmultiframe super-resolution,” IEEE Trans. Image Process., vol. 13,no. 10, pp. 1327–1344, Oct. 2004.

[21] X. Li, Y. Hu, X. Gao, D. Tao, and B. Ning, “A multi-frame imagesuper-resolution method,” Signal Process., Elsevier, vol. 90, no. 2, pp.405–414, Feb. 2010.

[22] M. Protter, M. Elad, H. Takeda, and P. Milanfar, “Generalizing thenonlocal-means to super-resolution reconstruction,” IEEE Trans. ImageProcess., vol. 18, no. 1, pp. 36–51, Jan. 2009.

[23] H. Takeda, P. Milanfar, M. Protter, and M. Elad, “Super-resolution with-out explicit subpixel motion estimation,” IEEE Trans. Image Process.,vol. 18, no. 09, pp. 1958–1975, Sep. 2009.

[24] D. L. Donoho, “Compressed sensing,” IEEE Trans. on Info. Theory,vol. 52, no. 4, pp. 1289–1306, Apr. 2004.

[25] E. T. Hale, W. Yin, and Y. Zhang, “Fixed-point continuation for l1-minimization: Methodology and convergence,” SIAM J. on Opt., vol. 19,no. 3, pp. 1107–1130, Oct. 2008.

Page 10: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

10

[26] P. Rodriguez and B. Wohlberg, “Efficient minimization method for ageneralized total variation functional,” IEEE Trans. Image Process.,vol. 18, no. 2, pp. 322 –332, Feb. 2009.

[27] S. Osher, M. Burger, D. Goldfarb, J. Xu, and W. Yin, “An iterativeregularization method for total variation based image restoration,” SIAMJ. on Multiscale Modeling and Simulation, vol. 4, no. 2, pp. 460–489,Apr. 2005.

[28] A. Marquina and S. J. Osher, “Image super-resolution by TV-regularization and Bregman iteration,” J. of Sci. Comput., vol. 37, no. 3,pp. 367–382, Dec. 2008.

[29] P. Soille, Morphological Image Analysis: Principles and Applications.Secaucus, NJ, USA: Springer-Verlag New York, Inc., 2003.

[30] S. Mukhopadhyay and B. Chanda, “An edge preserving noise smoothingtechnique using multiscale morphology,” Signal Process., vol. 82, no. 4,pp. 527–544, Apr. 2002.

[31] M. Nakashizuka, Y. Ashihara, and Y. Iiguni, “Morphological imageregularization with a smoothness criterion of structuring elements,” inProceedings of ISCIT, Oct. 2010, pp. 137–142.

[32] L. Vincent, “Morphological grayscale reconstruction in image analysis:applications and efficient algorithms,” IEEE Trans. Image Process.,vol. 2, no. 2, pp. 176–201, Apr. 1993.

[33] S. Mukhopadhyay and B. Chanda, “Multiscale morphological segmen-tation of gray-scale image,” IEEE Trans. Image Process., vol. 12, no. 5,pp. 533–549, May 2003.

[34] G. Piella, “A general framework for multiresolution image fusion: frompixels to regions,” Inf. Fusion, Elsevier, vol. 4, no. 4, pp. 259–280, Apr.2003.

[35] I. De, B. Chanda, and B. Chattopadhyay, “Enhancing effective depth-of-field by image fusion using mathematical morphology,” Image andVision Comp., Elsevier, vol. 24, no. 12, pp. 1278–1287, Apr. 2006.

[36] S. P. Kim, N. K. Bose, and H. M. Valenzuela, “Recursive reconstructionof high resolution image from noisy undersampled multiframes,” IEEETransactions on Acoustics, Speech, and Signal Process., vol. 38, no. 6,pp. 1013–1027, Jun. 1990.

[37] B. C. Tom and A. K. Katsaggelos, “Reconstruction of a high-resolutionimage by simultaneous registration, restoration, and interpolation of low-resolution images,” in Proceedings of ICIP, vol. 2, Oct. 1995, pp. 539–542.

[38] M. Elad and Y. Hel-Or, “A fast super-resolution reconstruction algorithmfor pure translational motion and common space-invariant blur,” IEEETrans. Image Process., vol. 10, no. 8, pp. 36–51, Aug. 2001.

[39] N. Nguyen, P. Milanfar, and G. H. Golub, “A computationally efficientimage super resolution algorithm,” IEEE Trans. Image Process., vol. 10,no. 4, pp. 573–583, Apr. 2001.

[40] M. Elad, “On the bilateral filter and ways to improve it,” IEEE Trans.Image Process., vol. 11, no. 5, pp. 1141–1151, Oct. 2002.

[41] C. Tomasi and R. Manduchi, “Bilateral filtering for gray and colorimages,” in Proceedings of ICCV, New Delhi, India, Jan. 1998, pp.836–846.

[42] R. W. Brockett and P. Maragos, “Evolution equations for continuous-scale morphological filtering,” IEEE Trans. on Signal Process., vol. 42,no. 12, pp. 3377–3386, Dec. 1994.

[43] D. Ze-Feng, Y. Zhou-Ping, and X. You-Lun, “High probability impulsenoise-removing algorithm based on mathematical morphology,” IEEETrans. on Signal Process., vol. 14, no. 1, pp. 31–34, Jan. 2007.

[44] W. Yin, S. Osher, D. Goldfarb, and J. Darbon, “Bregman iterative al-gorithms for L1-minimization with applications to compressed sensing,”SIAM J. on Imaging Sci., vol. 1, no. 1, pp. 143–168, Mar. 2008.

[45] J. Cai, S. Osher, and Z. Shen, “Linearized Bregman iterations forcompressed sensing,” Mathematics of Comput., vol. 78, no. 267, pp.1515–1536, Sep. 2009.

[46] S. Osher, Y. Mao, B. Dong, and W. Yin, “Fast linearized Bregmaniteration for compressive sensing and sparse denoising,” Commun. inMathematical Sci., vol. 8, no. 1, pp. 93–111, Jan. 2010.

[47] E. Candes, J. Romberg, and T. Tao, “Robust uncertainty principles: exactsignal reconstruction from highly incomplete frequency information,”IEEE Trans. on Info. Theory, vol. 52, no. 2, pp. 489–509, Feb. 2006.

[48] J. Darbon and S. Osher, “Fast discrete optimizations for sparse approx-imations and deconvolutions,” preprint, 2007.

[49] T.-C. Chang, L. He, and T. Fang, “MR image reconstruction from sparseradial samples using Bregman iteration,” in Proceedings of ISMRM, May2005.

[50] T. Goldstein and S. J. Osher, “The split Bregman method for l1-regularized problems,” SIAM J. on Imaging Sci., vol. 2, no. 2, pp. 323–343, Apr. 2009.

[51] P. L. Combettes and V. R. Wajs, “Signal recovery by proximal forward-backward splitting,” SIAM J. on Multiscale Modeling and Simulation,vol. 4, no. 4, pp. 1164–1200, Apr. 2005.

[52] J. J. Moreau, “Functions convexes duales et points proximaux dans unespace hilbertien,” C. R. Acad. Sci. Paris Ser. A. Math., vol. 255, pp.2897–2899, 1962.

[53] X. Zhang, M. Burger, X. Bresson, and S. Osher, “Bregmanized nonlocalregularization for deconvolution and sparse reconstruction,” SIAM J. onImaging Sci., vol. 3, no. 3, pp. 226–252, Jul. 2010.

[54] S.-J. Ko and Y. H. Lee, “Center weighted median filters and theirapplications to image enhancement,” IEEE Trans. on Circuits and Sys.,vol. 38, no. 9, pp. 984–993, Sep. 1991.

[55] T. Chen and H. R. Wu, “Adaptive impulse detection using center-weighted median filters,” IEEE Signal Process. Letters, vol. 8, no. 1,pp. 1–3, Jan. 2001.

APPENDIX

A. Subgradients of Morphological operatorsLet us consider the error ϒ(X) due to regularization as

mentioned in (III.3). Now use the following properties ofMorphological dilation and erosion

Ds(X) = (X⊕B)⊕ , s times · · ·⊕B= D(D(. . . s times . . .D(X) . . .))

Es(X) = (XB) , s times · · ·B= E(E(. . . s times . . .E(X) . . .))

where we use simply the operator D(X) for morphologicaldilation instead of D1(X) and E(X) instead of E1(X).

Since an analogous chain rule holds, subgradient of theregularizing error ϒ(X) described in (III.3) can be obtainedusing the chain rule of subgradient and the above propertiesof morphological operators as follows :

δ

δX Ds(X) = δ

δX [D(Ds−1(X))]

= δDsδDs−1

δDs−1δDs−2

. . .δD1(X)

δX(A1)

δ

δX Es(X) = δ

δX [E(Es−1(X))]

= δEsδEs−1

δEs−1δEs−2

. . .δE1(X)

δX(A2)

Since computing morphological filters [ (IV.13), (IV.14)]are just computing maximum and minimum in a neighborhooddefined by structuring element sB, as scale s increases, the sizeof morphological operator sB also increases and as a resultcomputational time for maximum and minimum values alsoincreases. We use the above chain rule (A1) and (A2) toreduce computation searching for large neighborhood. So wesearch in unit scale and perform searching s− t times on tth

subgradient of dilated or eroded image. Let us denote Zd1 =δDδX 1 and Ze1 = δE

δX 1 are column vectors obtained from (IV.13)and (IV.14) as follows :

Zd1i = [ δD1

δxi,

δD1δxi

, . . . δDmnδxi

]1= ] j ∈ B(i) Such that xi = maxs∈B( j)

{xs}

Ze1i = [ δE1

δxi,

δE1δxi

, . . . δEmnδxi

]1= ] j ∈ B(i) Such that xi = mins∈B( j)

{xs}

Therefore following the above chain rule (A1) and (A2) weget :

δ

δX [D2(X)]1 = δD2δD1

Zd1

δ

δX [E2(X)]1 = δE2δE1

Ze1

Page 11: Super Resolution Image Reconstruction Through Bregman ...vlrg/sites/default/files/Pulak/ieeeip2012.pdf · Super Resolution Image Reconstruction Through Bregman Iteration using

11

Thus we get recursive expression

Zds := δ

δX [Ds(X)]1 = δDsδDs−1

Zds−1

=δD(Ds−1)

δDs−1Zds−1

Zes := δ

δX [Es(X)]1 = δEsδEs−1

Zes−1

=δE(Es−1)

δEs−1Zes−1

WhereδD(Ds−1)

δDs−1and

δE(Es−1)δEs−1

are computed in the same wayas in equations (IV.13) and (IV.14) with respect to dilationDs−1 and erosion Es−1 respectively with unit scale.

B. Computational Complexity for proposed Morphologic Reg-ularization term

We use the above method for efficient computation ofsubgradients of morphological operators. Now computing

δ

δX Ds(X) in (A1) and δ

δX Es(X) in (A2) as above would takethe same number of operations as derivatives in ‘BTV’ reg-ularization term (II.9) for w = s and 2/(2s + 1)2th comparisonthat ‘TV’ regularization. Since in ‘TV’ regularization term weneed to compute only first order derivatives and for ‘BTV’regularization higher order derivatives for all neighborhoodpixels. Now computing δ

δDs(X)Es(Ds(X)) and δ

δEs(X)Ds(Es(X))as shown in equn. (IV.16) and equn. (IV.17) would take twiceas much as comparison for computing δ

δX Ds(X) and δ

δX Es(X).As a result computation of subgradients of our morphologicaloperators ϒ(X) as described in equn. (III.3) takes twice asmuch as computation of derivatives of BTV regularizationoperator (II.9) and (2s + 1)2 as much as computation ofderivatives of TV regularization operator (II.8).

Pulak Purkait received the M.Sc. degree in AppliedMathematics from the University of Calcutta andM.Tech degree in Computer Science from the IndianStatistical Institute, Kolkata, India, in 2007 and2009, respectively.

He is currently a senior research fellow in IndianStatistical Institute, Kolkata, India. His research in-terest includes computer vision, pattern recognitionand machine learning.

Bhabatosh Chanda received the B.E. degree inelectronics and telecommunication engineering andthe Ph.D. degree in electrical engineering from theUniversity of Calcutta, Calcutta, India, in 1979 and1988, respectively.

He is a Professor in Indian Statistical Institute,Kolkata, India. His research interest includes imageand video processing, pattern recognition, computervision, and mathematical morphology. He has pub-lished more than 100 technical articles in refereedjournals and conferences, authored one book, and

edited ve books.Dr. Chanda has received the “Young Scientist Medal” of the Indian National

Science Academy in 1989, the “Computer Engineering Division Medal” ofthe Institution of Engineers (India) in 1998, the “Vikram Sarabhai ResearchAward” in 2002, and the IETE-Ram Lal Wadhwa Gold medal in 2007. Heis fellow of the Institute of Electronics and Telecommunication Engineers(FIETE), of the National Academy of Science, India (FNASc.), of theIndian National Academy of Engineering (FNAE), and of the InternationalAssociation of Pattern Recognition (FIAPR).