Next Article in Journal
An LEO Constellation Early Warning System Decision-Making Method Based on Hierarchical Reinforcement Learning
Previous Article in Journal
Lightweight and Energy-Aware Monocular Depth Estimation Models for IoT Embedded Devices: Challenges and Performances in Terrestrial and Underwater Scenarios
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Regularization Solver Guided FISTA for Electrical Impedance Tomography

1
School of Electronic Information and Automation, Tianjin University of Science and Technology, Tianjin 300457, China
2
College of Engineering, University of Alabama, Tuscaloosa, AL 35487, USA
*
Author to whom correspondence should be addressed.
Sensors 2023, 23(4), 2233; https://doi.org/10.3390/s23042233
Submission received: 10 January 2023 / Revised: 8 February 2023 / Accepted: 14 February 2023 / Published: 16 February 2023
(This article belongs to the Section Sensing and Imaging)

Abstract

:
Electrical impedance tomography (EIT) is non-destructive monitoring technology that can visualize the conductivity distribution in the observed area. The inverse problem for imaging is characterized by a serious nonlinear and ill-posed nature, which leads to the low spatial resolution of the reconstructions. The iterative algorithm is an effective method to deal with the imaging inverse problem. However, the existing iterative imaging methods have some drawbacks, such as random and subjective initial parameter setting, very time consuming in vast iterations and shape blurring with less high-order information, etc. To solve these problems, this paper proposes a novel fast convergent iteration method for solving the inverse problem and designs an initial guess method based on an adaptive regularization parameter adjustment. This method is named the Regularization Solver Guided Fast Iterative Shrinkage Threshold Algorithm (RS-FISTA). The iterative solution process under the L1-norm regular constraint is derived in the LASSO problem. Meanwhile, the Nesterov accelerator is introduced to accelerate the gradient optimization race in the ISTA method. In order to make the initial guess contain more prior information and be independent of subjective factors such as human experience, a new adaptive regularization weight coefficient selection method is introduced into the initial conjecture of the FISTA iteration as it contains more accurate prior information of the conductivity distribution. The RS-FISTA method is compared with the methods of Landweber, CG, NOSER, Newton-Raphson, ISTA and FISTA, six different distributions with their optimal parameters. The SSIM, RMSE and PSNR of RS-FISTA methods are 0.7253, 3.44 and 37.55, respectively. In the performance test of convergence, the evaluation metrics of this method are relatively stable at 30 iterations. This shows that the proposed method not only has better visualization, but also has fast convergence. It is verified that the RS-FISTA algorithm is the better algorithm for EIT reconstruction from both simulation and physical experiments.

1. Introduction

