
Citation: Haohao Xu, Yuchen Gong, Xinyi Xia, Dong Li, Zhuangzhi Yan, Jun Shi, Qi Zhang. Gabor-based anisotropic diffusion with lattice Boltzmann method for medical ultrasound despeckling[J]. Mathematical Biosciences and Engineering, 2019, 16(6): 7546-7561. doi: 10.3934/mbe.2019379
[1] | Yihua Song, Chen Ge, Ningning Song, Meili Deng . A novel dictionary learning-based approach for Ultrasound Elastography denoising. Mathematical Biosciences and Engineering, 2022, 19(11): 11533-11543. doi: 10.3934/mbe.2022537 |
[2] | Hong-an Li, Min Zhang, Zhenhua Yu, Zhanli Li, Na Li . An improved pix2pix model based on Gabor filter for robust color image rendering. Mathematical Biosciences and Engineering, 2022, 19(1): 86-101. doi: 10.3934/mbe.2022004 |
[3] | Qian Zhang, Haigang Li, Ming Li, Lei Ding . Feature extraction of face image based on LBP and 2-D Gabor wavelet transform. Mathematical Biosciences and Engineering, 2020, 17(2): 1578-1592. doi: 10.3934/mbe.2020082 |
[4] | Yanyan Zhang, Jingjing Sun . An improved BM3D algorithm based on anisotropic diffusion equation. Mathematical Biosciences and Engineering, 2020, 17(5): 4970-4989. doi: 10.3934/mbe.2020269 |
[5] | Jimin Yu, Jiajun Yin, Shangbo Zhou, Saiao Huang, Xianzhong Xie . An image super-resolution reconstruction model based on fractional-order anisotropic diffusion equation. Mathematical Biosciences and Engineering, 2021, 18(5): 6581-6607. doi: 10.3934/mbe.2021326 |
[6] | Zhangrong Qin, Lingjuan Meng, Fan Yang, Chaoying Zhang, Binghai Wen . Aqueous humor dynamics in human eye: A lattice Boltzmann study. Mathematical Biosciences and Engineering, 2021, 18(5): 5006-5028. doi: 10.3934/mbe.2021255 |
[7] | Chenkai Chang, Fei Qi, Chang Xu, Yiwei Shen, Qingwu Li . A dual-modal dynamic contour-based method for cervical vascular ultrasound image instance segmentation. Mathematical Biosciences and Engineering, 2024, 21(1): 1038-1057. doi: 10.3934/mbe.2024043 |
[8] | Xiao Zou, Jintao Zhai, Shengyou Qian, Ang Li, Feng Tian, Xiaofei Cao, Runmin Wang . Improved breast ultrasound tumor classification using dual-input CNN with GAP-guided attention loss. Mathematical Biosciences and Engineering, 2023, 20(8): 15244-15264. doi: 10.3934/mbe.2023682 |
[9] | Yali Ouyang, Zhuhuang Zhou, Weiwei Wu, Jin Tian, Feng Xu, Shuicai Wu, Po-Hsiang Tsui . A review of ultrasound detection methods for breast microcalcification. Mathematical Biosciences and Engineering, 2019, 16(4): 1761-1785. doi: 10.3934/mbe.2019085 |
[10] | Gang Huang, Qianlin Ye, Hao Tang, Zhangrong Qin . A GPU accelerated study of aqueous humor dynamics in human eyes using the lattice Boltzmann method. Mathematical Biosciences and Engineering, 2023, 20(5): 8476-8497. doi: 10.3934/mbe.2023372 |
Speckle noise is a granular pattern that is commonly seen in coherent imaging systems, such as ultrasound (US), optical coherence tomography, and synthetic aperture radar imaging. It is a form of locally correlated multiplicative noise caused by constructive and destructive coherent interferences of sound or light echoes from randomly distributed scatters, whose resolution is beyond the capabilities of the imaging systems [1]. In medical ultrasonography, effective and efficient despeckling methods are required to guarantee the accuracy of diagnosis. The main purpose of despeckling is to reduce the speckle noise while preserving the details in images for further processing such as image segmentation, feature extraction and quantitative measurement. That is to say, ultrasound image despeckling is an essential preprocessing step for subsequent analysis.
Many different approaches to reducing ultrasound speckle noise have been proposed. Classic ultrasound despeckling methods are based on local statistics [2,3,4], such as the adaptive weighted median filter, Frost filter, and Lee filter, which can effectively reduce noise but may blur some details of tissues. Other methods are based on the anisotropic diffusion (AD) [5], and they can suppress noise and smooth an image [6]. However, whether they can keep or even enhance image details depends on whether the edge detector it uses can efficiently distinguish edges from noise [7].
The AD method, also known as the P-M model, uses partial differential equation (PDE) to filter an image step by step by iterated diffusion [8]. Unlike the traditional spatial filtering, that does not protect image edges and details, the AD can preserve or even enhance edges while eliminating noise. However, when a medical ultrasound image is seriously corrupted by speckle noise, the AD method cannot effectively distinguish image edges from noise, resulting in the unsatisfactory performance of noise reduction. The edge detectors in PDEs are critical to filtering. An appropriate edge detector for medical ultrasound images should be able to differentiate edges and noise effectively [9]. However, speckle noise is a multiplicative noise, which means that the gradient changes caused by noise may be equal to or even larger than that caused by edges. In the AD model, the gradient operator acts as the edge detector, but it is very sensitive to speckle noise; it is also the main reason why the AD cannot obtain acceptable results for ultrasonic image denoising [9,10,11].
We have recently proposed a robust edge detector called the Gabor edge detector based on the Gabor transform and embedded it into the AD's PDE to guide the diffusion. This improved method is called the Gabor-based anisotropic diffusion (GAD) [12]. Because the Gabor edge detector can distinguish edges from noise effectively, the GAD can not only suppress speckle noise, but also preserve the edges, structures and details in an ultrasound image [13,14]. However, the GAD requires the finite difference method to solve the PDE iteratively, and thus it is a time-consuming method, which limits its application in clinical practice.
Indeed, various existing AD filters including the GAD have a common drawback, the poor efficiency, because they use the finite difference discretization depending on an explicit scheme, which requires a very short time step to make the algorithm stable. Hence, many iterations are required and cause the entire procedure be rather time-consuming. Alternatively, the lattice Boltzmann method (LBM) is a numerical scheme for solving the PDE by constructing a simplified discrete microscopic dynamics to simulate the macroscopic model described by the PDE [1,15,16,17]. One large superiority of the LBM is that it is suitable for parallel computation [18,19]. Recently, the LBM has been used for solving image diffusion problems, including image denoising with the AD [20,21,22]. Thus, we speculate that the LBM may also have the potential for the GAD denoising.
In this paper, we propose using the LBM to fast solve the PDE of the GAD and thus derive a despeckling approach named the Gabor-based anisotropic diffusion coupled with the lattice Boltzmann method (GAD-LBM). In the following sections, we will show that the GAD-LBM not only has the advantages of the GAD including effective speckle noise reduction and detail preservation, but also has the advantages of fast computation speed, high parallelization, and good stability attributed to the LBM.
The two-dimensional Gabor kernels (i.e., functions) can be expressed as [23,24]:
ψ(x,y;v,θ)=|kv,θ|2σ2exp(−|kv,θ|2|z|22σ2)⋅[exp(ikv,θz)−exp(−σ22)] | (1) |
where v and θ are scales and directions of Gabor kernels, z = (x, y) is the spatial coordinates; σ is a constant related to the frequency bandwidth of the wavelet and |∙| denotes the norm operator. The wave vector is defined as:
kv,θ=(kmaxfv)⋅(cosθ,sinθ) | (2) |
where kmax is the maximum frequency, and f represents the kernel interval factor in the frequency domain. The spatial frequencydomain information at different scales and directions can be extracted by changing v and θ.
In the paper, the Gabor functions are defined at one scale and multiple directions, namely v = 0, and θ = θd = d ∙ 2π/D (d = 0, 1, ..., D – 1; D is the number of directions). Two-dimensional Gabor functions can be decomposed into real and imaginary parts. The imaginary parts are often used to compose the edge detector of images [12]. The imaginary part of the Gabor function gb can be expressed as follows:
gb(x,y;θd)=|kd|2σ2exp(−|kd|2|z|22σ2)sin(kdz) | (3) |
where kd = kmax(cosθd, sinθd). In this paper, we set σ = 2π, kmax = π/2 and D = 16 [24].
The Gabor transform of an image I(x, y) can be expressed by convolution between the image and the Gabor kernel:
Gd(x,y)=I(x,y)∗gb(x,y;θd) | (4) |
Gd(x, y) is the dth convoluted image resulted from the Gabor kernel at the direction θd. The details in the input image I(x, y) at the specified direction θd can be captured through the Gabor transform. Then the edge-enhanced image Gsd(x, y) by using the Gabor edge detector can be determined according to details from multiple directions:
Gsd(x,y)=√1D−1D−1∑d=0[Gd(x,y)]2 | (5) |
The GAD model can be built as the following PDE, which iteratively eliminates small variations in an image due to speckle noise and to preserve large variations due to edges:
∂I∂t=div[g(Gsd)⋅∇I] | (6) |
Here g(Gsd) is the diffusion coefficient, which controls the diffusion process that inhibits smoothing across edges. g(Gsd) is large where Gsd is small (namely where the edge is weak), and it can be expressed as:
g(Gsd)=11+(Gsd/k)2 | (7) |
where k is an edge magnitude threshold; generally, a large k-value produces a smoother result in a homogeneous region than a smaller one [25].
The LBM is built with a lattice together with the lattice vectors cα (α = 0, 1, …, q–1) along q directions. On each lattice node, there are a set of particles, consisting of a rest particle (α = 0) and q–1 moving particles [26,27]. Each particle has a particle density function Iα (α = 0, 1, …, q–1) ata vector direction cα [28]. Our research is based on a two-dimensional LBM model D2Q9 (2 dimensions and 9 directions) [29]. The lattice vectors of the D2Q9 are defined as:
cα={[0,0],whenα=0[cos(α−1)π2,sin(α−1)π2],whenα=1,2,3,4√2[cos(π(α−5)2+π4),sin(π(α−5)2+π4)],whenα=5,6,7,8 | (8) |
where α = 1, 2, 3, 4 shows the vertical and horizontal directions, α = 5, 6, 7, 8 indicates the directions of 45,135,225, and 315 degrees, respectively.
Iα(x, t) is the particle densityfunction (i.e. the image intensity) at the position x = [x, y] and time t with a velocity of cα. Its evolution equation is:
Iα(x+cαΔt,t+Δt)−Iα(x,t)=ω⋅[Ieqα(x,t)−Iα(x,t)] | (9) |
where ω represents the relaxation factor, and Ieqα(x, t) is the equilibrium distribution which is the predicted value of Iα(x, t).
The diffusion is conducted under the law of conservation:
I=q−1∑α=0Iα | (10) |
The equilibrium distribution function of D2Q9 is:
Ieqα=I/9,α=0,1,2,⋯,8 | (11) |
After setting the relaxation factor and equilibrium distribution function in Eq (9), we can solve the PDE with given initial values and certain boundary conditions.
The GAD is a competent despeckling model for medical ultrasonography which can effectively distinguish edges from speckle noise [12]. Moreover, the LBM is an algorithm with advantages of high stability, easy parallel implementation and fast calculation speed. The GAD-LBM model proposed in this paper combines the GAD and the LBM.
First, the relaxation factor ω in Eq (9) is not a constant across the image but a function of the image intensities denoted by ω(I), thus Eq (9) is rewritten as follows:
Iα(x+cαΔt,t+Δt)−Iα(x,t)=ω(I)⋅[Ieqα(x,t)−Iα(x,t)] | (12) |
We denote x = (x1, x2) and cα = (cα1, cα2). We then use a Taylor expansion on the left side of Eq (12) [26] and obtain
(ε2∂t+εcαi∂xi+ε22cαicαj∂xi∂xj)Iα+O(ε3)=−ω(I)(Iα−Ieqα) | (13) |
where ε is a small parameter, and i, j∈ {1, 2}. To derive the macroscopic equation, we use the Chapman-Enskog expansion [27] of Iα around Ieqα in powers of ε:
Iα=Ieqα+εϕα+O(ε2) | (14) |
Then we have [26]
Iα=I/9+εϕα+O(ε2) | (15) |
We substitute (15) into (13) and equate the ε term of both sides of Eq (13) and get
ϕα=−cαi∂xiI9ω(I) | (16) |
Combining Eq (15) and Eq (16), we obtain
Iα=I9−εcαi∂xiI9ω(I)+O(ε2) | (17) |
By taking the sum over α on both sides of Eq (13), we have
8∑α=0(ε2∂t+εcαi∂xi+ε22cαicαj∂xi∂xj)Iα+O(ε3)=0 | (18) |
Here we have used Eqs (10) and (11). By substituting (17) into (18) and equating the ε2-term of both sides in Eq (18), we get
∂tI−∂xiDij∂xjI=0 | (19) |
where the diffusion tensor
Dij=(1ω(I)−12)8∑0cαicαj9 | (20) |
Equation (19) is equivalent to
∂I∂t=div(g(ω(I))∇I) | (21) |
with the diffusion coefficient
g(ω(I))=23(1ω(I)−12) | (22) |
With regard to the GAD-LBM method, we use the Gabor transform to derive the edge-enhanced image Gsd via Eq (5) and the diffusion coefficient g(Gsd) via Eq (7). Then we obtain the diffusion equation of the D2Q9 for GAD-LBM as follows:
∂I∂t=div(23(1ω(Gsd)−12)∇I) | (23) |
where the relaxation factor is given by:
ω(Gsd)=21+3g(Gsd) | (24) |
The diffusion time t is an important parameter in the process of diffusion-based image filtering. If a fixed diffusion time is used to despeckle ultrasound images with different noise levels, the filtering method will lose flexibility, and the filtering efficacy and efficiency cannot be guaranteed. In order to improve the adaptive ability of the GAD-LBM, we automatically set the diffusion time by searching for a fully formed speckle region (FFSR) in the image, which is a homogeneous region containing no edges but only speckle noise [12].
Firstly, we divide the edge-detected image with the Gabor edge detector, Gsd(x, y), into several blocks in ms× ns size, and then a global search is carried out, from which a block with the smallest mean is selected as the FFSR. During the diffusion iterations in FFSR, the mean absolute error (MAE) of two successive filtered images (e.g., at the current time t and the previous time t–Δt) is computed:
MAEt=1ms×nsms∑i=1ns∑j=1|ItFFSR(i,j)−It−ΔtFFSR(i,j)| | (25) |
where ItFFSR and It–ΔtFFSR(i, j) are the gray levels of pixels (i, j) in the FFSR at two successive iterations. When the MAEt value is less than the threshold of 0.002, the diffusion will be automatically terminated.
The complete procedure of the GAD-LBM model can be summarized as eight steps.
Step 1: We take an initial noisy image I (x, y, t = 0) with a size of M × N to initialize the distribution functions at all directions:
Iα(x,y,t=0)=19⋅I(x,y,t=0) | (26) |
where α = 0, 1, …, 8 denoting 9 directions. We then search for the FFSR region in I (x, y, t = 0).
Step 2: We initialize the relaxation factor according to Eqs (5), (7) and (24).
Step 3: Collision step:
In+1α,i,j′=ωnα,i,j⋅[Ini,j/9−Inα,i,j] | (27) |
where n is the iteration time, and the x- and y-axis coordinates are i = 1, …, M and j = 1, …, N.
Step 4: Translation step:
In+11,i,j=In+11,i,j−1′(i=1,⋯,M;j=2,⋯,N) |
In+12,i,j=In+12,i−1,j′(i=2,⋯,M;j=1,⋯,N) |
In+13,i,j=In+13,i,j+1′(i=1,⋯,M;j=1,⋯,N−1) |
In+14,i,j=In+14,i+1,j′(i=1,⋯,M−1;j=1,⋯,N) |
In+15,i,j=In+15,i−1,j−1′(i=2,⋯,M;j=2,⋯,N−1) |
In+16,i,j=In+16,i−1,j+1′(i=2,⋯,M;j=1,⋯,N−1) |
In+17,i,j=In+17,i+1,j+1′(i=1,⋯,M−1;j=1,⋯,N−1) |
In+18,i,j=In+18,i+1,j−1′(i=1,⋯,M−1;j=2,⋯,N−1) |
In+10,i,j=In+10,i,j′(i=1,⋯,M;j=1,⋯,N) | (28) |
where In+1′ is the difference between In+1 and In.
Step 5: We deal with the boundary condition:
In+11,i,1=In+13,i,1′(i=1,⋅⋅⋅,M)In+12,i,j=In+14,1,j′(j=1,⋅⋅⋅,N)In+13,i,N=In+11,i,N′(i=1,⋅⋅⋅,M)In+14,M,j=In+12,M,j′(j=1,⋅⋅⋅,N)In+15,i,N=In+17,i,N′(i=1,⋅⋅⋅,M)In+15,M,j=In+17,M,j′(j=1,⋅⋅⋅,N−1)In+16,i,1=In+18,i,1′(i=1,⋅⋅⋅,M)In+16,M,j=In+18,M,j′(j=1,⋅⋅⋅,N)In+17,i,1=In+15,i,1′(i=1,⋅⋅⋅,M)In+17,1,j=In+15,1,j′(j=1,⋅⋅⋅,N)In+18,i,N=In+16,i,N′(i=1,⋅⋅⋅,M)In+18,1,j=In+16,1,j′(j=1,⋅⋅⋅,N−1) | (29) |
Step 6: We update the gray values of pixels:
In+1=8∑α=0In+1α | (30) |
Step 7: We update the edge-enhanced image Gsd in the (n+1)th iteration and the relaxation factor of pixels:
ωn+1i,j(Gsd)=21+3g(Gsd) | (31) |
Step 8: If the MAEt is still greater than the threshold, we change the diffusion time to t + Δt, and then return to Step 3 for the next iteration. Otherwise, we stop the diffusion, and the final output I is the despeckled image.
In this section, we present the experimental results on synthetic and clinical ultrasound images by using the proposed algorithm GAD-LBM and nine other algorithms for comparison including the Lee filter [30], AD [5], AD-LBM, speckle reducing anisotropic diffusion (SRAD) [31], Laplacian pyramid-based nonlinear diffusion (LPND) [32], complex diffusion (CD) [33], non-local means (NLM) [34], James-Stein typenon-local means (JSNLM) [35] and GAD (solved with finite difference) [12].
The parameters of all the existing methods were tuned in accordance with the values suggested in the publications. The computer used in our experiments was a server with the Intel Xeon CPU (E5-2620v2 2.1GHz) and 64GB RAM.
Clinical ultrasound images were acquired from human participants. All procedures performed in studies involving human participants were in accordance with the ethical standards of the institutional and/or national research committee and with the 1964 Helsinki declaration and its later amendments or comparable ethical standards. Informed consent was obtained from all individual participants included in the study.
We used a multiplicative model to add multiplicative speckle noise ns(x, y) to a synthetic noise-free image I(x, y) with a size of 256 × 256. The noise was in uniform distribution with a mean of zero and a variance of vn. Hence we generated an ultrasound image Y(x, y) contaminated by speckle:
Y(x,y)=[1+ns(x,y)]I(x,y) | (32) |
Firstly, we changed the vn-values from 0.03 to 0.21 in an interval of 0.03 in order to obtain synthetic images with various amounts of speckle noise. Simulated images with speckle variances of 0.03 and 0.12 were shown in Figure 1 and Figure 2 (entitled "Noisy"), respectively.
In Figure 1 and Figure 2, the GAD-LBM algorithm had the best filtering result through visual observation of the image. When the noise variance was 0.03, four methods including the AD-LBM, SRAD, GAD, and GAD-LBM yielded satisfactory results (Figure 1). However, when the variance of noise increased to 0.12, only the GAD and GAD-LBM seemed to obtain robust despeckling results, while the performance of the AD-LBM and SRAD degenerated (Figure 2). Compared with the GAD, the GAD-LBM appeared better in speckle noise suppression and edge preservation (Figure 1 and Figure 2).
In addition, we used three quantitative indices, i.e., the peak signal to noise ratio (PSNR), mean structural similarity (MSSIM), and Pratt's figure of merit (FOM), to evaluate the algorithms' capability of noise reduction, structure preservation and edge preservation, respectively [36,37,38].
The quantitative indices for synthetic images are listed in Table 1, where the values were calculated when the speckle variance vn was 0.12. From the table, we can know that the GAD-LBM largely enhanced the image quality measured by the PSNR, MSSIM and FOM, exceeding other nine methods in terms of all three indices.
PSNR (dB) | MSSIM | FOM | |
Noisy image | 14.553 | 0.113 | 0.224 |
Lee | 23.204 | 0.495 | 0.224 |
AD | 28.981 | 0.862 | 0.255 |
AD-LBM | 28.526 | 0.833 | 0.309 |
SRAD | 28.646 | 0.844 | 0.301 |
LPND | 29.782 | 0.901 | 0.248 |
CD | 23.109 | 0.502 | 0.223 |
NLM | 28.650 | 0.876 | 0.228 |
JSNLM | 28.331 | 0.812 | 0.318 |
GAD | 31.429 | 0.943 | 0.638 |
GAD-LBM | 31.484 | 0.948 | 0.744 |
We changed the variance of noise from 0.03 to 0.21 in an interval of 0.03 when synthesizing the images with the multiplicative model and compared the performance of all ten filtering methods. The despeckling results are illustrated in Figure 3, where we can see that the GAD-LBM and GAD outperformed other methods on almost every noise level in terms of every quantitative index.
Our experimental results show that when the variance of the speckle noise was relatively low (0.03 and 0.06; Figure 3), the GAD, GAD-LBM, AD and AD-LBM all achieved good PSNR values, indicating that the GAD-LBM and the traditional algorithms suppressed the noise well when the noise level was low. When the noise variances increased from 0.03 to 0.21, the PSNR values of the GAD-LBM and GAD were always above 28 dB, demonstrating they maintained excellent noise reduction performance at high noise levels. The FOM values of most methods decreased sharply with the increase of noise levels. Nevertheless, the FOM of the GAD-LBM still reached 0.67 when the noise increased to the highest variance of 0.21. The results of MSSIM show that the GAD-LBM was stable and always higher than 0.92 at a noise variance from 0.03 to 0.21, demonstrating the superiority of our method in structural preservation.
From Figure 4, we see that the computation time of the GAD-LBM was stable from 2 to 4s for denoising simulated noisy images with a variety of noise variances, which was about 1/50 to 1/20 of the GAD, indicating the advantage of the GAD-LBM in efficiency.
We also compared the GAD-LBM with nine methods on despeckling two clinical B-scan ultrasound images of breast tumor acquired from Huashan Hospital, Fudan University, Shanghai, China. The imaging device was the HI VISION Preirus system (Hitachi Medical, Tokyo, Japan) equipped with a linear array transducer. In Figure 5 and Figure 6, the yellow line in the original image is a sampling line, and we show both the two-dimensional image and the one-dimensional signal sampled from the line.
It can be seen from Figure 5 and Figure 6 that the GAD-LBM performed best and removed noise and preserved edges appropriately. In the denoised images by ten filtering methods, the speckle noise was suppressed to different extents. The Lee and the CD methods retained much noise while the other methods all smoothed the tumor. Among the ten methods, the GAD-LBM seemed to seek the best compromise between the noise reduction and the detail preservation. A sampling line is superimposed in the initial noisy image. From the plots of the intensities on the line, we can see that the GAD-LBM appropriately eliminated noise and smoothed intensities on the line while the other methods either over-smoothed or under-smoothed the intensities.
Table 2 shows the computation time of ten methods. It can be seen that it took 2 to 4s for the GAD-LBM to denoise a clinical ultrasound image, which was comparable to the Lee and LPND methods and much quicker than the GAD method. The computation time of the GAD-LBM was about 1/90 to 1/30 to that of the GAD, indicating the advantage of the GAD-LBM in efficiency.
Methods | Time (s) | |
Clinical image 1 | Clinical image 2 | |
Lee | 2.049 | 2.163 |
AD | 0.273 | 0.284 |
AD-LBM | 0.119 | 0.118 |
SRAD | 1.130 | 1.142 |
LPND | 2.197 | 2.315 |
CD | 0.128 | 0.153 |
NLM | 28.879 | 28.423 |
JSNLM | 0.024 | 0.027 |
GAD | 170.667 | 86.199 |
GAD-LBM | 2.751 | 3.233 |
Speckle noise corrupts ultrasound images and limits the signal-to-noise ratio. Moreover, the speckle noise is multiplicative, increasing the difficulty for noise suppression. In order to improve the feasibility and reliability of subsequent image analysis and interpretation, it is necessary to preserve or enhance the edge and texture of tissues while reducing speckle noise. However, the commonly used denoising methods cannot effectively denoise the speckle noise. The recently proposed GAD algorithm has a good performance for despeckling, but it is a time-consuming method and hence has limited applications in clinical practice.
In order to overcome the drawback of traditional algorithms, we combine the GAD with the LBM and propose the GAD-LBM model, leveraging the advantages of the GAD on edge preservation and the advantages of the LBM on fast parallel implementation. The GAD-LBM model achieves excellent results on both simulated and clinical images. Visual observation and quantitative comparison has revealed the improvement of the noise reduction, detail preservation, and calculation speed of the GAD-LBM compared with other nine methods. However, whether the despeckling method can be valuable for disease diagnosis has to be further validated in a future study. In addition, compared with the recently published methods, such as the nonlocal total variation [39] and other methods surveyed in [40], the GAD-LBM method has the advantage of computation speed on the premise of ensuring the quality of denoising. In our future work, we would combine these recent methods with AD and LBM and expect better results. We would also introduce higher order lattices [41,42] into the LBM models in future studies to further improve the despeckling performance.
The advantage of the GAD-LBM over the GAD is the computation speed (Figure 4 and Table 1). For synthetic and clinical images, the computation time of the GAD-LBM is about 1/90 to 1/20 of the GAD, demonstrating the superiority of the GAD-LBM in computational efficiency. From Figure 3, we have also found that although the PSNR and MSSIM are almost the same between the GAD-LBM and GAD, the FOM-values are different. It may be attributed to the stability of different numerical solutions to the diffusion. The LBM may derive more stable results for diffusion thus yield better results in FOMs than the finite difference.
For clinical US images, the GAD-LBM has showed a better balance between noise removal and detail preservation than other methods, and it has also demonstrated advantages in computational speed. Thus compared with other despeckling methods, the GAD-LBM can produce denoised images that could be more suitable for subsequent image analysis and interpretation, such as lesion detection, segmentation, feature extraction and intelligent diagnosis [43,44].
In this paper, we propose a new model called the GAD-LBM for despeckling US images. The experiments of filtering simulated and clinical US images have demonstrated that the GAD-LBM not only has excellent ability of noise reduction and edge preservation but also has advantages in computation efficiency.
The work was funded by the National Science Foundation of China (Nos. 61671281, 61911530249, 81627804).
The authors declare that they have no conflict of interest.
[1] | Y. H. Qian, D. D'Humières and P. Lallemand, Lattice BGK models for navier-stokes equation, Europhys. Lett., 17 (1992), 479. |
[2] | T. Loupas, W. N. McDicken and P. L. Allan, An adaptive weighted median filter for speckle suppression in medical ultrasonic images, IEEE Trans. Circuits Syst., 36 (1989), 129–135. |
[3] | V. S. Frost, J. A. Stiles, K. S. Shanmugan, et al., A model for radar images and its application to adaptive digital filtering of multiplicative noise, IEEE Trans. Pattern Anal. Machine Intell., 2 (1982), 157–166. |
[4] | J. S. Lee, Speckle suppression and analysis for synthetic aperture radar images, Opt. Eng., 25 (1986), 636–643. |
[5] | P. Perona and J. Malik, Scale-space and edge detection using anisotropic diffusion, IEEE Trans. Pattern Anal. Machine Intell., 12 (1990), 629–639. |
[6] | J. Wu, Y. Wang, J. Yu, et al., Intelligent speckle reducing anisotropic diffusion algorithm for automated 3-D ultrasound images, J. Opt. Soc. Am. A, 32 (2015), 248–257. |
[7] | W. Wojciech and P. Ewa, Granular filter in medical image noise suppression and edge preservation, Biocybern. Biomed. Eng., 39 (2019), 1–16. |
[8] | D. Chen, S. Maclachlan and M. Kilmer, Iterative parameter-choice and multigrid methods for anisotropic diffusion denoising, Siam J. Sci. Comput., 33 (2011), 2972–2994. |
[9] | E. J. Leavline and S. Sutha, Fast multiscale directional filter bank-based speckle mitigation in gallstone ultrasound images, J. Opt. Soc. Am. A, 31 (2014), 283–292. |
[10] | Y. Wang, J. Z. Cheng, D. Ni, et al., Towards personalized statistical deformable model and hybrid point matching for robust MR-TRUS registration, IEEE Trans. Med. Imaging, 35 (2015), 589–604. |
[11] | J. Liu, T. Z. Huang, Z. Xu, et al., High-order total variation-based multiplicative noise removal with spatially adapted parameter selection, J. Opt. Soc. Am. A, 30 (2013), 1956–1966. |
[12] | Q. Zhang, H. Han, C. Ji, et al., Gabor-based anisotropic diffusion for speckle noise reduction in medical ultrasonography, J. Opt. Soc. Am. A, 31 (2014), 1273–1283. |
[13] | Q. Huang, Y. Zheng, M. Lu, et al., A new adaptive interpolation algorithm for 3D ultrasound imaging with speckle reduction and edge preservation, Comput. Med. Imag. Graphics, 33 (2009), 100–110. |
[14] | X. Min, Y. Zhang, H. D. Cheng, et al., Automatic breast ultrasound image segmentation: A survey, Pattern Recognit., 79 (2018), 340–355. |
[15] | F. Higuera, S. Succi and R. Benzi, Lattice gas dynamics with enhanced collisions, Europhys. Lett., 9 (1989), 345. |
[16] | R. Benzi, S. Succi and M. Vergassola, Theory and application of the lattice Boltzmann equation, Phys. Rep, 222 (1992), 147. |
[17] | S. Succi, Lattice Boltzmann 2038, Europhys. Lett., 109 (2015), 50001. |
[18] | X. Shan and H. Chen, Lattice Boltzmann model for simulating flows with multiple phases and components, Phys. Rev. E, 47 (1993), 1815. |
[19] | S. Chen and G. D. Doolen, Lattice Boltzmann method for fluid flows, Annu. Rev. Fluid Mech., 30 (1998), 329–364. |
[20] | Y. Zhao, Lattice Boltzmann based PDE solver on the GPU, Vis. Comput., 24 (2008), 323–333. |
[21] | Q. Chang and T. Yang, A lattice Boltzmann method for image denoising, IEEE Trans. Image Process., 18 (2009), 2797–2802. |
[22] | H. Chen, D. Ni, J. Qin, et al., Standard plane localization in fetal ultrasound via domain transferred deep neural networks, IEEE J. Biomed. Health Inform., 19 (2015), 1627–1636. |
[23] | M. J. Lyons, J. Budynek and S. Akamatsu, Automatic classification of single facial images, IEEE Trans. Pattern Anal. Machine Intell., 21 (1999), 1357–1362. |
[24] | C. Liu and H. Wechsler, Gabor feature based classification using the enhanced fisher linear discriminant model for face recognition, IEEE Trans. Image Process., 11 (2002), 467–476. |
[25] | Y. Yue, M. M. Croitoru, A. Bidani, et al., Nonlinear multiscale wavelet diffusion for speckle suppression and edge enhancement in ultrasound images, IEEE Trans. Med. Imaging, 25 (2006), 297–311. |
[26] | B. Jawerth, P. Lin and E. Sinzinger, Lattice Boltzmann models for anisotropic diffusion of images, J. Math. Imaging Vis., 11 (1999), 231–237. |
[27] | M. Watari, What is the small parameter ε in the Chapman-Enskog expansion of the Lattice Boltzmann method?, J. Fluids Eng.,134 (2012), 011401. |
[28] | Y. Wang, C. S. Chua, Y. K. Ho, Face recognition from 2D and 3D images using 3D Gabor filters, Image Vis. Comput., 23 (2005), 1018–1028. |
[29] | W. Zhang and B. Shi, Application of lattice Boltzmann method to image filtering, J. Math. Imaging Vis., 43 (2012), 135–142. |
[30] | J. S. Lee, Speckle analysis and smoothing of synthetic aperture radar images, Comput. Graphics Image Process., 17 (1981), 24–32. |
[31] | Y. Yu and S. T. Acton, Speckle reducing anisotropic diffusion, IEEE Trans. Image Process., 11 (2002), 1260–1270. |
[32] | Y. Wu, B. Tracey, P. Natarajan, et al., James-Stein type center pixel weights for non-local means image denoising, IEEE Signal Process. Lett., 20 (2013), 411–414. |
[33] | Z. Wang, A. C. Bovik, H. R. Sheikh, et al., Image quality assessment: From error visibility to structural similarity, IEEE Trans. Image Process., 13 (2004), 600–612. |
[34] | A. Buades, B. Coll and J. M. Morel, A review of image denoising algorithms, with a new one, Multisc. Model. Simulat., 4 (2005), 490–530. |
[35] | Y. Zhang, H. D. Cheng, J. Huang, et al., An effective and objective criterion for evaluating the performance of denoising filters, Pattern Recognit., 45 (2012), 2743–2757. |
[36] | J. Yu, J. Tan and Y. Wang, Ultrasound speckle reduction by a SUSAN-controlled anisotropic diffusion method, Pattern Recognit., 43 (2010), 3083–3092. |
[37] | A. Buades, B. Coll, and J. M. Morel., A non-local algorithm for image denoising, 2005 IEEE Computer Society Conference on Computer Vision and Pattern Recognition (CVPR'05), 2 (2005), 60–65. Avaliable from: https://ieeexplore.ieee.org/abstract/document/1467423. |
[38] | G. Gilboa, N. Sochen, and Y. Y. Zeevi, Image enhancement and denoising by complex diffusion processes, IEEE Trans. Pattern Anal. Machine Intell., 26 (2004), 1020–1036. |
[39] | S. Liang, F. Yang, T. Wen, et al., Nonlocal total variation based on symmetric Kullback-Leibler divergence for the ultrasound image despeckling, BMC Med. Imag., 17 (2017), 57. |
[40] | X. Feng, X. Guo and Q. Huang, Systematic evaluation on speckle suppression methods in examination of ultrasound breast images, Applied Sci., 7 (2016), 37. |
[41] | G. Falcucci, G. Bella, G. Chiatti, et al., Lattice Boltzmann models with mid-range interactions, Commun. Comput. Phys., 2 (2007), 1071–1084. |
[42] | M. Sbragaglia, R. Benzi, L. Biferale, et al., Generalized lattice Boltzmann method with multirange pseudopotential, Phys. Rev. E, 75 (2007), 026702. |
[43] | J. Zhang, E. Lou, X. Shi, et al., A computer-aided Cobb angle measurement method and its reliability, J. Spinal Disord. Tech., 23 (2010), 383–387. |
[44] | Q. Huang, F. Zhang and X. Li, Machine learning in ultrasound computer-aided diagnostic systems: A survey, BioMed Res. Int., 2018 (2018), 1–10. |
1. | Muthukumaran Malarvel, Soumya Ranjan Nayak, Edge and region segmentation in high-resolution aerial images using improved kernel density estimation: A hybrid approach, 2020, 39, 10641246, 543, 10.3233/JIFS-191547 | |
2. | Niveditta Thakur, Nafis Uddin Khan, Sunil Datt Sharma, 2021, Chapter 34, 978-981-33-4581-2, 441, 10.1007/978-981-33-4582-9_34 | |
3. | Xiao Zou, Jintao Zhai, Shengyou Qian, Ang Li, Feng Tian, Xiaofei Cao, Runmin Wang, Improved breast ultrasound tumor classification using dual-input CNN with GAP-guided attention loss, 2023, 20, 1551-0018, 15244, 10.3934/mbe.2023682 | |
4. | Maria Chatrasingh, Cholatip Wiratkapun, Jackrit Suthakorn, A generalized closed-form solution for 3D registration of two-point sets under isotropic and anisotropic scaling, 2023, 51, 22113797, 106746, 10.1016/j.rinp.2023.106746 | |
5. | Jieyi Liu, Changchun Li, Liping Liu, Haobo Chen, Hong Han, Bo Zhang, Qi Zhang, Speckle noise reduction for medical ultrasound images based on cycle-consistent generative adversarial network, 2023, 86, 17468094, 105150, 10.1016/j.bspc.2023.105150 | |
6. | Ziqing Ma, Chang Yang, Shengzhu Shi, Zhichang Guo, Wenjuan Yao, Bibo Lu, Efficient SAV-Based Algorithms for Image Multiplicative Denoising with a Second Fundamental Form Regularizer, 2025, 103, 0885-7474, 10.1007/s10915-025-02819-y |
PSNR (dB) | MSSIM | FOM | |
Noisy image | 14.553 | 0.113 | 0.224 |
Lee | 23.204 | 0.495 | 0.224 |
AD | 28.981 | 0.862 | 0.255 |
AD-LBM | 28.526 | 0.833 | 0.309 |
SRAD | 28.646 | 0.844 | 0.301 |
LPND | 29.782 | 0.901 | 0.248 |
CD | 23.109 | 0.502 | 0.223 |
NLM | 28.650 | 0.876 | 0.228 |
JSNLM | 28.331 | 0.812 | 0.318 |
GAD | 31.429 | 0.943 | 0.638 |
GAD-LBM | 31.484 | 0.948 | 0.744 |
Methods | Time (s) | |
Clinical image 1 | Clinical image 2 | |
Lee | 2.049 | 2.163 |
AD | 0.273 | 0.284 |
AD-LBM | 0.119 | 0.118 |
SRAD | 1.130 | 1.142 |
LPND | 2.197 | 2.315 |
CD | 0.128 | 0.153 |
NLM | 28.879 | 28.423 |
JSNLM | 0.024 | 0.027 |
GAD | 170.667 | 86.199 |
GAD-LBM | 2.751 | 3.233 |
PSNR (dB) | MSSIM | FOM | |
Noisy image | 14.553 | 0.113 | 0.224 |
Lee | 23.204 | 0.495 | 0.224 |
AD | 28.981 | 0.862 | 0.255 |
AD-LBM | 28.526 | 0.833 | 0.309 |
SRAD | 28.646 | 0.844 | 0.301 |
LPND | 29.782 | 0.901 | 0.248 |
CD | 23.109 | 0.502 | 0.223 |
NLM | 28.650 | 0.876 | 0.228 |
JSNLM | 28.331 | 0.812 | 0.318 |
GAD | 31.429 | 0.943 | 0.638 |
GAD-LBM | 31.484 | 0.948 | 0.744 |
Methods | Time (s) | |
Clinical image 1 | Clinical image 2 | |
Lee | 2.049 | 2.163 |
AD | 0.273 | 0.284 |
AD-LBM | 0.119 | 0.118 |
SRAD | 1.130 | 1.142 |
LPND | 2.197 | 2.315 |
CD | 0.128 | 0.153 |
NLM | 28.879 | 28.423 |
JSNLM | 0.024 | 0.027 |
GAD | 170.667 | 86.199 |
GAD-LBM | 2.751 | 3.233 |