You are viewing a javascript disabled version of the site. Please enable Javascript for this site to function properly.
Go to headerGo to navigationGo to searchGo to contentsGo to footer
In content section. Select this link to jump to navigation

Restoration of Poissonian Images Using Nonconvex Regularizer with Overlapping Group Sparsity

Abstract

Aimed at achieving the accurate restoration of Poissonian images that exhibit neat edges and no staircase effect, this article develops a novel hybrid nonconvex double regularizer model. The proposed scheme closely takes the advantages of total variation with overlapping group sparsity and nonconvex high-order total variation priors. The overlapping group sparsity is adopted to globally suppress the staircase artifacts, while the nonconvex high-order regularization plays the role of locally preserving the significant image features and edge details. Computationally, a quite efficient alternating direction method of multipliers, associated with the iteratively reweighted 1 algorithm and the majorization-minimization method, is employed to settle the optimization problem iteratively. Finally, exhaustive simulation experiments are executed for recovering Poissonian images, which are made comparisons with several state-of-the-art restoration strategies, indicate the brilliant performance of our model in terms of intuitive effects and accuracy evaluation.

1Introduction

In imaging science, the obtained images usually have undesirable degradation that is caused by the limitation of external environment, electronic equipment and human factors. Among those, the pollution of Poisson noise is a widely considered issue, which commonly occurs in medical imaging (Sarder and Nehorai, 2006), single particle emission computed tomography (Bardsley and Goldes, 2011) and various other applications. Therefore, the problem of Poisson noise removal is an important and urgent task.

To solve the above problem, Setzer et al. (2010) proposed a classical Poissonian image restoration model based on the total variation (TV) regularization as

(1)
minuu1+λ1,KuflogKu,
where ∇ denotes the gradient operator, λ is a positive tuning parameter that controls the data fidelity term, K means a nonnegative linear compact operator, and then u and f represent the original image and the positive, bounded observed version separately. With the aim to optimize the minimization problem (1), the researches in (Setzer et al., 2010; Liu and Huang, 2012; Pham et al., 2020) adopted the alternating split Bregman iteration to avoid the inner loop. Besides, several valid numerical algorithms have been proposed in recent years, such as the scaled gradient projection method (Bonettini et al., 2009), and alternating direction algorithm (Figueiredo and Bioucas-Dias, 2010).

Generally speaking, the TV-based models have the edge-preserving property in the process. That being said, the TV penalty often makes homogeneous regions easy to be over-divided to appear piecewise constant. To compensate for this technical drawback, there have emerged many efficient solvers, such as the high-order TV (HOTV, Chan et al., 2000; Lysaker et al., 2003), nonlocal TV (Gilboa and Osher, 2008), and total generalized variation (Bredies et al., 2010; Liu, 2016, 2021) regularized schemes. Devoted to removing Poisson noise, the HOTV-based model formally reads as

(2)
minu2u1+λ1,KuflogKu,
with 2 denoting the second-order gradient operator. The merit of high-order strategy is able to eliminate the staircase effect caused by the TV model. Lately, another innovation to conquer the unexpected distortion is the fractional-order TV (FOTV, Chowdhury et al., 2020). Unfortunately, the images resulting from the aforesaid techniques sometimes suffer from the over-smoothness of contours or the residue of noise.

As opposed to the convex models mentioned above, Nikolova et al. (2010) illustrated that the nonconvex regularizers in the aspect of preserving shapes are superior to the convex regularizers. As a matter of fact, nonconvex TV (Nikolova et al., 2010; Chartrand, 2007) possesses some excellent features of TV, but it may cause more serious staircase artifacts. In our opinion, nonconvex HOTV (Adam and Paramesran, 2019; Oh et al., 2013) is more appropriate for processing the degraded images relatively. Recently, the work (Lv et al., 2016) considers the TV with overlapping group sparsity (OGS-TV) for deblurring Poisson noisy images. It follows from the experiments that this approach can alleviate the blocky aspects to a certain extent, however, the staircasing effect is still present in the recovered image.

For the purpose of overcoming the staircasing effect and obtaining sharp jump discontinuities simultaneously, as well as improving the accuracy of image restoration, this paper focuses on a novel hybrid regularizers strategy for image deblurring under Poisson noise. The proposed model closely incorporates the advantages of OGS-TV and nonconvex HOTV regularizers. Mathematically, the resulting optimization model is formulated as follows

(3)
minuϕ(u)+α2upp+λ1,KuflogKu,
where ϕ(·) is defined by the overlapping group sparsity, and ·pp is a nonconvex p norm with 0<p<1. The parameter α>0 controls the tradeoff between the first and second regularizers.

The main ideas and contributions of the current article are summarized as follows. First, a novel hybrid regularizers model, which combines the superiorities of OGS-TV and nonconvex HOTV, is explored for deblurring Poissonian images. The inclusion of double regularizers contributes to achieving accurate restoration, and preserving sharp edges while suppressing the staircasing artifacts. Second, to deal with the resulting nonconvex minimization problem, we design an efficient alternating direction method of multipliers, integrating it with the popular variable splitting method, majorization-minimization (MM) method and iteratively reweighted 1 algorithm. Lastly, compared with several state-of-the-art denoising techniques, numerous numerical experiments are presented to illustrate the superior performance of our newly developed scheme.

The remainder of this paper is generalized as follows. In Section 2, we briefly present some mathematical notations and necessary definitions, as well as the algorithms related to our research. Moreover, the detailed solving steps of the proposed minimization are described in Section 3 together with some efficient methods and remark. Subsequently, in Section 4 we conduct several numerical experiments to display the comparisons of different models, and demonstrate our significant improvements. Finally, Section 5 presents a conclusion of this paper.

2Preliminaries

In this section, our main target is to outline some necessary background knowledge, which is tailored for the sequel numerical computations.

2.1Notation

Suppose that ΩRn is an open, bounded domain. Then the TV of uL1(Ω) is formulated as

(4)
TV(u)=Ω|u|dx=sup{Ωudiv(ψ)dx:ψCc1(Ω;Rn),|ψ|1},
with div being the divergence operator. As for the high-order version, it takes the form of
(5)
HTV(u)=Ω|2u|dx=sup{Ωi,j=1nujiψijdx:ψCc2(Ω;Rn×n),|ψ|1},
where |ψ(x)|=i,j=1n(ψij)2, and Cc2(Ω;Rn×n) is the set of continuous quadratic differentiable vector functions on the compact support set in Ω.

At present, we are in a position to give the discrete setting. For notational convenience, we assume that the size of an image is n1×n2, and define the function space U=Cc2(Ω;Rn×n). By the theory of finite difference method, the first-order forward and backward difference operators are respectively characterized by

(x+u)i,j=ui+1,jui,j,1i<n1,0,i=n1,(y+u)i,j=ui,j+1ui,j,1j<n2,0,j=n2,(xu)i,j=ui,jui1,j,1<i<n1,u1,j,i=1,un11,j,i=n1,(yu)i,j=ui,jui,j1,1<j<n2,ui,1,j=1,ui,n21,j=n2.

Consequently, the discrete gradient operator enjoys the following expression

(6)
(u)i,j=((x+u)i,j,(y+u)i,j)T,
and the counterpart of second-order operator is thus defined by
(7)
(2u)i,j=x(x+u)i,jx+(y+u)i,jy(xu)i,jy(y+u)i,j.

Furthermore, the discrete forms of the first-order and second-order divergence operators on the space U are described as

(divu)i,j=(xu)i,j+(yu)i,j,(div2u)i,j=x+(xu)i,j+x(yu)i,j+y+(x+u)i,j+y+(yu)i,j.

2.2OGS-TV Method

As stated in Selesnick and Chen (2013), an L-point group of the vector s is represented as

(8)
si,L=[si,si+1,,si+L1]RL,
where L denotes the size of group, and si,L is a block that is composed of L continuous components of s beginning with index i. On the basis of this notation, the work (Peyre and Fadili, 2011) puts forward a general 1D group sparsity regularizer
(9)
φ(s)=isi,L2=i(l=0L1|si+l|2)1/2.
Note that if L=1, φ(s) in (9) degrades into the commonly used 1D TV functional, and when L>1, φ(s) is beneficial for block sparsity (Bayram, 2011).

Regarding the case of 2D image uRm×1 with m=n1×n2, the associated L×L-point group can be defined as the following square matrix. That is,

(10)
u˜i,j,L=uim1,jm1uim1,jm1+1uim1,j+m2uim1+1,jm1uim1+1,jm1+1uim1+1,j+m2ui+m2,jm1ui+m2,jm1+1ui+m2,j+m2,
where m1=L12 and m2=L2, with · being the operation of rounding. By means of piling up the L columns of the L×L matrix shown in (10), we obtain a vector ui,j,L such that ui,j,L=u˜i,j,L(:). Thus, the OGS function in a 2D arrangement is read as
(11)
φ(u)=ijui,j,L2.

Consequently,the function ϕ(u) in (3) acted as a regularizer can be defined as

(12)
ϕ(u)=φ(xu)+φ(yu).
It follows from the above formula that if L=1, ϕ(u) is the anisotropic version of TV function. Otherwise, when L>1, this regularizer is denominated as the OGS-TV.

2.3MM Method

The MM method (Hunter and Lange, 2004; Figueiredo et al., 2007) is frequently applied to cope with the minimization problem. Rather than directly handling a complex cost function P(u), this technique achieves the computational efficiency by solving a series of more tractable optimization issues Q(u,uk) (k=0,1,2,). In fact, an MM iterative approach that minimizes P(u) can be set as the model

(13)
uk+1=argminuQ(u,uk),
which requires that Q(u,uk) is not less than P(u), and Q(u,u) is equal to P(u).

For example, the form of an optimization scheme is as follows

(14)
minu{P(u)=12uu022+λφ(u)},
with λ>0, and φ denotes a penalty function that is given by (11).

To obtain an effective strategy for dealing with the minimization (14) by employing the MM method, we need to seek out a majorizor of P(u). Owing to the quadratic form of the first term in (14), we actually need to find a majorizor of φ(u). The average value inequality gives that

(15)
12t2u22+12t2u2,
where u,t0. We remark that if and only if t=u, the equal sign in (15) holds. Substituting each group of φ(u) into (15), and then adding them up, this yields a majorizor of φ(u) as
(16)
R(u,t)=12i=1n1j=1n2[1ti,j,L2ui,j,L22+ti,j,L2],
with R(u,t)φ(u) and R(t,t)=φ(t). And for i,j, (16) needs to meet ti,j,L20. By an uncomplicated calculation, it can be reformulated as
(17)
R(u,t)=12uTΛ(t)u+C,
where C is a constant related to t, and each element in the diagonal matrix Λ(t) is expressed by
(18)
[Λ(t)]d,d=i=m1m2j=m1m2(k1=m1m2k2=m1m2|udi+k1,dj+k2|2)1/2,
with the subscript d=1,2,,m.

So as to minimize P(u), an iterative algorithm using the MM approach is defined by

(19)
uk+1=argminu12uu022+λ2uTΛ(uk)u.

After some manipulations, we can easily get the final solution

(20)
uk+1=(I+λΛ(uk))1u0,
where I means an identity matrix, which has the same size as Λ(uk).

3Numerical Algorithm

Our task, in this section, is chiefly to resolve our proposed hybrid model that combines the OGS-TV and nonconvex HOTV functions for image restoration.

For solving the p-norm based nonconvex optimization problem, in all other typical algorithms that we are aware of, the iteratively reweighted 1 algorithm (Candes et al., 2008; Ochs et al., 2015) is generally an ideal treatment. Applying this method to the above minimization reduces to the following approximation

(21)
minuϕ(u)+αωk2u1+λ1,KuflogKu,
where the weight ω is calculated at the k-th iteration by ωk=p/(|2uk|+ϵ)1p, with ϵ denoting a small positive number that prevents the denominator from being equal to zero.

To deal with the non-linearity and non-differentiability properties of the constructed model, we then resort to the classical variable splitting technique. Therefore, the objective function (21) can be transformed into a constrained optimization problem by introducing three auxiliary variables v, w and z. Namely,

(22)
minv,w,z,uϕ(v)+αωkw1+λ1,zflogz,s.t.v=u,w=2u,z=Ku.

The above minimization problem can be effectually solved adopting the alternating direction method of multipliers (Gabay and Mercier, 1976; Bertsekas and Tsitsiklis, 1997). Consequently, we define the corresponding augmented Lagrangian function

(23)
L(v,w,z,u;μ1,μ2,μ3)=ϕ(v)+αωkw1+λ1,zflogzμ1,vu+γ12vu22μ2,w2u+γ22w2u22μ3,zKu+γ32zKu22,
where the symbols μ1,μ2,μ3 stand for the Lagrange multipliers, and three positive penalty parameters γ1,γ2,γ3 are used to measure the quadratic penalization.

Obtaining the optimal solution of (22) is equivalent to seeking a saddle point of L. Since it is technically more difficult to settle all the variables simultaneously, this is done by alternately minimizing L(v,w,z,u;μ1,μ2,μ3) with respect to v, w, z and u,

(24)
(vk+1,wk+1,zk+1,uk+1)=argminv,w,z,uϕ(v)+αωkw1+λ1,zflogzμ1k,vu+γ12vu22μ2k,w2u+γ22w2u22μ3k,zKu+γ32zKu22,
with the updating Lagrange multipliers μ1k+1, μ2k+1 and μ3k+1
(25)
μ1k+1=μ1k+γ1(uk+1vk+1),μ2k+1=μ2k+γ2(2uk+1wk+1),μ3k+1=μ3k+γ3(Kuk+1zk+1).

More precisely, the optimization problem (24) can be effectively solved by yielding the decoupled decomposition as

(26)
vk+1=argminvϕ(v)+γ12vuk22μ1k,vuk,wk+1=argminwαωkw1+γ22w2uk22μ2k,w2uk,zk+1=argminzλ1,zflogz+γ32zKuk22μ3k,zKuk,uk+1=argminuγ12vk+1u22μ1k,vk+1u+γ22wk+12u22μ2k,wk+12u+γ32zk+1Ku22μ3k,zk+1Ku.

In what follows, our purpose is to settle each subproblem in detail one by one. At first, fixing the variables {w,z,u}, the minimization of energy L regarding v is of the form

(27)
vk+1=argminvϕ(v)+γ12v(uk+μ1kγ1)22.
This, together with the definitions of OGS and MM algorithms, leads to a converted formation that we are interested in:
(28)
vk+1=argminv12vTΛ(vk)v+γ12v(uk+μ1kγ1)22.
Based on the preliminaries described above, the solution of v is obviously given by
(29)
vk+1=(I+1γ1Λ(vk))1(uk+μ1kγ1).

Subsequently, we aim to figure out the subproblem pertaining to w. The second expression in (26) equivalently shares the following more concise formula

(30)
wk+1=argminwαωkw1+γ22w(2uk+μ2kγ2)22.
For notational simplicity, let us denote by Xk=(2uk+μ2k/γ2). The solving process of sequence (30) is given explicitly by utilizing a soft thresholding with the shrink operator. Concretely, which takes the form of
(31)
wk+1=shrink(Xk,αωkγ2)=max{|Xk|αωkγ2,0}·sgn(Xk),
with the 1D shrinkage formula being defined by
(32)
shrink(t,ρ)=max(|t|ρ,0)·sgn(t).

Thereafter, the concerned subproblem with regard to z corresponds to the equivalent minimization problem as follows

(33)
zk+1=argminzλ1,zflogz+γ32z(Kuk+μ3kγ3)22.
According to the variational method, this results in the first-order optimization condition as
(34)
0=λ(1fzk+1)+γ3(zk+1Kukμ3kγ3).
More explicitly, by using the extract roots formula of quadratic equation, we acquire the following closed-form solution
(35)
zk+1=Kukλγ3+μ3kγ32+(Kukλγ3+μ3kγ32)2+λγ3f.

The last procedure of the alternating method is to minimize for u. Deducing from the fourth equation in (26), we thus obtain

(36)
uk+1=argminuγ12uvk+1+μ1kγ122+γ222uwk+1+μ2kγ222+γ32Kuzk+1+μ3kγ322.
Considering that the subproblem (36) is a simple quadratic problem, the specific Euler–Lagrange equation can be derived as follows
(37)
0=γ1(uk+1vk+1+μ1kγ1)+γ2(2)(2uk+1wk+1+μ2kγ2)+γ3K(Kuk+1zk+1+μ3kγ3),
where ∗ indicates the conjugate operator. By doing a simple arrangement, the above formulation can be represented as
(38)
[γ1+γ2(2)2+γ3KK]uk+1=(γ1vk+1μ1k)+(2)(γ2wk+1μ2k)+K(γ3zk+1μ3k),
with the periodic boundary condition for u. Note that all the operators KK, and (2)2 have block circulant structure. Hence, the solution to uk+1 can be solved efficiently by using fast Fourier transform (FFT) and its inverse. As a matter of convenience, let υ1k+1=γ1vk+1μ1k, υ2k+1=γ2wk+1μ2k and υ3k+1=γ3zk+1μ3k. Therefore, we have
(39)
uk+1=F1(F()F(υ1k+1)+F(2)F(υ2k+1)+F(K)F(υ3k+1)γ1F()F()+γ2F(2)F(2)+γ3F(K)F(K)),
where F stands for the FFT operator and “∘” is the componentwise multiplication operator. Additionally, we also employ the discrete cosine transform to solve the problem (38) under the Neumann boundary condition.

To recap, putting the above solving steps altogether, we achieve at the following alternating direction method of multipliers (ADMM) that settles the proposed optimization problem (21).

Algorithm 1

ADMM for solving the problem (21)

ADMM for solving the problem (21)
Remark 1.

Algorithm 1 actually consists of four subproblems, and it is necessary to discuss the computational complexity of each subproblem. In the first place, the problem with respect to v can be executed with a linear time complexity order O(n1n2) for an n1×n2 image. Secondly, we note in passing that the solution of the w subproblem is exactly represented by shrinkage, thus there is a linear relationship between calculated cost and n1n2. As for the subproblem of z, the solving structure shows that its complexity is O(n1n2). Lastly, the u-subproblem is computed by FFT and inverse FFT, thus it needs O(n1n2log(n1n2)) arithmetic operations.

4Experimental Results

In this section, we present some standard test images, which have been corrupted by different blurs and noise intensities, to demonstrate the performance of the proposed model for Poissonian image restoration. Note that Poisson noise is simulated by using the MATLAB library function “poissrnd(I)”. Also, our introduced strategy will be compared with the classical TV, FOTV, HOTV and OGS-TV models in terms of measuring the visual effects and reconstruction accuracy. All experiments are performed under Windows 7 and MATLAB R2011b on a PC with an Intel(R) Core(TM) i5-6500U CPU at 3.20 GHz and 4 GB of RAM.

During the simulations, we apply the widely used peak signal-to-noise ratio (PSNR) criterion as the measure of restored image quality that is defined by

(40)
PSNR=10log10(P2MSE),with MSE=i=1n1j=1n2(ui,ju˜i,j)2n1×n2,
where P denotes the maximum peak value of image, u is the original image, u˜ is the reconstructed one, and n1×n2 implies the image size. To have a fairer comparison, the recovered perceptual quality is measured by calculating the structure similarity (SSIM, Wang et al., 2004) index as
(41)
SSIM=(2μuμu˜+C1)(2σuu˜+C2)(μu2+μu˜2+C1)(σu2+σu˜2+C2),
with μu and μu˜ being the means of u and u˜, respectively, and σu, σu˜ indicating the variations of u and u˜. Besides, σuu˜ means the covariance between u and u˜, and C1, C2 are two small constants to avoid instability in (41). Moreover, we also adopt the feature similarity (FSIM, Zhang et al., 2011) criterion to evaluate the feature-preserving ability of different methods.

It is noteworthy that the equivalent parameters chosen for the subsequent experiments are selected as L=3, p=0.1, and the iteration of MM method is fixed to 5. Three equal parameters γ1, γ2 and γ3 are updated by using the rule stated in Chan et al. (2011) with the initial value 0.1. In addition, we set α=3 for image denoising and α=5 for image deblurring. With regard to the stopping condition, each algorithm is terminated using the following formula

(42)
uk+1uk2uk+12<104.

In this simulation, we illustrate the compared results by five different methods on two test data for image denoising. The first original image peppers sized by 256×256 pixels is shown on the upper left of Fig. 1. Its noisy version displayed in Fig. 1(b) is obtained by adding Poisson noise to the clean image with the parameter P=90. Figures 1(c)–(g), which correspond to the different outcomes, represent the intuitive comparison of TV, FOTV, HOTV, OGS-TV models and our proposed scheme. As a declaration, our model is implemented by setting the parameter λ=65. For a more convincing explanation, we also present in Fig. 2 the zoom-in regions of the restorations in detail. Besides, the same applications are performed on the image Sailboats (512×512), as shown in Fig. 3, with the adjusted parameter λ=60. Meanwhile, the quantitative measures of PSNR, SSIM and FSIM values and the CPU time (in seconds) are listed in Table 1.

Fig. 1

Restoration results for the image Peppers (P=90) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

Restoration results for the image Peppers (P=90) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.
Fig. 2

Zoomed-in results for the image Peppers (P=90) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

Zoomed-in results for the image Peppers (P=90) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.
Fig. 3

Restoration results for the image Sailboats (P=90) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

Restoration results for the image Sailboats (P=90) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.
Table 1

Comparison of the performance via five different methods.

ModelPeppers (P=90)Sailboats (P=90)
IterTime (s)PSNRSSIMFSIMIterTime (s)PSNRSSIMFSIM
TV361.310329.90550.95680.9653384.803830.80200.95630.9787
FOTV381.419829.96830.95770.9665374.896530.50410.95260.9769
HOTV762.398930.32810.96240.9692799.337130.95190.95700.9785
OGS-TV411.692830.45090.96130.9709223.421031.32710.95980.9811
Ours311.822530.85800.96400.9730337.830831.71350.96330.9836

The second experiment aims to further verify the denoising ability and effectiveness of our proposed approach. For this purpose, we increase the Poisson noise density by setting a smaller peak value. Two grayscale images Brid and Boats are depicted in Figs. 4(a) and 5(a), where Brid image of size of 256×256 contains rich counters and details, the other has dimensions of 512×512 pixels and complex background. Figures 4(b) and 5(b) indicate the contaminated images with P=60. The remaining parts of Figs. 4 and 5 are the corresponding restoration results of the above five different techniques on two images, respectively. It is worth mentioning in this case, the proposed new strategy is computed with the same setting as in the simulation of Sailboats image. Moreover, Table 2 reports in detail the measurable comparisons regarding the PSNR, SSIM and FSIM values and the CPU time.

Fig. 4

Restoration results for the image Bird (P=60) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

Restoration results for the image Bird (P=60) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.
Fig. 5

Restoration results for the image Boats (P=60) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

Restoration results for the image Boats (P=60) by using five methods. (a) original image, (b) noisy image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

As is obvious from both visual images and objective data, the TV-based approach can preserve the object boundaries well, but it indeed produces the serious staircase artifacts in smooth regions. On the contrary, we notice that the awful artifacts disappear when the HOTV regularizer is utilized, while it causes the loss of important structural features because of excessive smoothness of the edges. The images restored by the FOTV model exhibit no staircasing but show a little residual noise. For the OGS-TV model, it still produces slight piecewise constant aspects while denoising. As can be observed, the proposed model enables better image quality compared to the other models, and keeps sharp and neat edges with less blocky effect.

Thirdly, the point of this experiment is to test the ability of restoring blurred and noisy images. The standard test images Saturn and Lady, which are of size 256×256 pixels and consist of homogeneous regions and abundant features, are chosen for this numerical example. Their corresponding deteriorated versions shown in Figs. 6(b) and 7(b) are corrupted by Gaussian blur with a kernel size of 7×7 pixels and standard deviation of 2, and noisy due to Poisson noise with P=255. In this case, the weighting parameter is adjusted as λ=300 for the former and λ=370 for the latter. The recovered results and comparisons of different models can be observed in sequence in Figs. 6(c)–(g), 7(c)–(g) and Table 3.

Table 2

Comparison of the performance via five different methods.

ModelBird (P=60)Boats (P=60)
IterTime (s)PSNRSSIMFSIMIterTime (s)PSNRSSIMFSIM
TV521.859828.18260.96220.9672455.804328.44190.95270.9806
FOTV531.920928.20580.95820.9698506.501628.32140.95200.9813
HOTV842.796328.24520.96200.9703759.230828.66670.95560.9840
OGS-TV441.907928.45240.96410.9715345.554628.71600.95580.9807
Ours352.109828.98800.96730.9746358.319829.31000.96050.9848
Fig. 6

Restoration results for the image Saturn (P=255) by using five methods. (a) original image, (b) degraded image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

Restoration results for the image Saturn (P=255) by using five methods. (a) original image, (b) degraded image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

As for the last experiment, to further comprehensively evaluate the performance of the proposed model for Poissonian image restoration, another classical motion blur is added to this simulation. Here we take the images Moon (358×537) and Lena (512×512), which contain flat zones and neat counters embodied in Figs. 8(a) and 9(a), as the objects for image denoising and deblurring. Figures 8(b) and 9(b) stand for the contaminated images blurred by motion blur with motion distance l=10 and angle θ=45, and noisy due to Poisson noise with the noise level P=200. Thereinto, we alter the parameter λ=360 for Moon image, and λ=300 for Lena image. Figures 8 and 9 represent the visual restorations by five different methods separately. And the PSNR, SSIM and FSIM values of the reconstructions are listed in Table 4 minutely.

Fig. 7

Restoration results for the image Lady (P=255) by using five methods. (a) original image, (b) degraded image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

Restoration results for the image Lady (P=255) by using five methods. (a) original image, (b) degraded image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.
Table 3

Comparison of the performance via five different methods.

ModelSaturn (P=255)Lady (P=255)
IterTime (s)PSNRSSIMFSIMIterTime (s)PSNRSSIMFSIM
TV1334.679533.09380.94160.9367853.050028.99490.84780.8586
FOTV732.608333.39670.94530.9551441.552728.26430.84190.8833
HOTV1053.409633.12800.94680.9561973.118128.67010.85930.8884
OGS-TV411.694533.40800.94700.9543431.838029.16830.85950.8881
Ours372.252633.65150.94730.9563301.976529.52210.86560.9012
Fig. 8

Restoration results for the image Moon (P=200) by using five methods. (a) original image, (b) degraded image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

Restoration results for the image Moon (P=200) by using five methods. (a) original image, (b) degraded image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.
Fig. 9

Restoration results for the image Lena (P=200) by using five methods. (a) original image, (b) degraded image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

Restoration results for the image Lena (P=200) by using five methods. (a) original image, (b) degraded image, (c) TV, (d) FOTV, (e) HOTV, (f) OGS-TV, (g) our model.

All in all, it is clear to observe that the staircase-like and fuzzy effects caused by the TV-based model inevitably degrade the image quality. The HOTV model avoids the shortcoming of staircase aspects, but the resulting images are mostly composed of incorrect edges and blurred counters. Even though the FOTV and OGS-TV models are able to reduce the staircase artifacts to some extent, they lead to the unexpected phenomenon of residual noise or staircase distortion. However, our introduced novel approach, which combines the advantages of nonconvex second-order regularizer and OGS-TV function, performs prominently in comparison with other existing popular techniques. Our scheme not only substantially makes the artifacts disappear, but also shapes the edges sharper. Quantitatively, this results in the restorations possessing the best PSNR, SSIM and FSIM values in Tables 3 and 4.

Table 4

Comparison of the performance via five different methods.

ModelMoon (P=200)Lena (P=200)
IterTime (s)PSNRSSIMFSIMIterTime (s)PSNRSSIMFSIM
TV8010.328833.38480.86230.8877628.007028.63050.83490.9298
FOTV648.804533.21020.89150.9084425.406628.27190.83630.9364
HOTV12811.834533.61250.87430.91159210.561928.74510.84970.9450
OGS-TV597.070333.84280.90790.8986365.390828.89950.84740.9414
Ours366.720534.15250.91210.9140337.836529.11340.85400.9492

5Conclusion

A novel hybrid nonconvex variational model, which we have proposed in this paper, is applied to reconstruct the degraded images under Poisson noise. The introduced scheme closely integrates the superiorities of OGS-TV and nonconvex HOTV regularizers, this combination helps to improve the accuracy of image restoration. To efficiently get the optimal solution of the minimization problem, we develop a modified alternating direction method of multipliers by combining the iteratively reweighted 1 algorithm and the majorization-minimization method. Lastly, for the case of reducing the staircase-like aspects and preserving edge features, numerous simulation examples, which are compared with other widely applied regularization models, have demonstrated that our presented strategy performs better for restoration of Poissonian images.

References

1 

Adam, T., Paramesran, R. ((2019) ). Image denoising using combined higher order non-convex total variation with overlapping group sparsity. Multidimensional Systems and Signal Processing, 30: (1), 503–527.

2 

Bardsley, J.M., Goldes, J. ((2011) ). Techniques for regularization parameter and hyper-parameter selection in PET and SPECT imaging. Inverse Problems in Science and Engineering, 19: (2), 267–280.

3 

Bayram, I. ((2011) ). Mixed norms with overlapping groups as signal priors. In: IEEE International Conference on Acoustics Speech and Signal Processing. IEEE, Piscataway, pp. 4036–4039.

4 

Bertsekas, D., Tsitsiklis, J. ((1997) ). Parallel and Distributed Computation: Numerical Methods. Athena Scientific, Belmont.

5 

Bonettini, S., Zanella, R., Zanni, L. ((2009) ). A scaled gradient projection method for constrained image deblurring. Inverse Problems, 25: (1), 015002.

6 

Bredies, K., Kunisch, K., Pock, T. ((2010) ). Total generalized variation. SIAM Journal on Imaging Sciences, 3: (3), 492–526.

7 

Candes, E.J., Wakin, M.B., Boyd, S.P. ((2008) ). Enhancing sparsity by reweighted 1 minimization. Journal of Fourier Analysis and Applications, 14: (5-6), 877–905.

8 

Chan, S.H., Khoshabeh, R., Gibson, K.B., Gill, P.E., Nguyen, T.Q. ((2011) ). An augmented Lagrangian method for total variation video restoration. IEEE Transactions on Image Processing, 20: (11), 3097–3111.

9 

Chan, T., Marquina, A., Mulet, P. ((2000) ). High-order total variation-based image restoration. SIAM Journal on Scientific Computing, 22: (2), 503–516.

10 

Chartrand, R. ((2007) ). Nonconvex regularization for shape preservation. In: IEEE International Conference on Image Processing. IEEE, Piscataway, pp. 293–296.

11 

Chowdhury, M.R., Qin, J., Lou, Y. ((2020) ). Non-blind and blind deconvolution under poisson noise using fractional-order total variation. Journal of Mathematical Imaging and Vision, 62: (9), 1238–1255.

12 

Figueiredo, M., Bioucas-Dias, J. ((2010) ). Restoration of Poissonian images using alternating direction optimization. IEEE Transactions on Image Processing, 19: (12), 3133–3145.

13 

Figueiredo, M., Bioucas-Dias, J., Nowak, R. ((2007) ). Majorization-minimization algorithms for wavelet-based image restoration. IEEE Transactions on Image Processing, 16: (12), 2980–2991.

14 

Gabay, D., Mercier, B. ((1976) ). A dual algorithm for the solution of nonlinear variational problems via finite element approximations. Computers & Mathematics with Applications, 2: (1), 17–40.

15 

Gilboa, G., Osher, S. ((2008) ). Nonlocal operators with applications to image processing. Multiscale Modeling & Simulation, 7: (3), 1005–1028.

16 

Hunter, D.R., Lange, K. ((2004) ). A tutorial on MM algorithms. American Statistician, 58: (1), 30–37.

17 

Liu, X. ((2016) ). Augmented Lagrangian method for total generalized variation based Poissonian image restoration. Computers & Mathematics with Applications, 71: (8), 1694–1705.

18 

Liu, X. ((2021) ). Nonconvex total generalized variation model for image inpainting. Informatica, 32: (2), 357–370.

19 

Liu, X., Huang, L. ((2012) ). Total bounded variation-based Poissonian images recovery by split Bregman iteration. Mathematical Methods in the Applied Sciences, 35: (5), 520–529.

20 

Lv, X.G., Jiang, L., Liu, J. ((2016) ). Deblurring Poisson noisy images by total variation with overlapping group sparsity. Applied Mathematics and Computation, 289: , 132–148.

21 

Lysaker, M., Lundervold, A., Tai, X.-C. ((2003) ). Noise removal using fourth order partial differential equation with applications to medical magnetic resonance images in space and time. IEEE Transactions on Image Processing, 12: (12), 1579–1590.

22 

Nikolova, M., Ng, M.K., Tam, C.P. ((2010) ). Fast nonconvex nonsmooth minimization methods for image restoration and reconstruction. IEEE Transactions on Image Processing, 19: (12), 3073–3088.

23 

Ochs, P., Dosovitskiy, A., Brox, T., Pock, T. ((2015) ). On iteratively reweighted algorithms for nonsmooth nonconvex optimization in computer vision. SIAM Journal on Imaging Sciences, 8: (1), 331–372.

24 

Oh, S., Woo, H., Yun, S., Kang, M. ((2013) ). Non-convex hybrid total variation for image denoising. Journal of Visual Communication and Image Representation, 24: (3), 332–344.

25 

Peyre, G., Fadili, J. ((2011) ). Group sparsity with overlapping partition functions. In: 19th European Signal Processing Conference. IEEE, Piscataway, pp. 303–307.

26 

Pham, C.T., Tran, T.T.T., Gamard, G. ((2020) ). An efficient total variation minimization method for image restoration. Informatica, 31: (3), 539–560.

27 

Sarder, P., Nehorai, A. ((2006) ). Deconvolution methods for 3-D fluorescence microscopy images. IEEE Signal Processing Magazine, 23: (3), 32–45.

28 

Selesnick, I.W., Chen, P.Y. ((2013) ). Total variation denoising with overlapping group sparsity. In: IEEE International Conference on Acoustics, Speech and Signal Processing. IEEE, Piscataway, pp. 5696–5700.

29 

Setzer, S., Steidl, G., Teuber, T. ((2010) ). Deblurring Poissonian images by split Bregman techniques. Journal of Visual Communication and Image Representation, 21: (3), 193–199.

30 

Wang, Z., Bovik, A.C., Sheikh, H.R., Simoncelli, E.P. ((2004) ). Image quality assessment: from error visibility to structural similarity. IEEE Transactions on Image Processing, 13: (4), 600–612.

31 

Zhang, L., Zhang, L., Mou, X., Zhang, D. ((2011) ). FSIM: a feature similarity index for image qualtiy assessment. IEEE Transactions on Image Processing, 20: (8), 2378–2386.