Electrical Impedance Tomography (EIT) [1] is a noninvasive tomographic technique that visualizes the conductivity distribution in the measurement area [2]. A set of excitation electrodes attached to the boundary inject an alternating current to construct a sensitive field, and then the responding voltages are measured by other sensors sequentially. The conductivity distribution of the measurement region is reconstructed by an appropriate tomography algorithm. With the advantages of being non-damaging, noninvasive, non-radiation, low-cost, a simple operation and providing rich functional information, electrical impedance tomography has been researched deeply in the biomedical and industrial fields [3]. In biomedical applications, EIT has been used for lung imaging, which is based on the principle of assessing recoverable alveolar collapse and overdistension by images obtained during end-expiratory positive pressure titration [4,5]. In addition, EIT has also been used to varying degrees in brain function, brain activity and tumor localization studies [6,7,8]. EIT is more advantageous in long-time monitoring with functional visualizations compared to computed tomography (CT) and magnetic resonance imaging (MRI) [9,10]. In industrial applications, it is mainly used for process monitoring, allowing real-time monitoring of the gas or liquid transported in the pipeline and a more accurate estimation of the flow rate [11].
Currently, the core problem of solving the inverse problem of EIT, i.e., image reconstruction, is finding a suitable image reconstruction algorithm to obtain an accurate image to describe the conductivity parameters and boundary features. In order to solve this problem, many image reconstruction methods have been studied in two categories, iterative and non-iterative methods.
The non-iterative methods include the linear back projection method (LBP), truncated singular value decomposition (TSVD), the D-bar method, the Tikhonov regularization method, and the statistical shape constrained reconstruction method, etc. The back projection method (BP) is widely used as a basic solving method with the advantage of fast imaging. However, the linear back projection method (LBP) [12] and the improved filtered back projection method (FBP) [13] can reconstruct the approximate conductivity parameters containing serious artifacts and significant errors. The truncated singular value decomposition (TSVD) [14] method decomposes the system into singular values and uses partial singular value eigenvectors to solve the inverse problem, which reduces the influence of unknown parameters on the stability of the solution process. It improves the quality of FBP imaging to some extent, but the selection of the number of singular values and the eigenvectors often depends on the positive problem model and human experience, so it is not widely applicable to the scenario. The D-Bar method [15] is a direct method for solving nonlinear inverse problems, which converts the Laplace equation into the Schrödinger equation by nonlinear variable substitution. The D-Bar method utilizes the nonlinear Fourier transform to invert the distribution of the dielectric permittivity within the electric field using the exponential form of the solution. This method can improve the reconstruction quality under complex boundary conditions because it does not depend on the accuracy of the forward problem model and does not require an approximate solution of the Jacobian matrix. However, the calculation of the nonlinear transformation often requires the calculation of the DtN mapping, and it is built on the interrupted electrode model, so there are also certain artifacts on the ROI boundary. The regularization methods [16,17] are to impose a suitable penalty function to constrain the solution space under the convex optimization paradigm, such as the Tikhonov regularization method, which is based on L2-norm and is prone to cause boundary smoothing, which makes artifacts exist in the reconstructed images. Another regularization method is the total variation regularization method, which has the advantage of preserving boundary features but the proper regularization coefficient needs to be set by human experience [18]. The Statistical Shape Constrained Reconstruction method (SSCR) [19] is an ideal method that fully utilizes structural prior information as an optimization penalty function, where an accurate convergent solution is difficult to calculate considering the large condition number of the Jacobian matrix, alleviating the risk of inversing the ill-conditioned system matrix. However, the SSCR method requires strict Lipschitz continuity and is often limited by complex boundary conditions.
Iterative methods include the Landweber method, the Newton-Raphson method, the conjugate gradient method (CG), the soft threshold iterative method (Iterative Shrinkage-Thresholding Algorithm (ISTA), the NOSER (Newton’s one-step error reconstructor) method, the fast soft threshold method (Fast Iterative Shrinkage-Thresholding Algorithm, or FISTA), etc. Landweber’s algorithm [20] continuously reduces the error between the computed and real results by iterative methods. Since the Landweber algorithm needs to choose the appropriate regularization function to ensure the convergence of the solution, it often relies on the a priori information and empirically chosen regularization parameters, so there are sometimes artifacts interfering in the reconstruction results. The Newton-Raphson method [21,22] uses a quadratic function approximation instead of the objective function to find the extremum of this quadratic function and uses it as the approximation of the minima of the objective function. However, the Newton-Raphson method needs to calculate the Hessian matrix of the objective function for each iteration, which is computationally intensive when there are more variables. The conjugate gradient method (CG) [23] is a method for solving nonlinear systems of equations, which uses two eigenvectors in the conjugate direction to continuously iterate to search for the optimal solution of the EIT inverse problem and converges faster. However, the CG algorithm requires the system matrix to be strictly square, and the system matrix of EIT is an approximate result, so this approximation error is amplified in the solution, and the reconstruction results contain artifactual information, which cannot be applied to quantitative analysis scenarios. The NOSER (Newton’s one-step error reconstructor) method [24] requires only the Newton-Raphson method’s first step, setting an initial conductivity, to obtain an approximate solution of the field conductivity distribution. However, the image reconstructed in this way can only reflect the location and size of the medium, not the shape of the medium. The soft threshold iterative method (ISTA) [25,26] is an extension of the gradient descent method, and the iterative process only considers the information of the current point for gradient estimation to update the iteration point; the optimization process is in the shape of a zigzag towards the minimal value point, and the convergence speed is relatively slow. The fast soft threshold iteration method (FISTA) [27,28,29,30] adds a Nesterov acceleration technique to the ISTA method, which consists of a linear combination of the current point and the previous point and uses an acceleration technique to re-estimate the gradient and update the iteration points, which speeds up the algorithm. Due to the characteristics of ill-posedness and nonlinearity in the image reconstruction problem, it leads to the loss of some boundary information and makes the reconstructed images contain some artifacts. Although iterative algorithms have alleviated the effects of nonlinearity and ill-posedness on image reconstruction to a certain extent, the spatial resolution of images is still a subject that many researchers have devoted themselves to studying.
In summary, various iterative or non-iterative algorithms have different principles, but a single reconstruction algorithm is often used in specific applications. In this paper, we fully consider incorporating the non-iterative algorithm adaptive TR into the iterative FISTA algorithm to solve the problem of artificial empirical setting of the initial conductivity matrix in the FISTA algorithm, i.e., the Regularization Solver Guided Fast Iterative Shrinkage-Thresholding Algorithm (RS-FISTA for short). The algorithm first uses the adaptive regularization coefficient method to obtain the initial conductivity matrix of the FISTA. This paper adopts a fast soft thresholding image reconstruction strategy based on regularized solutions. The initial solution obtained by using the regularization method contains more a priori information, reduces the dependence on human settings, improves the imaging quality, and accelerates the convergence speed of the FISTA algorithm.
The contents of this paper are organized as follows. Section 2 is an overview of the EIT sensing model, the forward problem, and the inverse problem. Section 3 is the methodology of the proposed RS-FISTA algorithm. Section 4 briefly introduces the compared algorithm and the evaluation metrics. Section 5 presents the imaging results of the simulation and physical model, and compares the different algorithms quantitatively. Section 6 is the discussion and conclusions.

2. EIT Sensing Mechanism and Mathematical Model

2.1. EIT Sensing Model

Taking a 2D EIT sensing model as an example, the measurement system of EIT is shown in Figure 1. The data acquisition protocol of EIT adopts the adjacent current excitation adjacent voltage measurement [31]. A specific collection method is as follows: the current excitation is applied to one adjacent electrode pair as the initial excitation electrode (1–2 is selected as the first pair of the excitation current source in Figure 1), and then two adjacent electrodes are selected successively to measure voltages as the measurement electrode (3–4, 4–5, 5–6,……, 14–15, 15–16 in Figure 1). Using 16 pairs of adjacent electrodes as the excitation electrode successively, a total of 208 measurements are collected, which will be used as measurement describing one frame cross section.
In Figure 1, 1 to 16 represent 16 titanium electrodes attached equally on the boundary at the same height. Ω(σ0) represents the measurement area with conductivity σ0. σ1 and σ2 represent the conductivity of different inclusions. represents the current injected by a pair of adjacent electrodes. represents the measured voltage between a pair of adjacent electrodes.
In the EIT mathematical model, the electromagnetic field distribution in the region to be measured satisfies Maxwell’s equations [32], and its partial differential equation is as follows
× ( σ ( x ) φ ( x ) ) = 0 , x Ω
where Ω is the measuring field, σ(x) and φ(x) represent the conductivity distribution and potential distribution in the measuring field, respectively. The unique solution of the differential Equation (1) can be obtained only under certain boundary conditions.
In the current excitation pattern, the response voltage at the boundary of the measured region is constrained by the Dirichlet boundary condition.
φ ( x ) = u ( x ) , x Ω \ L = 1 16 e L
The boundary current density vector of the measurement area satisfies the Neumann boundary condition, and the equation is as follows
σ ( x ) φ ( x ) n = 0 , x Ω \ L = 1 16 e L
where n is the outer normal vector on the boundary, and Ω represents the boundary information of the measurement region.
Because the current density vector on the electrode surface is unknown, the differential form of Ohm’s law cannot be directly used on the electrode. Therefore, the boundary condition in the form of the integral is adopted, that is, on the electrode, the integral of the current density vector on the electrode surface is equal to the size of the injected current, which can be expressed as follows
e L σ ( x ) × φ ( x ) n d S = I L , x e L , L = 1 , 2 , , 16
In EIT, the contact surface between the sensor and the measurement area usually has high impedance thin layers due to chemical reactions. The complete electrodes model (CEM) proposed by Somersalo et.al., is utilized [33,34,35]
φ ( x ) + ρ L σ ( x ) × φ ( x ) n = U L , x e L , L = 1 , 2 , , 16
where ρ L represents the contact impedance between the electrode and the contact surface, and UL represents the potential response at the L electrode.
Compared with the actual measurement, the boundary potential obtained by the CEM model with contact impedance has better consistency. To ensure the existence and uniqueness of the solution of Equation (1), it is necessary to guarantee the conservation of potential and charge in the EIT sensing model [36,37], namely
L = 1 16 U L = 0
L = 1 16 I L = 0

2.2. Forward Problem

Forward problem modeling methods include the finite element method (FEM) [38] and the boundary element method (BEM) [39]. The FEM divides the continuous measurement field into many discrete sub-areas (such as the triangle area), which can approximately represent the measuring field. The discrete form of the governing equation in Formula (1) is obtained by analyzing the conductivity and potential of each region, establishing the equations of each region, and combining them into a whole equation. Using FEM, the conductivity and voltage distribution in the measured field are written in discrete form as
σ ( x ) = i = 1 N σ σ i ϕ ( x ) , x Ω
φ ( x ) = i = 1 N φ φ k ψ ( x ) , x Ω
where σ(x) represents the conductivity value in the subdivision grid, φ(x) represents the potential in the mesh, ϕ (x) represents the nodal basis function of the conductivity, ψ(x) represents the nodal basis function of the potential, and and represent the number of subdivision regions obtained by FEM. Using the standard Galerkin discretization [40], the solution of the direct problem can be approximated to the solution of a system of linear equations, respectively.
Below, U(σ) is used to indicate that σ discretely maps positively to U. The additive Gaussian model is used for measurement error, and the observation model is
V = U ( σ ) + e
where V ∈ RM*1 represents the voltage value of the measured electrode, U(σ)∈RM*1 represents the direct problem operator (the solution of the direct problem is the calculated voltage), and e ∈ RM*1 represents the additive noise.
The inverse problem of EIT is the image reconstruction problem. The measurements and sensitivity matrix calculated from the forward problem are used to image the distribution of the parameters with conductivity. There exists a nonlinear relationship between the measurements and the conductivity distribution in the measurement field, as shown in Formula (10).

2.3. Inverse Problem

In general, the nonlinear functions that can be expanded using the Taylor series at some point can be approximated by linear combinations of the exponential function. Therefore, in the reference conductivity σ0, the Formula (11) can be obtained by the first order Taylor series expansion at
U = U 0 + A ( σ ) × ( σ σ 0 ) + O ( σ )
where A ( σ ) = d U ( σ ) d σ σ = σ 0 is the Jacobian matrix (matrix A ∈ RM*N), representing the differential of boundary voltage to conductivity. According to Geselowitz’s sensitivity theory [41], the Jacobian matrix is used to describe the changing relationship between measurements and the conductivity distribution, in which the elements are calculated as
A i j = j th φ u i . ψ u i d Ω
where i represents the electrode pair for the i-th adjacent current excitation adjacent voltage measurement, j represents the j-th pixel unit, φ u i represents the gradient vector of the input current of the excitation electrode of the i-th pair in each electric field unit, and ψ u i represents the gradient vector of the input current of the measurement electrode of the j-th pair in each electric field unit. After combining Formulas (11) and (12) and discrete approximation, the mathematical model of EIT inverse problem can be expressed as
y = A x + b
where y = U − U0, x = σ − σ0. y (matrix y ∈ RM*1) represents the difference between the boundary voltage value in different states and the boundary voltage value in the reference state. x (matrix x ∈ RN*1) represents the difference between the conductivity distribution in different states and the conductivity distribution in the reference state. b represents additive noise.
Since the mathematical model of the EIT inverse problem is ill-conditioned, Formula (10) cannot be uniquely solved and is usually calculated with the least squares error [42]. In order to prevent the least square problem from overfitting, a regularization term R(x) is added to the objective function, namely
x = arg min x 1 2 A x y 2 2 + R ( x )

3. Methodology

This section mainly introduces a new image reconstruction method, the RS-FISTA. The first part briefly introduces the FISTA method and analyzes the reconstruction process of the method. The second part briefly introduces the calculation method of regularization solver. The third part introduces the implementation process of the RS-FISTA.

3.1. FISTA Algorithm

When the regularization term R ( x ) uses the L1-norm constraint, the problem of Formula (14) can be converted into the LASSO problem (Least absolute shrinkage and selection operator, LASSO) [43], i.e.,
x ^ = arg min x 1 2 A x y 2 2 + λ x 1
where λ is the regularization coefficient, and λ > 0. Let f ( x ) = 1 2 A x y 2 2 , g ( x ) = x 1 . g : N is a continuous non-smooth convex function. f : N is a smooth convex function defined in 1 , 1 , that is, a continuously differentiable function with Lipschitz continuous gradient, i.e., f ( x ) f ( y ) L ( f ) x y , x , y N . The smallest Lipschitz constants of f is L ( f ) = 2 λ max ( A T A ) .

3.1.1. Non-Constrain LASSO Problem

Consider unconstrained optimization problems min x F ( x ) f ( x ) , x N . Normally, the gradient descent method
x k + 1 = x k t k f ( x k )
is used to solve the vector x k + 1 . First, f ( x ) = 1 2 A x y 2 2 performs the second-order Taylor expansion,
f ( x ) = 1 2 A x k y 2 2 + A T ( A x k y ) , x x k + 1 2 t k x x k 2
Assuming f ( x ) satisfies the Lipschitz continuity condition, i.e., L ( f ) , s.t. L ( f ) = sup x f ( x ) . Then there exists any L L ( f ) with f ( x ) = f ( y ) + f ( x k ) , x y + 1 2 t k x y 2 , x , y N . At this time, in the neighborhood of any iteration point x = x k , there is the following approximation
f ( x , x k ) = f ( x k ) + f ( x k ) , x x k + L 2 x x k 2
In the next step, using Proxinal regularization method, i.e., the point where the function f ( x ) obtains the minimum value at x = x k 1 is taken as the starting point of the next iteration x = x k , then the optimization problem is
x k = arg min x f ( x k ) + f ( x k ) , x x k + 1 2 t k x x k 2
where t k = 1 L . Equation (19) can be derived by the second-order Taylor expansion at x = x k 1 , where f(x) meets Lipschitz continuous constrain f ( x k ) f ( x k 1 ) 2 L ( f ) x k x k 1 2 .

3.1.2. Constrain LASSO Problem

When constraints are introduced, the optimization problem (15) can be written as min x F ( x ) f ( x ) + g ( x ) , x R N , then Equation (19) is rewritten as
x k = arg min x f ( x k 1 ) + f ( x k 1 ) , x x k 1 + 1 2 t k x x k 1 2 + λ x 1
After ignoring the constant term in Equation (20), we can obtain
x k = arg min x 1 2 t k x ( x k 1 t k f ( x k 1 ) ) 2 + λ x 1
Since the L1-norm is separable, the calculation of xk is simplified to solving the one-dimensional minimization problem for each of its components, which can be obtained through calculus
x k = Τ λ t k [ x k 1 t k f ( x k 1 ) ]
where Τ α : N N is the shrinkage operator, which is defined as Τ α ( x i ) = s i g n ( x i ) × max { x i a , 0 } , and α is the denoising parameter [44]. Literature [45] proves that the linear convergence rate of (21) is O ( 1 k ) . The expansion result of Equation (22) is
x k = Τ λ t k [ x k 1 2 t k A T ( A x k 1 y ) ]
where tk is a suitable step size.

3.1.3. Nesterov Accelerator

In order to speed up the convergence rate, the Nesterov accelerator is added to (23), where the calculation steps are as follows
x ( k ) = Τ α [ z ( k ) μ A T ( A z ( k ) y ) ] t ( k + 1 ) = 1 + 1 + 4 × ( t ( k ) ) 2 2 z ( k + 1 ) = x ( k ) + t ( k ) 1 t ( k + 1 ) ( x ( k ) x ( k 1 ) )
where μ = 1/L is a suitable step size, and L must be the upper bound of the maximum eigenvalue of ATA [46].
Literature [44] proves that, for any, there is
F ( x k ) F ( x * ) 2 β L ( f ) x 0 x * 2 ( k + 1 ) 2
where β = 1 is the constant search uber length, and β = η is the backtracking cruise step length. x* represents the solution when the algorithm convergence rate reaches O ( 1 k 2 ) . Therefore, the convergence rate of this algorithm is increased from O ( 1 k ) to O ( 1 k 2 ) .

3.2. Regularization Solver (RS)

In the FISTA algorithm, the initial matrix x(0) is selected as a fixed matrix and depends on human experience, which has great uncertainty. In this paper, based on the regularization idea, the solution can be solved by regularization, which can not only reduce the number of iterations, but also improve the solving accuracy of the iterative algorithm, so as to improve the spatial resolution of the image. Therefore, a penalty function based on the L2-norm constraint is used as the regularization factor in this paper, and its mathematical expression is
R ( θ ) = R ( x x 0 ) 2 2
where R is a particular continuous regularized matrix, and x0 is a hypothetical initial parameter based on the positive problem model. If R = I (identity matrix) and x0 = 0, the standard Tikhonov regularization mathematical expression of Formula (14) is
x ^ = arg min x 1 2 A x y 2 2 + λ I x 2 2
Define the objective function as
f ( x ) = 1 2 A x y 2 2 + λ I x 2 2
Then the first-order differential of the objective function is
d f ( x ) d x = A T A + λ I x A T y
Let the first-order differential be zero, the optimal solution of the objective function can be expressed as
x ^ = A T A + λ I 1 A T y
where matrix A∈RM*N represents the sensitivity matrix in the measurement field, and matrix x ^  ∈ RN*1 represents the conductivity distribution in the measurement field, and matrix y ∈ RM*1 represents the potential distribution in the measurement field, and λk represents the regularization coefficient.
In most cases, the regularization coefficient λ is evaluated according to the trial-and-error method or the “L” curve method, so the value taken out has great uncertainty. Therefore, a TR regularization method with adaptive regularization parameters is proposed in this paper. After each calculation of this method, the regularization coefficient λ will be adjusted according to the results of this (xk) and the expected (y), and then the new regularization parameters will be used to solve the solution of the next step, so that the value obtained is closer to the expected value. The formula for calculating the adaptive regularization coefficient λ can be expressed as
λ k + 1 = λ k x k A x k y 1
So that x k + 1 = A T A + λ k + 1 I 1 A T y . When the TR algorithm of adaptive regularization parameter iterates to an error less than 10−2, the initial matrix x(0) required by the FISTA algorithm is obtained.

3.3. Pseudo-Code of RS-FISTA

The pseudo-code of this Algorithm 1 is as follows
Algorithm 1 Regularization Solver Guided Fast Iterative Shrinkage Threshold Algorithm (RS-FISTA)
INPUT: Sensitivity matrix A, voltage y; parameters: denoising parameter α = 10−9, relative tolerance Epsilon = 10−5, maximum iterations Itermax.
  • Setting the initial value t(1) = 1, k = 1, error = 0
  • Calculate the regular resolution as the initial value of the algorithm x(0), z(1) = x(0)
  • Calculate the step size μ in the RS-FISTA method, μ = 1 L
  • If it does not reach the convergence criterion or the error is greater than the relative tolerance,
    (1)
    Calculate x(k), x ( k ) = Τ α [ z ( k ) μ A T ( A z ( k ) y ) ]
    (2)
    Update parameter t(k + 1) of the RS-FISTA method, t ( k + 1 ) = 1 + 1 + 4 × ( t ( k ) ) 2 2
    (3)
    Calculate z ( k + 1 ) , z ( k + 1 ) = x ( k ) + t ( k ) 1 t ( k + 1 ) ( x ( k ) x ( k 1 ) )
    (4)
    Calculate error, e r r o r = | y A x ( k ) |
    (5)
    k = k + 1
    end
OUTPUT: The calculated conductivity matrix x(k), the error between the actual voltage and the estimated voltage error.

4. Comparison Algorithms and Evaluation Metrics

4.1. Comparison Algorithms

4.1.1. Landweber Method

In EIT inverse problem, the conductivity distribution in the measurement field and the voltage at the electrode boundary are nonlinear problems. Moreover, the Landweber method is the most common method to solve nonlinear and ill-posed EIT problems [46]. The expression of the Landweber method is
x k + 1 = x k + λ A T ( y A x k )
where λ = 2 / ( λ max + λ min ) (λmax and λmin are the maximum and minimum positive special values of matrix ATA, respectively) [47]. In this article, the value of x0 is zero matrix.

4.1.2. Conjugate Gradient Method (CG Method)

The CG method takes x0 as the initial conductivity matric, calculates the error ω0 = y–Ax0, gives the first search direction as p0 = ω0, and then carries out the iterative operation. The main iterative formula for this method is as follows
a k = ( ω k , ω k ) ( A p k , p k ) g k + 1 = g k + a k p k ω k + 1 = ω k a k J p k β k = ( ω k + 1 , ω k + 1 ) ( ω k , ω k ) p k + 1 = ω k + 1 β k p k
where k = 1, 2, 3,…, n is the number of iterations, and the relationship between each corrected direction vector is conjugate, that is, piTApj = 0 (I ≠ j). In this article, the value of x0 is zero matrix.

4.1.3. Iterative Shrink Threshold Algorithm (ISTA)

The ISTA method formula is shown in (15). The ISTA method solves Formula (15) through iterative Formula (34), which is shown below
x ( k + 1 ) = Τ α [ x ( k ) μ A T ( A x ( k ) y ) ]
where μ = 1/L is a suitable step size, and L must be the upper bound of the maximum eigenvalue of ATA [48], such as L > λ max ( A T A ) . Tα is the shrink operator. For example, when R ( x ) = x 1 , the shrink operator is T α ( x ) = s o f t ( x , a ) , and s o f t ( x , a ) = s i g n ( x i ) × max { x i a , 0 } . α is a denoising parameter. In this article, µ = 1/(λmin + λmax) and the value of α is 10−9. The initial matrix is zero matrix.

4.1.4. NOSER Method

The NOSER method [24] is a fast static EIT algorithm based on the Newton method, but it does not require iteration and is only the first step of the Newton method, as shown in Formula (36)
E ( x ( 0 ) ) = y A x ( 0 ) 2 , F ( x ( 0 ) ) = E ( x ( 0 ) ) x i , i = 1 , 2 , , N , x = x ( 0 ) [ A ( x ( 0 ) ) ] 1 × F ( x ( 0 ) ) .
where x ( 0 ) represents the initial conductivity matrix, A ( x ( 0 ) ) represents the modified sensitivity matrix, and N represents the number of element divided in the measuring field. In this article, the value of x ( 0 ) is zero matrix.

4.1.5. Newton-Raphson Method

The Newton-Raphson method [21] is an iterative method of unconstrained minimization for solving nonlinear functions. The basic idea of this method is to use the function approximation to replace the objective function, in order to find the minimum point of the quadratic function and take it as the approximate value of the minimum point of the objective function. The iterative formula of this method is shown in (36)
x ( k + 1 ) = x ( k ) ( A T A + r I ) 1 A T ( A x ( k ) y )
where r stands for regularization parameter and I stands for unit diagonal matrix. In this article, the value of r is 0.1.

4.2. Evaluation Metrics

The three main metrics of structure similarity (SSIM), root mean square error (RMSE) and peak signal to noise ratio (PSNR) are commonly used to quantify and evaluate image quality. SSIM is used to measure the similarity of two images. RMSE is used to measure the deviation between the calculated value and the expected value. PSNR is used to measure the degree of image satisfaction. The mathematical expression is as follows
S S I M = 2 * 1 n i = 1 n r x i 1 n i = 1 n r x i * cov ( r x , r x * ) 1 n i = 1 n r x i 2 + 1 n i = 1 n r x i * 2 cov 2 ( r x , r x * )
R M S E = 1 n m j = 1 m i = 1 n p i x ( j , i ) p i x * ( j , i ) 2
P S N R = 10 log 10 ( 2 k 1 ) 2 R M S E 2
where rx* represents the conductivity distribution of the reconstructed image, and rx is the conductivity distribution of the real image. pix* represents the pixel value of the reconstructed image, and pix represents the pixel value of the real image. 2k − 1 represents the maximum pixel value of the image.
In order to effectively evaluate the performance of the RS-FISTA method, this paper uses the rates at which average metrics are changing compared with those of other comparison methods (Landweber, CG, NOSER, Newton-Raphson, ISTA and FISTA methods), and the expression is
C A M = | A V E R S - F I S T A A V E x | A V E x * 100 %
where AVERS-FISTA represents average metrics of the RS-FISTA method, and AVEx represents average metrics of the other comparison methods. The higher CAM means the better performances improved.

5. Experimentations and Results

The simulation experiments are implemented through the joint programming of MATLAB 2021a and COMSOL Multiphysics 5.6. The measurement field is triangulated by the finite element method (FEM) and obtains 3012 elements. Then the boundary voltage and sensitivity matrix of the field are obtained by using COMSOL Multiphysics 5.6 to solve the EIT forward problem. In the process of solving the EIT inverse problem, COMSOL Multiphysics and MATLAB are used to divide the measurement field into 64 × 64 mesh which could avoid inverse crime. During the simulation experiment, a tank with a radius of 0.095 m is set, and 16 electrodes, made of a Titanium material with 1 mm radius, are distributed on the wall of the tank at the same interval and height. A homogenous background with conducting is 1 S/m is set inside the tank, and the conductivity of the target object in the measurement field is 10−12 S/m. The excitation current amplitude is 4.5 mA, and the excitation current frequency is 100 kHz.

5.1. Simulation Experiments

The results of reconstructed images obtained by the RS-FISTA method compare with those obtained by common Landweber, CG, NOSER, Newton-Raphson, ISTA and FISTA methods. The simulation imaging results are shown in Figure 2. From the results, we can see that the method has a better ability to deal with the nonlinearity of the EIT inverse problem.
It can be seen from Figure 2 that with the increase in the number of inclusions in the observation domain, the artifacts surrounding the objects in comparisons are not only more obvious with the smaller bubbles, but characteristics of the sharp boundary and the inclusion size are also significantly blurred. In contrast, due to the superiority of the RS-FISTA with the optimized regularization parameter, which could improve the quality in the initial guess with more prior information, the visualizations with more clear boundaries and more accurate conductivities are much better than the NOSER method and other optimized methods where the initial guess is manually set.
The results of image quantitative metrics, SSIM, RMSE, and PSNR, are shown in Table 1. It can be seen from the results of SSIM, RMSE and PSNR of the RS-FISTA method compared with the other six methods in Table 1 that the RS-FISTA method has significantly improved the image quality. The rates of average metrics (model 1~model 10) changing comparing with those of other comparison methods are shown in Table 1 (such as Formula (40)). It can be concluded that the SSIM of RS-FISTA method is 25.71% higher than the Landweber method, 11.41% higher than the CG method, 8.83% higher than the NOSER method, 27.84% higher than the Newton-Raphson method, 38.08% higher than the ISTA method and 33.37% higher than the FISTA method. The RMSE of the RS-FISTA method is 35.14% higher than that of the Landweber method, 10.21% higher than that of the CG method, 9.93% higher than that of the NOSER method, 29.76% higher than that of the Newton-Raphson method, 38.36% higher than that of the ISTA method, and 40.28% higher than that of the FISTA method. The PSNR of RS-FISTA method is 10.16% higher than that of the Landweber method, 2.49% higher than that of the CG method, 2.93% higher than that of the NOSER method, 8.35% higher than that of the Newton-Raphson method, 12.64% higher than that of the ISTA method, and 13.4% higher than that of the FISTA method.

5.2. Tank Experiments

The boundary voltage signal acquisition equipment used in this paper is composed of the electrical impedance data acquisition system (EIT-DAS) and sensors attached on the tank. The system [49,50] is shown in Figure 3.
The DAS consists of a computer for data processing and image reconstruction, a data acquisition and signal processing module, and a tank with 16 titanium electrode sensors. In the experiment, 16 electrodes were distributed at the same interval and height on the tank (with a radius of 0.095 m) wall and uniform media (replaced by glass rods, and experimental data were obtained by changing the size, position, and number of objects) were placed in the tank. A proper concentration of NaCl was added to tap water to obtain the background conductivity of the experiment (the conductivity was set as 1 S/m), and the conductivity of the glass rod was approximately 0 S/m. During the experiment, the current with 4.5 mA amplitude and 100 kHz frequency is excited through the hardware. Then the voltage between the adjacent electrodes is measured to obtain the boundary voltage of the field. With the boundary voltage as the input value, image reconstruction was performed using the Landweber, CG, ISTA, FISTA, NOSER, Newton-Raphson and RS-FISTA methods. The result of image reconstruction is shown in Figure 3.
It can be seen from Figure 4, using other methods (such as Landweber, CG, NOSER, Newton-Raphson, ISTA and FISTA), with the increase of the number of inclusions in the observation domain, the position information of inclusions with small geometric diameter in the reconstructed image is more blurred, and the “transition area” between the background and the include is larger. However, because the RS-FISTA method uses the initial guess with prior information, the artifacts are less in reconstructions. So, compared with other optimized methods where the initial guess is manually set, this method can better display the location information of inclusions with a small diameter.
The results of image quantitative metrics, SSIM, RMSE, PSNR, are shown in Table 2. It can be seen from the results of SSIM, RMSE and PSNR of the RS-FISTA method compared with the other six methods in Table 2 that the RS-FISTA method has significantly improved the image quality. The rates of average metrics (tank 1~tank 5) changing compared with those of other methods are shown in Table 2 (such as Formula (40)). It can be seen from the comparison chart of evaluation indicators that the SSIM of RS-FISTA method is 24.26% higher than that of the Landweber method, 11.07% higher than that of the CG method, 9.38% higher than that of the NOSER method, 24.01% higher than that of the Newton-Raphson method, 35.80% higher than that of the ISTA method, and 38.16% higher than that of the FISTA method. The RMSE of the RS-FISTA method is 36.73% higher than that of the Landweber method, 21.08% higher than that of the CG method, 10.65% higher than that of the NOSER method, 36.83% higher than that of the Newton-Raphson method, 46.05% higher than that of the ISTA method, and 44.57% higher than that of the FISTA method. The PSNR of RS-FISTA method is 12.12% higher than that of the Landweber method, 4.66% higher than that of the CG method, 2.38% higher than that of the NOSER method, 9.29% higher than that of Newton-Raphson method, 16.31% higher than that of the ISTA method, and 14.87% higher than that of the FISTA method.

5.3. Noise Experiments

In order to test the robustness of the RS-FISTA method to noise with different signal to noise ratios (SNRs), different levels of Gaussian white noise (SNR = 60 dB, 50 dB, 40 dB, 30 dB) were added to the simulation experiment. In the experiment, models with different numbers were selected as experimental samples. The image reconstruction results of the experiment are shown in Figure 5.
It can be seen from the figure that when the RS-FISTA method’s SNR = Inf, 60 dB and 50 dB, the reconstructed image can better express the distribution of the inclusions in the original measurement field, and the reconstructed image has less artifact information. As the level of white Gaussian noise decreases, the position information of the inclusions begins to become blurred, but the position information of the inclusions can still be better expressed. In summary, it shows that the robustness of the RS-FISTA method is good, and even if the input signal contains noisy interference, the image reconstructed by the algorithm still has a good visualization effect.

6. Discussion and Conclusions

6.1. Experiments Analysis

In this paper, the results of RS are taken as the initial values, so that the initial values of the iterative method are closer to the optimal solution of the objective function. Therefore, the RS-FISTA method is used for image reconstruction. From the visual image, we can see that the reconstructed image has less artifacts, relatively accurate location information and clearer boundaries. From the quantitative metrics, we can see that the value of SSIM is improved, indicating that the shape information saved is relatively good. The value of RMSE is reduced which indicates that the distribution of conductivity is relatively accurate. The value of PSNR is improved, which shows that the visualization effect of the image is relatively good. In a word, the reconstructed image has good spatial resolution.

6.2. Discussion on Convergence Iterations

In order to verify the convergence speed of the RS-FISTA method in this paper, except that NOSER is a one-step iterative imaging method, the other six methods (Landweber, CG, ISTA, FISTA, Newton-Raphson and RS-FISTA) successively perform different times of iterative operations on the physical experimental model and compare the SSIM of the reconstructed images. The SSIM of the reconstructed images of the six imaging methods are shown in Figure 6.
It can be observed that within 20 iterations, the SSIM index of the RS-FISTA is only less than that of Newton-Raphson, but better than other methods. From 20 to 30 iterations, the SSIM index of the RS-FISTA increases rapidly, which is distinctly higher than the other five methods. After 30 iterations, the SSIM index of the RS-FISTA has a stable performance in SSIM and superior to the other methods. If you discount the complexity of different methods, the RS-FISTA method gives a satisfactory convergent efficiency.
The initial guess of the FISTA method is usually set according to experience, which has great uncertainty. The RS-FISTA method takes the result of the adaptive regularization solution as the initial guess. This has the advantage that the initial guess is closer to the optimal solution of the objective function, thereby reducing the number of iterations of the method. This method also introduces Nesterov acceleration technology. This acceleration technique first realizes an acceleration in the xk direction by the linear combination of one of the previous two points {xk, xk−1}, and then accelerates in the gradient direction of the function through the contraction operator, so that the method can quickly solve the optimal solution of the objective function. Other algorithms only accelerate in the gradient direction, so this method has faster iteration speed and fewer iterations than other methods.

6.3. Conclusions

In this paper, the RS-FISTA method is proposed to solve the problems of excessive artifact information and poor visualization effect in electrical impedance tomography. In this method, the TR regularization of the adaptive parameters is calculated as the initial value of the input, and the Nesterov acceleration technique is used to solve the problem of slow convergence of the reconstructed image method effectively. In this paper, the corresponding experiment is carried out, and the imaging effect and image evaluation metrics of the tank experiment are analyzed. The results show that compared with the methods of Landweber, CG, ISTA, FISTA, Newton-Raphson and NOSER, the reconstructed images not only have less artifact information and a better visualization effect, but also effectively improve the convergence speed of the method.

Author Contributions

Conceptualization, Q.W.; Methodology, Q.W., D.W. and Z.W.; Software, Q.W. and D.W.; Resources, D.W.; Writing—original draft, Q.W.; Writing—review & editing, Q.W., Z.W., X.Z., N.X. and L.L.; Visualization, Z.W.; Supervision, X.C.; Project administration, X.C.; Funding acquisition, X.C. All authors have read and agreed to the published version of the manuscript.

Funding

This research received no external funding.

Institutional Review Board Statement

The study do not require ethical approval.

Informed Consent Statement

Not applicable.

Data Availability Statement

No new data are created.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Adler, A.; Alistair, B. Electrical Impedance Tomography: Tissue Properties to Image Measures. IEEE Trans. Biomed. Eng. 2017, 64, 2494–2504. [Google Scholar] [PubMed]
  2. Wang, Q.; He, J.; Wang, J.; Li, X.; Duan, X.; Zhang, P.; Chen, X.; Sun, Y. An image reconstruction algorithm for electrical impedance tomography using Symkaczmarz based on structured sparse representation. Trans. Inst. Meas. Control. 2019, 41, 2803–2815. [Google Scholar] [CrossRef]
  3. Zhang, X.; Wang, Z.; Fu, R.; Wang, D.; Chen, X.; Guo, X.; Wang, H. V-Shaped Dense Denoising Convolutional Neural Network for Electrical Impedance Tomography. IEEE Trans. Instrum. Meas. 2022, 71, 1–14. [Google Scholar] [CrossRef]
  4. Costa, E.L.; Borges, J.B.; Melo, A.; Suarez-Sipmann, F.; Toufen, C.; Bohm, S.H.; Amato, M.B. Bedside estimation of recruitable alveolar collapse and hyperdistension by electrical impedance tomography. Intensive Care Med. 2009, 35, 1132–1137. [Google Scholar] [CrossRef] [PubMed]
  5. Shin, K.; Mueller, J. Calderón’s Method with a Spatial Prior for 2-D EIT Imaging of Ventilation and Perfusion. Sensors 2021, 21, 5635. [Google Scholar] [CrossRef] [PubMed]
  6. Holder, D. Electrical impedance tomography of brain function. In Proceedings of the 2008 World Automation Congress, Waikoloa, HI, USA, 28 September–2 October 2008; pp. 1–6. [Google Scholar]
  7. Scholz, B. Towards virtual electrical breast biopsy: Space-frequency MUSIC for trans-admittance data. IEEE Trans. Med. Imaging 2002, 21, 588–595. [Google Scholar] [CrossRef] [PubMed]
  8. Samorè, A.; Guermandi, M.; Placati, S.; Guerrieri, R. Parametric Detection and Classification of Compact Conductivity Contrasts with Electrical Impedance Tomography. IEEE Trans. Instrum. Meas. 2017, 66, 2666–2679. [Google Scholar] [CrossRef]
  9. Borijindargoon, N.; Ng, B.P. Hybrid sensitivity-correlation regularisation matrix for electrical impedance tomography. IET Sci. Meas. Technol. 2019, 13, 1092–1101. [Google Scholar] [CrossRef]
  10. Nguyen, D.M.; Qian, P.; Barry, T.; McEwan, A. The region-of-interest based measurement selection process for electrical impedance tomography in radiofrequency cardiac ablation with known anatomical information. Biomed. Signal Process. Control. 2020, 56, 101706. [Google Scholar] [CrossRef]
  11. Pellegrini, S.P.; Trigo, F.; Lima, R. Adaptive Kalman filter-based information fusion in electrical impedance tomography for a two-phase flow. Mech. Syst. Signal Process. 2021, 150, 107326. [Google Scholar] [CrossRef]
  12. Solomon, J.; Marin, D.; Roy Choudhury, K.; Patel, B.; Samei, E. Effect of radiation Dose reduction and reconstruction algorithm on image noise, contrast, resolution, and Detectability of subtle hypoattenuating liver lesions at Multidetector cT: Filtered Back Projection versus a Commercial Model—Based Iterative Reconstruction Algorithm. Radiology 2017, 284, 777–787. [Google Scholar] [PubMed] [Green Version]
  13. Liu, H.; Tan, C.; Ren, S.; Dong, F. Real-Time Reconstruction for Low Contrast Ultrasonic Tomography Using Continuous-Wave Excitation. IEEE Trans. Instrum. Meas. 2020, 69, 1632–1642. [Google Scholar] [CrossRef]
  14. Smirnova, A. On TSVD regularization for a Broyden-type algorithm. J. Inverse Ill-Posed Probl. 2018, 26, 551–564. [Google Scholar] [CrossRef]
  15. Hamilton, S.J.; Hauptmann, A. Deep D-Bar: Real-Time Electrical Impedance Tomography Imaging with Deep Neural Networks. IEEE Trans. Med. Imaging 2018, 37, 2367–2377. [Google Scholar] [CrossRef] [Green Version]
  16. Xu, Y.; Pei, Y.; Dong, F. An adaptive Tikhonov regularization parameter choice method for electrical resistance tomography. Flow Meas. Instrum. 2016, 50, 1–12. [Google Scholar] [CrossRef]
  17. Zhao, J.; Xu, Y.; Tan, C.; Dong, F. A fast sparse reconstruction algorithm for electrical tomography. Meas. Sci. Technol. 2014, 25, 085401. [Google Scholar] [CrossRef]
  18. González, G.; Huttunen, J.M.J.; Kolehmainen, V.; Seppänen, A.; Vauhkonen, M. Experimental evaluation of 3D electrical impedance tomography with total variation prior. Inverse Probl. Sci. Eng. 2016, 24, 1411–1431. [Google Scholar] [CrossRef]
  19. Ren, S.; Sun, K.; Liu, D.; Dong, F. A Statistical Shape-Constrained Reconstruction Framework for Electrical Impedance Tomography. IEEE Trans. Med. Imaging 2019, 38, 2400–2410. [Google Scholar] [CrossRef]
  20. Tian, W.; Sun, J.; Ramli, M.F.; Yang, W. Adaptive Selection of Relaxation Factor in Landweber Iterative Algorithm. IEEE Sens. J. 2017, 17, 7029–7042. [Google Scholar] [CrossRef]
  21. Rao, L.; He, R.; Wang, Y.; Yan, W.; Bai, J.; Ye, D. An efficient improvement of modified Newton-Raphson algorithm for electrical impedance tomography. IEEE Trans. Magn. 1999, 35, 1562–1565. [Google Scholar]
  22. Edic, P.M.; Isaacson, D.; Saulnier, G.J.; Jain, H.; Newell, J.C. An iterative Newton-Raphson method to solve the inverse admittivity problem. IEEE Trans. Biomed. Eng. 1998, 45, 899–908. [Google Scholar] [CrossRef]
  23. Miao, L.; Ma, Y.; Wang, J. ROI-Based Image Reconstruction of Electrical Impedance Tomography Used to Detect Regional Conductivity Variation. IEEE Trans. Instrum. Meas. 2014, 63, 2903–2910. [Google Scholar] [CrossRef]
  24. Cheney, M.; Isaacson, D.; Newell, J.C.; Simske, S.; Goble, J. NOSER: An algorithm for solving the inverse conductivity problem. Int. J. Imaging Syst. Technol. 1990, 2, 66–75. [Google Scholar] [CrossRef]
  25. Zibetti, M.V.; Helou, E.S.; Pipa, D.R. Accelerating Overrelaxed and Monotone Fast Iterative Shrinkage-Thresholding Algorithms With Line Search for Sparse Reconstructions. IEEE Trans. Image Process. 2017, 26, 3569–3578. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  26. Zibetti, M.V.; Pipa, D.R.; De Pierro, A.R. Fast and exact unidimensional L2–L1 optimization as an accelerator for iterative reconstruction algorithms. Digit. Signal Process. 2016, 48, 178–187. [Google Scholar] [CrossRef]
  27. Zhang, M.; Wu, Q.; Liu, Y.; Zheng, J. Optimization of Depth from Defocus Based on Iterative Shrinkage Thresholding Algorithm. In Proceedings of the 15th International Conference, Web Information Systems and Applications, WISA 2018, Taiyuan, China, 14–15 September 2018; Springer International Publishing: Cham, Switzerland, 2018; pp. 131–144. [Google Scholar]
  28. Javaherian, A.; Soleimani, M.; Moeller, K.; Movafeghi, A.; Faghihi, R. An accelerated version of alternating direction method of multipliers for TV minimization in EIT. Appl. Math. Model. 2016, 40, 8985–9000. [Google Scholar] [CrossRef] [Green Version]
  29. Liu, X.; Zhang, T.; Ye, J.A.; Tian, X.; Zhang, W.; Yang, B.; Dai, M.; Xu, C.; Fu, F. Fast Iterative Shrinkage-Thresholding Algorithm with Continuation for Brain Injury Monitoring Imaging Based on Electrical Impedance Tomography. Sensors 2022, 22, 9934. [Google Scholar] [CrossRef] [PubMed]
  30. Wang, J.; Han, B. Application of a class of iterative algorithms and their accelerations to Jacobian-based linearized EIT image reconstruction. Inverse Probl. Sci. Eng. 2020, 29, 1108–1126. [Google Scholar] [CrossRef]
  31. Barber, D.C.; Brown, B.H. Applied potential tomography. Sci. Instrum. 1984, 17, 723. [Google Scholar] [CrossRef]
  32. Cheng, K.S.; Isaacson, D.; Newell, J.C.; Gisser, D.G. Electrode models for electric current computed tomography. IEEE Trans. Biomed. Eng. 1989, 36, 918–924. [Google Scholar] [CrossRef] [Green Version]
  33. Cheney, M.; Isaacson, D.; Somersalo, E.J.; Isaacsone, E.L. Layer-stripping reconstruction algorithm for impedance imaging. In Proceedings of the 14th Annual International Conference of the IEEE Engineering in Medicine and Biology Society, Paris, France, 29 October–1 November 1992; pp. 1694–1695. [Google Scholar] [CrossRef]
  34. Djajaputra, D. Electrical Impedance Tomography: Methods, History and Applications. Med. Phys. 2005, 32, 2731. [Google Scholar] [CrossRef]
  35. Somersalo, E.; Cheney, M.; Isaacson, D. Existence and uniqueness for electrode models for electric current computed tomography. Siam J. Appl. Math. 1992, 52, 1023–1040. [Google Scholar] [CrossRef]
  36. Liu, D.; Gu, D.; Smyl, D.; Deng, J.; Du, J. B-Spline Level Set Method for Shape Reconstruction in Electrical Impedance Tomography. IEEE Trans. Med. Imaging 2020, 39, 1917–1929. [Google Scholar] [CrossRef]
  37. Grychtol, B.; Adler, A. FEM electrode refinement for electrical impedance tomography. In Proceedings of the 35th Annual International Conference of the IEEE Engineering in Medicine and Biology Society (EMBC), Osaka, Japan, 3–7 July 2013; pp. 6429–6432. [Google Scholar]
  38. Vauhkonen, P.J.; Vauhkonen, M.; Savolainen, T.; Kaipio, J.P. Three-dimensional electrical impedance tomography based on the complete electrode model. IEEE Trans. Biomed. Eng. 1999, 46, 1150–1160. [Google Scholar] [CrossRef]
  39. Aykroyd, R.G.; Cattle, B.A. A boundary-element approach for the complete-electrode model of EIT illustrated using simulated and real data. Inverse Probl. Sci. Eng. 2007, 15, 441–461. [Google Scholar] [CrossRef]
  40. Liu, D.; Kolehmainen, V.; Siltanen, S.; Laukkanen, A.M.; Seppänen, A. Nonlinear Difference Imaging Approach to Three-Dimensional Electrical Impedance Tomography in the Presence of Geometric Modeling Errors. IEEE Trans. Biomed. Eng. 2016, 63, 1956–1965. [Google Scholar] [CrossRef]
  41. Geselowitz, D.B. An application of electrocardiographic lead theory to impedance plethysmography. IEEE Trans. Biomed. Eng. 1971, 18, 38–41. [Google Scholar] [CrossRef]
  42. Yang, W.Q.; Spink, D.M.; York, T.A.; McCann, H.J.M.S. An image-reconstruction algorithm based on Landweber’s iteration method for electrical-capacitance tomography. Meas. Sci. Technol. 1999, 10, 1065–1069. [Google Scholar] [CrossRef]
  43. Tibshirani, R.J. The Lasso Problem and Uniqueness. Electron. J. Stat. 2013, 7, 1456–1490. [Google Scholar] [CrossRef]
  44. Combettes, P.L.; Wajs, V.R. Signal recovery by proximal forward-backward splitting. Soc. Ind. Appl. Math. 2005, 4, 1168–1200. [Google Scholar] [CrossRef] [Green Version]
  45. Amir, B.; Marc, T. A Fast Iterative Shrinkage-Thresholding Algorithm for Linear Inverse Problems. SIAM J. Imaging 2009, 2, 183–202. [Google Scholar]
  46. Gregor, K.; LeCun, Y. Learning Fast Approximations of Sparse Coding. In Proceedings of the 27th International Conference on Machine Learning, Haifa, Israel, 21–24 June 2010; Volume 10, pp. 399–406. [Google Scholar]
  47. Yan, C.M.; Liu, X.M. Improved image reconstruction of Landweber capacitance tomography based on dual cycle. J. Sens. Technol. 2022, 35, 107–113. [Google Scholar]
  48. Han, G.; Qu, G.; Wang, Q. Weighting Algorithm and Relaxation Strategies of the Landweber Method for Image Reconstruction. Math. Probl. Eng. 2018, 2018, 1–19. [Google Scholar] [CrossRef] [Green Version]
  49. Chen, X.; Chang, X. Feature Extraction of Lung Ventilation by Biomedical Electrical Impedance Tomography. In Proceedings of the 2017 IEEE International Conference on Imaging Systems and Techniques (IST), Beijing, China, 18–20 October 2017; pp. 1–5. [Google Scholar]
  50. Chen, X.; Wang, Z.; Zhang, X.; Fu, R.; Wang, D.; Zhang, M.; Wang, H. Deep Autoencoder Imaging Method for Electrical Impedance Tomography. IEEE Trans. Instrum. Meas. 2021, 70, 1–15. [Google Scholar] [CrossRef]
Figure 1. EIT simulation model measurement system.
Figure 1. EIT simulation model measurement system.
Sensors 23 02233 g001
Figure 2. Simulation imaging results of different algorithms.
Figure 2. Simulation imaging results of different algorithms.
Sensors 23 02233 g002
Figure 3. TUST-EIT Electrical Impedance Imaging System.
Figure 3. TUST-EIT Electrical Impedance Imaging System.
Sensors 23 02233 g003
Figure 4. Imaging results of bucket experiment with different algorithms (the numbers 2–4 represent the diameter of the inclusions).
Figure 4. Imaging results of bucket experiment with different algorithms (the numbers 2–4 represent the diameter of the inclusions).
Sensors 23 02233 g004
Figure 5. Image reconstruction results of noise experiment.
Figure 5. Image reconstruction results of noise experiment.
Sensors 23 02233 g005
Figure 6. The SSIM variation with iterations of different methods (Use red and purple vertical lines to divide the number of iterations into three zones).
Figure 6. The SSIM variation with iterations of different methods (Use red and purple vertical lines to divide the number of iterations into three zones).
Sensors 23 02233 g006
Table 1. Imaging evaluation metrics of simulation experiments of different methods.
Table 1. Imaging evaluation metrics of simulation experiments of different methods.
Model 1Model 2Model 3Model 4Model 5Model 6Model 7Model 8Model 9Model 10AverageCAM (%)
SSIM Landweber0.63140.65600.46100.47550.63180.49500.57800.61060.55710.69580.5792 25.71
CG0.73960.70600.66270.65030.59200.59120.62850.60540.62200.73770.6535 11.41
NOSER0.81590.68720.62690.64810.65460.59690.62610.63110.65050.75330.6691 8.83
Newton-Raphson0.81390.68850.64840.55590.49510.60090.51340.59200.41220.37510.5695 27.84
ISTA0.54070.60640.45440.47340.46390.50680.59470.60110.48100.55060.5273 38.08
FISTA0.67760.52930.45720.47070.62410.48980.41770.59980.53150.66170.5459 33.37
RS-FISTA0.86420.81860.68240.76820.70020.67090.64670.66180.66290.80520.7281
RMSE Landweber4.15123.92049.53368.09224.77128.02475.06584.49825.94774.62885.8634 35.14
CG2.20043.17693.39184.13135.52836.41584.32244.84714.78034.54984.3344 10.21
NOSER3.09713.52653.91074.26724.40066.41834.22854.15264.51114.69804.3211 9.93
Newton-Raphson3.08863.51073.25705.71597.55095.87775.90014.47148.84497.11955.533729.67
ISTA3.57974.40909.68827.19627.73747.01514.68174.69177.30176.84066.3141 38.36
FISTA3.51576.35359.63698.80764.88427.65748.51804.46236.49004.84576.5171 40.28
RS-FISTA2.07163.15383.21884.11234.31554.86554.19004.03504.43234.52413.8919
PSNR Landweber35.7670000336.264128.545629.969534.558330.042334.037935.070032.643835.403433.2302 10.16
CG41.280738.090837.522135.809133.278931.985835.259934.421234.541734.97135.7161 2.49
NOSER38.311837.183836.285835.52835.260731.982435.607135.764535.045134.692535.5662 2.92
Newton-Raphson38.335637.222937.874532.989130.570832.746632.713735.121929.196931.081833.7854 8.35
ISTA37.053935.244028.405930.988730.358931.210234.722834.704230.862331.42932.4980 12.64
FISTA37.210532.070528.452129.233634.354930.449229.524035.139631.886034.423632.2744 13.42
RS-FISTA41.804838.154237.976935.849035.430134.388335.686536.014035.198235.562836.6065
Table 2. Experimental evaluation metrics for imaging results of 7 different methods.
Table 2. Experimental evaluation metrics for imaging results of 7 different methods.
Tank 1Tank 2Tank 3Tank 4Tank 5AverageCAM (%)
SSIMLandweber0.59580.65970.52880.57670.55740.583724.26
CG0.79850.5870.60810.69050.5810.65311.07
NOSER0.8020.63650.60420.680.59290.66319.38
Newton-Raphson0.80640.51740.65320.39320.55420.584924.01
ISTA0.43970.62650.50550.56570.5330.534135.8
FISTA0.68570.60270.4420.45660.43790.52538.16
RS-FISTA0.81880.71250.6790.71660.69960.7253
RMSELandweber6.21264.28445.91185.58375.2025.438936.73
CG2.36937.10534.5793.80173.94824.360721.08
NOSER2.31174.5884.70493.70143.95063.851310.65
Newton-Raphson2.41788.16394.08468.54544.02665.447736.83
ISTA9.5064.70786.16175.79655.72236.378946.05
FISTA3.34965.03917.12457.62137.90636.208244.57
RS-FISTA2.30313.68834.04523.55593.61393.4413
PSNRLandweber32.265335.493132.696533.192433.807433.490912.12
CG40.638631.099134.915336.531336.202935.87744.66
NOSER40.852134.898334.679736.763636.197536.67842.38
Newton-Raphson40.462329.892835.907729.496136.03234.35829.29
ISTA28.570934.674532.336732.867532.979532.285816.31
FISTA37.63134.083831.075730.490230.171332.690414.87
RS-FISTA40.884436.794235.99237.111836.971337.5507
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Wang, Q.; Chen, X.; Wang, D.; Wang, Z.; Zhang, X.; Xie, N.; Liu, L. Regularization Solver Guided FISTA for Electrical Impedance Tomography. Sensors 2023, 23, 2233. https://doi.org/10.3390/s23042233

AMA Style

Wang Q, Chen X, Wang D, Wang Z, Zhang X, Xie N, Liu L. Regularization Solver Guided FISTA for Electrical Impedance Tomography. Sensors. 2023; 23(4):2233. https://doi.org/10.3390/s23042233

Chicago/Turabian Style

Wang, Qian, Xiaoyan Chen, Di Wang, Zichen Wang, Xinyu Zhang, Na Xie, and Lili Liu. 2023. "Regularization Solver Guided FISTA for Electrical Impedance Tomography" Sensors 23, no. 4: 2233. https://doi.org/10.3390/s23042233

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop