Next Article in Journal
Quantification of Arm Swing during Walking in Healthy Adults and Parkinson’s Disease Patients: Wearable Sensor-Based Algorithm Development and Validation
Next Article in Special Issue
Deep Learning-Based Spread-Spectrum FGSM for Underwater Communication
Previous Article in Journal
The Measurement of Nanoparticle Concentrations by the Method of Microcavity Mode Broadening Rate
Previous Article in Special Issue
A Survey on Underwater Wireless Sensor Networks: Requirements, Taxonomy, Recent Advances, and Open Research Challenges
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Two-Tier PSO Based Data Routing Employing Bayesian Compressive Sensing in Underwater Sensor Networks

1
School of Computer Science and Engineering, Central South University, Changsha 410083, China
2
School of Electronics and Information Technology, Sun Yat-Sen University, Guangzhou 510275, China
*
Author to whom correspondence should be addressed.
Sensors 2020, 20(20), 5961; https://doi.org/10.3390/s20205961
Submission received: 10 September 2020 / Revised: 12 October 2020 / Accepted: 15 October 2020 / Published: 21 October 2020
(This article belongs to the Special Issue Underwater Sensor Networks)

Abstract

:
Underwater acoustic sensor networks play an important role in assisting humans to explore information under the sea. In this work, we consider the combination of sensor selection and data routing in three dimensional underwater wireless sensor networks based on Bayesian compressive sensing and particle swarm optimization. The algorithm we proposed is a two-tier PSO approach. In the first tier, a PSO-based clustering protocol is proposed to synthetically consider the energy consumption and uniformity of cluster head distribution. Then in the second tier, a PSO-based routing protocol is proposed to implement inner-cluster one-hop routing and outer-cluster multi-hop routing. The nodes selected to constitute i-th effective routing path decide which positions in the i-th row of the measurement matrix are nonzero. As a result, in this tier the protocol comprehensively considers energy efficiency, network balance and data recovery quality. The Bayesian Cramér-Rao Bound (BCRB) in such a case is analyzed and added in the fitness function to monitor the mean square error of the reconstructed signal. The experimental results validate that our algorithm maintains a longer life time and postpones the appearance of the first dead node while keeps the reconstruction error lower compared with the cutting-edge algorithms which are also based on distributed multi-hop compressive sensing approaches.

1. Introduction

1.1. Motivation

In recent decades, the research on wireless sensor networks (WSNs) has been a hotspot for numerous applications, such as, environment monitoring [1], smart cities [2,3], military monitoring [4], maritime resource gathering [5] and health-care surveillance [6].
As maritime rights and interests are paid more and more attention, underwater wireless sensor networks (UWSNs), an important extension of WSNs into ocean, is of great value in various application fields, such as, oceanographic information collection, hydrological and environmental monitoring, resources exploration, disaster forecast, underwater navigation, military defense, and etc. [7]. For UWSNs, there exist two kinds of topological structures, two dimensional network and three dimensional network. In this work, we study the three dimensional UWSNs, with which all nodes are deployed at different depths in the ocean.
Generally, in WSNs, including UWSNs, the information from all sensor nodes, which are equipped with limited power battery, are gathered to the sink node. When the power of the node is used up, the node expires. While most nodes died, the sink node is no longer able to gain necessary information from common nodes. Considering the fact that the nodes are hard to recharge, energy consumption remains a key factor that affects the whole network lifetime. On the other hand, in underwater scenario, as the network usually occupies large area and the effective transmission semidiameter is limited, those nodes who might not transfer the signal to sink node in one hop will need relay nodes. As a result, to design an efficient data routing algorithm for UWSN, it is vital to reduce the processing complexity and traffic overhead and meanwhile ensure that the data are collected efficiently. Wang et al. [8] render a layering algorithm which divides nodes to different parts according to their depth and data are forwarding based on opportunistic directional forwarding strategy. Guan et al. [9] improved opportunistic routing by adding distance-vector. The algorithm uses a query mechanism to establish the distance vectors for sensor nodes, then opportunistic routing is developed to forward packet based on the distance vectors. Further studies tend to cluster all nodes in the network, and only transmit the merged message in the cluster head to the sink node. Common nodes just need to transmit their data to their cluster heads (CHs) in one hop. For instance, clustering is added as one stage in [10] to save energy better. This strategy cuts down the energy-consumption efficiently. In [11], clustering and CH transmission are introduced as well. After the formation of cluster and selection of CH, the courier nodes are deployed into the clusters to collect the aggregated data from the CHs, and the visiting tour is scheduled based on the Decisional Welzl’s algorithm.
However, the works above do not consider the facts that in UWSN, while the sensor nodes are deployed to measure environmental data, for example, maritime temperatures, the signals they collect usually possess spatial correlations that induce sparsity into practical application. Based on such a fact, we comprehensively consider the routing strategy and the data sparsity to save energy even further. In such contexts, compressive sensing (CS) is adopted to reduce communication cost while also preserve information precisely. In this paper, we propose a CS based schedule which simultaneously considers routing and nodes selection for overall data reconstructions at the sink node for 3-D UWSNs. We use Particle Swarm Optimization (PSO) to optimize both the clustering and routing protocols design while the factors consisting of fitness functions consist of signal recovery quality, energy consumption, network balance and etc.

1.2. Related Work

CS, which unifies sampling and compression, has been enthusiastically promoted and studied [12,13]. It states that when the original signal is sparse itself or sparse on some basis, we can reconstruct it from compressed measurements. Making use of its advantages on simple encoding and efficient compressing, many researchers apply CS in WSN to achieve advanced compression compared with conventional compression algorithms [14,15,16]. CS could also be utilized for sensor selection; that is, only part of nodes will be chosen to transmit the product of its data with a random coefficient to the sink [17,18,19]. In the context that all nodes transmitted their data directly to the sink node in one hop, Hwang et al. [20] propose both centralized and decentralized algorithms for sensor selection under multi-variated noise condition. In [21], a tree-based algorithm named CDG is designed to reduce the payload falling on nodes close to the BS. In [22,23], a WSN is partitioned into clusters. Sensor readings are sent to CHs and the CHs send the received data to the BS. However, the measurement matrices they adopt are all full Gaussian ones which consume more power than the sparse measurement matrix used in our work. In the other word, they do not combine the routing and nodes selection with the help of CS.
PSO is a computational method that can be used to improve the optimization of candidate solutions through iteration. The way to adopt PSO for data routing [24] has been studied in several literatures [25,26,27]. Ref. [25] proposes a novel bi-velocity discrete PSO approach which extends PSO from the continuous version to the binary or discrete domain to find routing paths for WSN. Tukisi et al. [26] presents a PSO based method to find routings for the network with energy harvesting. Targeting on the problem that some of the nodes would be left out during cluster formation, ref. [27] introduces to apply the concepts of PSO and gravitational search algorithm to prevent residual nodes. All of these studies consider the application of PSO either in the clustering or in the routing, i.e., only one tier. And they do not consider the application of CS.
To the best of our knowledge, there are few works besides the following literatures that have considered the application of CS into combination of data routing and nodes selection in WSNs, especially in UWSNs. In [28], the network is partitioned into clusters. Then each CH collects the sensor readings within its cluster and generates CS measurements to be forwarded directly to the base station. As a result, the overall CS measurement matrix at the base station is a block diagonal matrix. Later on, in [29], an improved method is introduced which allows the multi-hop routing of generated CS measurements through intermediate CHs. The authors generalize the two methods in [30]. Compared to our work, they obtain CS measurements in each CH and then forward to sink node while we postpone this operation to be done in the sink node to reduce the burden in CHs. On the other hand, while choosing multi-hop routing paths from the CH to the sink node, they use traditional tree-based algorithm while we design a PSO-optimization based scheme.Specifically targeting on three dimensional UWSNs as well, distributed multi-hop CS has been proposed by Gong et al. in [31]. This algorithm randomly chooses a subset with size M of N nodes in the first place, then each chosen node finds a tour to the sink node. During the traveling of the message through the tour, each node computes the product of its sensing data and a random weighted coefficient and adds the product to the intermediate result it received. Finally the sink node obtains M measurements and reconstructs the whole data.Compared to our work, they ignore the noise and select the nodes which participate in sensing by Bernoulli generator. To conclude, though these works use sparse measurement matrices similar to what we do, they only consider energy efficiency while choosing appropriate routs without considering the sensing quality. Furthermore, they do not consider the optimization of clustering.
In this work, we introduce a two-tier PSO protocol for both clustering and routing. Specifically, our contributions are listed as below.
(1)
In the first tier, a PSO-based clustering protocol is proposed to find appropriate CHs with the comprehensive consideration of energy consumption efficiency and CH distribution uniformity.
(2)
In the second tier, a PSO-based routing protocol is introduced to find appropriate routs. A routing path consists of inner-cluster one-hop routing and outer-cluster multi-hop routing and each path corresponds to one cluster. Hence the number of paths equals to the number of clusters. It is worth mention that the multi-hop routing in our scheme is not restricted to consisting of CHs only. Note that these paths correspond to the rows of the measurement matrix for CS. In this way, we implement the combination of routing and nodes selection based on CS. Hence, the fitness function of PSO-based routing protocol comprises of several factors, including the criterions for energy efficiency, network balance, and data recovery qualities. To measure network balance, we divide the nodes in the 3-D model into different layers in accordance with their horizontal distance to the sink node. As we adopt Bayesian CS (BCS), Bayesian Cramér-Rao Bound (BCRB) is added in the fitness function to reflect the recovery performance.
(3)
With optimization in CH and routing chosen progress, the network could survive longer with relatively lower measurement error as demonstrated by the simulation results. What’s more, taking energy-balancing into consideration contributes to form a more balanced energy-consuming network every round cycle, and also prolongs the network lifetime and reduces the sensing error.
The remainder of this paper is organized as follows. In Section 2 we present preliminary knowledge. In Section 3, we introduce our system model for UWSN scenario. The detailed descriptions of the clustering and routing algorithms based on CS and PSO are given in Section 4. The simulation results are presented in Section 5. Finally, Section 6 concludes the paper, and introduces the future work.
The notation used in this paper is according to the convention. Symbols for matrices and vectors are in boldface.

2. Preliminary

2.1. Compressive Sensing

CS theory proves that if a signal z of dimension N is sufficiently sparse in a certain domain; that is z = Ψ x and x 0 = K , K N , where Ψ R N × N is an orthogonal basis and x R N , it is efficient to recover z from a random measurement vector that is obtained by y = Φ z . M, the length of y is much smaller than N. Φ is named as a measurement matrix or sensing matrix. In the sequel, the random non-zero coefficients in Φ obey Gaussian distributions.
In general, it is an ill-posed problem to recover signal z from y since y has much smaller dimensions than z . We have to minimize the solution’s 0 norm to find the sparsest result. However, it is an NP-hard problem, which is not capable to be represented by mathematical formulas. Candés et al. [13] state that as long as a measurement matrix satisfies the restricted isometry property (RIP) condition, the 0 norm can be replaced by 1 norm. A measurement matrix satisfies RIP of order of K when
( 1 ϵ ) x 2 Φ Ψ x 2 ( 1 + ϵ ) x 2
for all x 0 2 K and some 0 < ϵ < 1 . Afterwards, many methods for such a convex optimization problem were introduced to solve the 1 norm optimization problem [32,33,34]. Later on, iterative-greedy-pursuit recovery algorithms [35,36,37] are proposed to reduce the time complexity.

2.2. Bayesian Estimation

In the presence of noise, the noisy measurement vector y is
y = Φ Ψ x + n = Θ x + n .
where n R M denotes the noise.
In the underwater acoustic channel, the overall noise at the receiver contains both the ambient noise and residual intersymbol interference (ISI) after equalization. Though the ambient noise is not AWGN in the underwater environment, the use of Gaussian approximation is often convenient and adequate [38]. In the presence of Gaussian ambient noise, according to [39] and [40], the overall noise can be treated as Gaussian, although it is not independent with regard to time step, since the signal after CS transform, i.e., transmitted signal is treated as Gaussian distributed. Hence, in the sequel, n is approximated as Gaussian distributed.
In [41], BCS is proposed to reconstruct a sparse signal from noisy measurements, if a statistical characterization of the signal is available. The computation time of BCS is comparable to or even faster than other classical greedy iteration algorithms. In this work, we adopt bayesian learning to recover the signal in the sink node. Therefore in this part, we make a brief review of BCS method.
n i indicates the i-th element of n in Equation (2), and is approximated as a zero mean Gaussian variable with variance σ 2 . From the Bayesian point of view, to obtain the restoration of the original signal is to seek a full posterior probability function for x. Usually, a Laplacian distribution is a widely used prior for sparse signals. But considering it is not conjugate to Gaussian likelihood, in BCS, a hierarchical prior has been defined for x; that is, a zero-mean Gaussian prior is defined on each element of x
p ( x | α ) = i = 1 N N ( x i | 0 , α i 1 ) ,
where α i is the inverse-variance of x i and α satisfies a Gamma prior with parameters a and b with p ( α ) = i = 1 N Γ ( α i | a , b ) . By marginalizing over the hyperparameter α , the overall prior is given by
p ( x | a , b ) = i = 1 N 0 N ( x i | 0 , α i 1 ) Γ ( α i | a , b ) d α i .
Likewise, the hyperparameter α 0 = 1 / σ 2 satisfies a Gamma prior Γ ( α 0 | c , d ) . Note that a, b, c and d are all set to zero to obtain a uniform hyperprior.
The goal of BCS is to estimate three parameters α , α 0 , and the most important one x. The posterior function of all unknowns is
p ( x , α , α 0 | y ) = p ( x | y , α , α 0 ) p ( α , α 0 | y ) .
The posterior of x is
p ( x | y , α , α 0 ) = ( 2 π ) N 2 | Σ | 1 2 exp ( 1 2 x μ T Σ 1 x μ ) ,
with the mean matrix μ and the covariance matrix Σ ,
μ = α 0 Σ Θ T y Σ = ( α 0 Θ T Θ + A 1 ) 1 .
For the case of uniform hyperpriors,
p ( α , α 0 | y ) p ( y | α , α 0 ) .
Finally, we can estimate all unknown parameters by maximizing the posterior in Equation (5). To find a approximate solution, we use EM algorithm to achieve the solution iteratively. In the algorithm, α and α 0 are re-estimated by every iteration with the form
α i n e w = γ i μ i 2 , 1 α 0 n e w = y Φ μ 2 2 M Σ i γ i ,
where μ i is the ith posterior mean weight from μ and γ i is defined as γ i 1 α i Σ i i , with Σ i i the i-th diagonal element of the posterior covariance weight from Σ . Then new μ and Σ are obtained. The iterations terminate until the values of α and α 0 converges. Finally, x ^ MAP = μ .

2.3. Particle Swarm Optimization

PSO was inspired by the social behavior of bird flocking or fish schooling. PSO obtains a set of candidate solutions according to the mathematical formulas, which are based on the positions and velocities of the particles. These particles are iterated in the search space to solve the problem. The motion of each particle is not only affected by its local best known position, but is also guided toward the best known position in the search-space, which are updated by better positions found by other particles. PSO is a meta-heuristic algorithm (Algorithm 1) because it makes little or no assumptions about the problem being optimized and is able to search within a very large candidate solutions space.
Initially, each particle is randomly assigned with a position vector x l = [ x l , 1 , x l , 2 , , x l , D ] as well as a velocity vector v l = [ v l , 1 , v l , 2 , , v l , D ] , where D is the dimension of a particle and l ( 1 , 2 , , S ) with S representing the total particles number. Then each particle keeps track of its personal best position P l and the global best one G in the whole search space. After finding the two best fitness values for the l-th particle, it updates the position and velocity by the fourmulas
v l m + 1 = ω m v l m + a 1 [ r 1 , l ( P l x l m ) ] + a 2 [ r 2 , l ( G x l m ) ] , x l m + 1 = v l m + 1 + x l m .
where m represents the current number of iteration, and r 1 , l , r 2 , l are random variables between [ 0 , 1 ] . a 1 and a 2 are the learning factors while ω is a weight factor that controls the velocity of the particle.
Algorithm 1: PSO algorithm
for each particle do
  initialize particle
end for
while target fitness or maximum epoch is not attained do
  for each particle do
   calculate fitness  
   if current fitness value better than (pbest) then
    pbest = current fitness
   end if
  end for
  set gbest to the best one among all pbest
  for each particle do
   update velocity
   update position
  end for 
end while

3. Proposed System Model

We consider the scenario that sensor nodes are randomly deployed in a three dimensional undersea area and sink node (base station) is placed on top of the area as shown in Figure 1. As introduced before, CS can only be used when the signal has sparsity in some domain. In the next, we would prove that the monitored oceanic data such as temperature, hardness, and salinity are indeed sparse in Fourier transform domain because of their spatial correlation. Take the ocean underwater temperature data rendered by National Aeronautic and Space Administration (NASA) (https://www.nasa.gov/specials/ocean-worlds) for example, we transform the data into its fast Fourier transform (FFT) domain and the results validate the sparsity as show in Figure 2.
Another property of oceanic data is that its sparsity varies in different depth. As a result, we divide the network into different segments in line with its depth. Note that data with higher sparsity needs more information for recovery. Therefore, segments with higher sparsity are given higher cluster-heads chosen probability so that for these segments, more measurements are obtained. In our model, the data in different segments are transmitted to the sink node and reconstructed separately, hence every segment can be considered as a sub-model. The segment-divided network model is presented as Figure 1.
In reality, the data is collected in a 3-dimensional network. We need to ransform them into one-dimensional data in accordance with its horizontal position and depth first. Hence the data in the i-th segment is represented as z i = [ z i , 1 , z i , 2 , , z i , N ] , where N is the total number of nodes in the i-th segment. However, for simplicity, in the sequel, we take every sub-model as an integral model and the data are regarded as z = [ z 1 , z 2 , , z N ] . Its sparse form is denoted as z = Ψ x , where x is a sparse vector and Ψ is the FFT transform matrix.
In each segment, we use CS to reduce the transmission burden to the sink node. Therefore, energy is saved and the network lifetime is prolonged. Clustering is also applied in our model to further economize on energy. The noisy measurement vector collected in the sink node is y = Φ z + n = Φ Ψ x + n . For the purpose of making network energy-consuming balanced and easier for a node to find the next relay node, we divide all nodes into different layers according to their distances to the sink node. In the following work, we divided them into four distinct layers, those who are closer to the sink node are given smaller layer number, which is depicted in Figure 3.

4. Proposed Algorithm

The overall algorithm contains three main steps illustrated as follows.
Firstly, we use PSO algorithm to choose M CHs for each segment and divide the nodes in each segment into M clusters. The second step is to select one routing path for each cluster using PSO algorithm, hence we obtain M routs to compose an integral routing matrix Φ R M × N . Figure 4 presents the flowchart of the whole procedure. In the flowchart, E represents the remaining energy of the whole network and f 1 , f 2 are the fitness functions of clustering and routing steps respectively. f 1 considers energy consumption and uniformity of cluster head distribution while f 2 focuses on energy consumption state and BCRB.
The detailed description about how the CHs and routing paths, i.e., the measurement matrix are chosen will be presented in the next subsections. After we get the measurement matrix, the sink node receives a M dimensional measurement y and its measurement matrix Φ . Finally, at the sink node, we use BCS algorithm to reconstruct the sparse signal x and then transform it to the original temperature signal z. After obtaining signals for all the segments one by one, the base station merges them together to recover the complete original signal.
To design the final object, there are three important factors to be taken into consideration: the signal reconstruction accuracy, the remaining energy of the network, and the balance state of the network.
Usually, mean squared error (MSE) is used to measure the reconstruction quality of the signals. If x ^ ( y ) denotes the recovered signal based on noisy measurements y represented by Equation (2). The MSE in estimation of the vector x is given by
MSE = E { x x ^ 2 } = T r { E [ x x ^ ( y ) x x ^ ( y ) T ] }
However, the calculation of MSE requires the actual estimator which is impossible for us to get before choosing the measurement matrix. To solve this problem, we introduce Bayesian Cramér-Rao Bound (BCRB) to measure the lower bound of MSE; that is, MSE BCRB . Hence, adding BCRB into the fitness function is beneficial for us to find the solution with lower MSE, since minimizing BCRB is equal to obtaining minimum acceptable MSE. Subsequently, we will derive the formula of BCRB for our problem.

4.1. BCRB Derivation

The BCRB is computed as B C R B = T r { J B 1 } with J B R N × N being the Bayesian Fisher information matrix (FIM) [42].
The i , j -th element of J B , J i j is equal to E X Y [ x i log p ( x , y ) x i T log p ( x , y ) ] . Herein, v [ v 1 , , v q ] . Then J i j can be calculated as
J i j E X Y [ x i log p ( x , y ) x j T log p ( x , y ) ] = E X Y [ x i x j T log p ( x , y ) ] = E X Y [ x i log p ( y | x ) x j T log p ( y | x ) ] + E X [ x i log p ( x ) x j T log p ( x ) ] = E X Y [ x i x j T log p ( y | x ) ] E X [ x i x j T log p ( x ) ] .
Therefore, the Bayesian FIM is given by
J B = E X Y [ x x T log p ( y | x ) ] E X [ x x T log p ( x ) ] = E ( y , x ) { 2 L ( y | x ) x x T } E ( x ) { 2 L ( x ) x x T } .
Firstly, we compute the second part of Equation (12). To solve L ( x ) , we must obtain the density function of signal x in the first place. In our model, the sparse signal x follows the Gaussian distribution with a mean vector μ and a covariance matrix Σ . Σ = diag ( γ 1 , , γ N ) is a diagonal matrix with γ i denoting the variance of x i . As a result, the density of x is
p ( x ; γ ) = i = 1 N ( 2 π γ i ) 1 / 2 e ( x i μ ) 2 2 γ i .
Hence L ( x ) = i = 1 N 1 2 ln 2 π γ i ( x i μ ) 2 2 γ i .
As the previous part is irrelevant to x, we abbreviate it as g ˜ . Then the formula in matrix form can be written as
L ( x ) = g ˜ 1 2 x T Σ 1 x .
As a result 2 L ( x ) x x T = Σ 1 .
Secondly, we turn to deal with the first part of FIM. To obtain E ( y , x ) { 2 L ( y | x ) x x T } , we need to know p ( y | x ) . Since y = Φ Ψ x + n , the probability density function of y is related to the noise term n given the information of x. The noise can be the Gaussian distribution; that is, p ( n ) = i = 1 N ( 2 π σ 2 ) 1 / 2 e n i 2 2 σ 2 . Hence, we have
p ( n ) = ( 2 π σ 2 ) N / 2 e y Φ Ψ x 2 2 σ 2 .
Subsequently,
p ( y | x ) = N 2 × log 2 π σ 2 y Φ Ψ x 2 2 σ 2 = N 2 log 2 π σ 2 1 2 σ 2 ( y Φ Ψ x ) T ( y Φ Ψ x ) ,
and then
E ( y , x ) { 2 L ( y | x ) x x T } = 1 σ 2 Ψ T Φ T Φ Ψ .
Finally, we put the two parts together as the description of FIM,
J B = E ( y , x ) { 2 L ( y | x ) x x T } E ( x ) { 2 L ( x ) x x T } = 1 σ 2 Ψ T Φ T Φ Ψ + Γ 1
Therefore, in our model, BCRB is represented by T r { 1 σ 2 Ψ T Φ T Φ Ψ + Γ 1 } .

4.2. Underwater Energy Consumption Model

Ref. [43] gives an in-depth analysis of the energy consumptions of underwater acoustic networks according to the conceptions of underwater acoustic channel attenuation model, noise model and bandwidth model. The total energy consumption associated to one hop (which includes both the transmit and the receive energy at the two ends of the link), is determined by the power P r , acoustic electric conversion power P t e l ( l ) which is the power required to transform acoustic signal to electric signal and single hop transmission delay t h o p ( L , l ) . Specifically, the energy consumed by each single hop, E h o p is calculated as:
E h o p ( L , l ) = t h o p ( L , l ) × ( P r + P t e l ) .
The single hop transmission delay t h o p ( L , l ) is determined by package length L and the distance l between two transmitting nodes as well as channel effective bandwidth α B ( l ) where α means channel utilization rate. So the formula becomes
E h o p ( L , l ) = t h o p ( L , l ) × ( P r + P t e l ) = L α B ( l ) × ( P r + P t e l )
P t e l ( l ) is calculated as
P t e l ( l ) = P t ( l ) × 10 17.2 η .
Herein, 10 17.2 is the conversion factor from acoustic power in d B r e μ P a to electrical power in Watt, η represents electronic circuit conversion efficiency and P t ( l ) is the transmitting power of underwater nodes, which is calculated as
P t ( l ) = B ( l ) × A l , f 0 ( l ) × N f 0 ( l ) × S N R t g t .
N ( f ( l ) ) and A ( l , f ( l ) ) are noise parameter and attenuation coefficient, respectively. A N = A l , f ( l ) N f ( l ) is the channel parameter and can be plotted as a curve in terms of f for given l. Therefore, for certain l, we can obtain its best frequency f 0 ( l ) and then find its corresponding A N product, N f 0 ( l ) × A l , f 0 ( l ) from the A N curve.
S N R t g t denotes the target signal noise rate for the terminal to receive signals correctly. B ( l ) is the usable bandwidth given S N R t g t , which is B ( l ) = b × l β . The positive parameters b , β depend on the target SNR as well. Unlike the transmit power, the receive power P r is independent of distance, and rather depends on the complexity of the receive operations. So it could be set as a constant value. More details can be found in [44].
In conclusion, the energy consumed for each hop in the terms of package length L and distance l is calculated as:
E h o p ( L , l ) = t h o p ( L , l ) × ( P r + P t e l ) = L α B ( l ) × ( P r + B ( l ) N ( f 0 ( l ) ) A ( l , f 0 ( l ) ) S N R t g t × 10 17.2 η )
Based on such a model, we can calculate the energy consumed by each node which participates the routing.

4.3. PSO for Clustering

First we use PSO to find appropriate nodes to be CHs. Because we divided the network into different segments, the percentage of CHs within each segment is highly related to the sparsity of the segment. In general, we set the CH ratio q to be 0.4, only in some segments which have relative low sparsity, the value of q i increases slightly in a trend like q i = 0.4 + 0.05 × s i 0.08 where s i is the sparsity of the ith segment.
The particle’s dimension is the same as the number of CHs. To initialize the particle, we generate M random integer numbers within [ 1 , N ] . For example, the i-th particle P i is M dimensional and P i , m represents the m-th value of it. If P i , m = 25 , it means that in this particle, we choose node 25 to be the m-th CH. As a node cannot be chosen repeatedly in one particle, if a particle has duplicated numbers, it will be assigned a penalty fitness value 1 to be excluded during later progress.
After initializing all the particles, we calculate the fitness value for each particle. According to their fitness value, we choose the local best and the global best particles, update the particle position which corresponds to the coordinates of the nodes in this particle and velocity to get new fitness values.
In this part, we mainly focus on energy consumption and uniformity of cluster head distribution, hence the fitness function f does not include the measurements for signal recovery qualities in current stage. The fitness function f 1 comprises of three parts as below:
  • E p , represents the energy evaluation factor and E p is given by
    E p = m = 1 M E r e s m i = 1 N E i n i t i ,
    which measures the remaining energy of the chosen CHs.
    Note that E i n i t i is the initial energy of the i-th node while E r e s m is the residual energy of the m-th node and equals to E i n i m E c m , and
    E c m = 0 if node m was not involved in the routing t h o p ( L , l m , r ) × P r + t h o p ( L , l m , t ) × P t e l if node m was involved in the routing ,
    where l m , r measures the hop length when node m is the receiver and l m , t measures the hop length when node m is the transceiver.
    We tend to choose nodes with higher residual energy to be CHs due to the fact that cluster heads consume more energy than normal nodes.
  • E c indicates the evaluation factor for the intra-cluster compactness and measures the average distance between nodes and their cluster heads.
    We calculate
    f = max m = 1 , 2 , , M n i C m d i , C H m / | C m | ,
    which measures the maximum average Euclidean distance between nodes and their CHs. d i , C H m measures the distance between node i and C H m . | C m | is the number of nodes that belong to cluster C m . Our aim is to minimize f because the nodes are closer to its cluster heads with smaller f. Therefore, E c = 1 / f .
  • E e is the evaluation factor of the uniformity of CH distribution. It measures the uniformity of CH distribution. Firstly we calculate all nodes’ distances to each other. D = d 1 , , d N where d j = d j , 1 , d j , i , , d j , N , i j and d j , i measures the distance between node j and node i. In an unevenly distributed network, the sum of D must be higher than relatively evenly distributed network. As a consequence, we add this value E e = j = 1 M d j / | C m | on our fitness function.
To sum up, the final form of fitness function f 1 of our cluster choosing algorithm is given by:
f 1 = w 1 E p + w 2 E c + w 3 E e , where w 1 + w 2 + w 3 = 1 w i 0 , i { 1 , 2 , 3 }
and w i is the weighting factor for the i-th item. To think about the problem in a balanced way, w 1 and w 2 are randomly chosen from the range [ 0.2 , 0.4 ] while w 3 = 1 w 1 w 2 .
When a particle contains duplicated nodes, we set a penalty factor to it to exclude it from iterations.
This iteration keeps going on until either the global best fitness value is lower than the threshold we set or the maximal iterative times is reached. The global best particle obtained by the last iteration is the output of the cluster head selection scheme.

4.4. PSO for Choosing Routing Paths

The final step of our algorithm is to find the routing paths, then the measurement matrix. PSO is used in this stage as well and herein each particle contains M sub-particles, where M is the number of CHs. A sub-particle includes the nodeID information while sub-particle position includes priorities corresponding to all the nodes denoted in the sub-particle.
Each sub-particle determines a single rout from each cluster to the base station. Since we have already chosen all the CHs, there are two steps left for each CH to fulfill the corresponding routing path: (1) Each CH chooses the nodes in its cluster which transmit the messages to it in one hop; (2) After collecting messages in its cluster, each CH starts a multi-hop rout to the base station.
In one word, a complete routing path contains two parts, the one-hop inner cluster part and the multi-hop outer part. Therefore we divide the sub-particle into two parts, a and b. Part a determines which nodes from the inner cluster transmit their data to the CH while part b finds the routing path from the CH to the base station. It is difficult to jointly optimize these two part. Instead, we construct inner cluster part and outer cluster part separately.
The dimension of part a of sub-particle i equals to K i , where K i is the node numbers of each cluster except the i-th CH. The sub-particle i selects ϵ × K i nodes with highest priorities from part a to transmit data to the i-th CH in one hop. ϵ is the ratio controlling parameter which we would optimize in the simulation section. Figure 5 gives an example on how to choose nodes within one cluster and how to map part a of a sub-particle into real measurement matrix. The measurement matrix with dimension M × N is initially set to all zero matrix, where M is the number of CHs and N is the total number of nodes. Once a node is chosen into i-th rout, its corresponding position in the i-th row of measurement matrix is set to a randomly distributed coefficient which obeys Gaussian distribution.
The algorithm to find a multi-hop routing path from the i-th CH to the base station from part b is more sophisticated and will be illustrated in detail in the following.
  • Choosing candidate nodes
Regarding that if we take all nodes into consideration for each rout, the dimension of a sub-particle would be too large. Given the fact that when a node try to find its rout, those nodes in the opposite area from sink node may never be included. Therefore, before the initialization, we calculate the distances of all nodes to the sink node D i s s and the distance of all nodes to the CHs D i s c . Then choose an appropriate group of candidate nodes for each CH first. D i s s = d s , 1 , , d s , N represents nodes’ distances to the sink node while D i s c = d c , 1 , , d c , N represents nodes’ distances to the CH. d i s = ( x s x c ) 2 + ( y s y c ) 2 + ( z s z c ) 2 is the distance between the CH and sink node where x s , y s , z s represent the coordinates of the sink node and x c , y c , z c are the coordinates of the CH. Note that these coordinates values could be obtained by range-based or range-free localizations before the data transmission. Only when a node k satisfies d s , k d i s and d c , k d i s , it would be added to the candidate group. Once the candidate groups are chosen, they will not be altered during the whole iteration period. Suppose the size of candidate group for the i-th CH is N i , then the dimension of part b of the sub-particle i equals to N i .
ii.
Initialization
To find part b, we make use of the network’s layered structure as we need to take directions into consideration. The nodes that are in the closer layer to the base station ought to have higher priority. This layer-based initialization method can control the routing path’s direction towards the sink node as well as avoid trapping into a dead cycle and accelerate iterative process.
The priorities of the nodes in the farthest layer are initialized by randomly generating numbers between 0 to 1. In our layered model, the fourth layer is the farthest layer, so the priorities of the nodes in the fourth layer are set from 0 to 1, while the priorities of the nodes in the third layer are from 1 to 2. In one word, when the number of the layer decreases by 1, the initial priorities of the nodes increase by 1. Hence the priority is not initialized completely randomly but related to the layer the node belongs to.
Figure 6 shows an example of our initialization. In this example, for the CH, there are altogether 12 candidate nodes dispersed in 4 different layers. It can be easily observed that the nodes in the higher layers have lower initialized priorities. That is how we achieve hierarchical initialization and obtain initialized multi-hop routing path from the CH to the sink node.
iii.
Iteration
After initializing the particles, in each iteration, we are going to calculate particles’ fitness values in terms of measurements matrices and select local best and global best ones. Then the particle positions are updated.
We have already introduced how to map part a of the sub-particle i to the corresponding row. Here we introduce how we map part b of sub-particle i to the i-th row of the measurement matrix.
Firstly we set the corresponding position of the i-th CH in the i-th row of Φ to a random Gaussian distributed coefficient. Then we find the next relay node by two steps iteratively until the complete routing path is found.
Step 1: If the previous node’s distance to the sink node is smaller than its transmission range R c , stop searching since we already obtain a single rout from the i-th CH to the sink node. Otherwise, we go to step 2.
Step 2: Find all nodes that are not only in the candidate group but also within the previous node’s transmission range, compare their priorities and find the largest one as the next relay node. Meanwhile, we set the corresponding position of chosen relay node in the i-th row of Φ to a random Gaussian distributed coefficient.
After mapping M sub-particles to M rows, the measurement matrix Φ is determined. The generated Φ is then used to compute the fitness value of corresponding particle. The fitness function includes two main items, the measurement of reconstruction quality, B r , which is related to BCRB and the measurement of energy consumed, E s .
As we calculated before, the formula of the BCRB is given by
BCRB = T r { ( 1 σ 2 Ψ T Φ T Φ Ψ + Γ ^ 1 ) } .
As BCRB implies a theoretical lower bound of reconstruction’s mean square error, we wish it to be as small as possible. So B r = 1 / T r { ( 1 σ 2 Ψ T Φ T Φ Ψ + Γ ^ 1 ) } .
The energy consumption of the routings we chose is measured by E s . It consists of three factors like
E s = 1 / E r + E l + E b .
The first item E r = k = 1 N E c k E r e s k , where E c k is the energy consumed at this round by node k and E r e s k is the rest energy of this node. It measures the energy cost ratio of nodes and should be small considering the durability of a network.
Besides E r , E l = k = 1 N E r e s k E i n i t k , where E i n i t k is the initial energy of the k-th node.
On top of that, the balance of this network also needs to be considered. A well-known fact is that the nodes near the sink node are prone to consume more energy than the nodes far away. Those nodes burden heavier transmission tasks and are easier to convey their data to the sink repeatedly because they are more likely to be relay nodes. So to obtain a balanced network, we introduce a factor E b to describe a energy consumption ratio of different layer. E b = E 1 / E 4 + E 2 / E 3 , where E i represents the remaining energy of the i- th layer. E b should be as large as possible as the lower layer tends to remain more energy in a balanced network than in an uneven network.
In a conclusion, the final fitness function consists of two parts as below,
f 2 = W 1 B r + W 2 E s
where W i is a weighting factor and W 1 + W 2 = 1 , W i 0 , i { 1 , 2 } . In the simulation, W 1 is chosen randomly from the range [ 0.4 , 0.6 ] while W 2 = 1 W 1 .

5. Simulation Results

We use the real ocean temperature data provided by NASA (https://www.nasa.gov/specials/ocean-worlds) to test our algorithm against the two cutting-edge methods. Note that the sensor network they deploy to monitor the environment is huge and we only choose 1000 nodes from this network which are deployed in a 3-D undersea region divided into 10 × 10 × 10 grids. The size of the area is 18.5 km × 14.5 km × 0.8 km. We compare our method with other two cutting edge method which also applies CS into routing. The method introduced in [31] for 3D UWSN is named as “DRMCS” which is the abbreviation of “distributed random multi-hop compressive sensing”. The other method is called “ICCS” following its name in [29] and later on in [30]. We extend it to 3D scenario by changing the clustering and routing methods to 3D protocol through replacing the 2D distance ( x , y ) to 3D distance ( x , y , z ) . The parameters we set for the energy consumption model in Section 4.1 are listed in Table 1 according to [43].
Before the whole simulations, we firstly select the appropriate value of parameter ϵ . It is impossible for us to obtain the signal z before the algorithm is run. To solve this problem, we do some preparatory experiments to decide an appropriate ϵ . In the first five rounds, we set ϵ = 0.9 , run the experiments once, and then we obtain the reconstructed signal z ^ . The reconstructed signal z ^ is regarded as the approximation of the original signal z in order to compute the reconstruction error in the following simulations. That is, afterwards we ran the first five rounds with different ϵ ranging from 0.2 to 0.8, respectively. The average consuming energy and the reconstruction error are compared. For example, the results of round 1, 3 and 5 are shown in Table 2. Considering the reconstruction error and energy consumption state integrally, we found that in our algorithm ϵ = 0.4 is the most suitable. As a result, for the rest rounds, ϵ is set to be 0.4.
All experiments were performed on MATLAB 2018b and a computer with intel(R) Core(TM) i7-8700K 2.50 GHz CPU, 16.00 GB RAM and the Windows 10 system.
In Figure 7 and Figure 8, we compare the total energy consumption and the remaining energy for each round while the measurement ratio M / N is set to 0.4. Obviously our algorithm survives longer than the other two state-of-the-art methods.The first tier utilizes PSO to find the best cluster heads group while the second tier utilizes PSO to find the best routing matrix so that the whole network has the lowest average consuming energy per cycle while maintaining the sensing error in an acceptable range. Note that in the second tier, the optimization of the routing path can not only reduce the average energy cost per round but also help to make the network more balanced. In other words, besides the fact that our PSO-based routing scheme consumes less energy each round, another important reason for longer network lifetime is that our scheme obtains more balanced energy-consumption condition.
The more balanced condition and less energy-consuming phenomenon of our scheme can also be proved in Figure 9, which shows the remaining living nodes of the network in each round. From Figure 9, we can observe that by our algorithm, the first dead node appears much later. The proposed algorithm has its first dead node at round more than 100 while the other algorithms has its first dead node at about round 70. Such a fact indicates that the proposed two-tier protocol consumes less energy each round as well as consumes energy more equally for each node of the whole network. The improvement attributes to the fact that in order to better balance the whole network, we add a factor named “network-balancing” in the particles’ fitness value calculation. Considering that the nodes closer to the sink burden heavier transmission load and hence are easier to die, we put energy consumption ratios of inner and outer layers into consideration. Reducing the ratio can avoid repeatedly choosing inner layer nodes and balance the network energy consumption better.
In order to observe the impact of node density on the network performance, we fix the total node number as 1000 and vary the volume of the area where these nodes are deployed. As shown in Figure 10, the average energy consumption in each round decreases with the increase of node density. Since the node number is fixed, the initial energy is fixed. Hence lower average energy consumption in each round means larger round cycles. This is due to the fact that we shrink the volume so that the average distances from CHs to sink node are shortened. From Figure 10, it can also be observed that compared with other two schemes, our algorithm consumes less average energy each round in the whole range of node density. To measure the delay of relevant schemes, we calculate the average hop numbers in the case of two different node densities. Average hop number is obtained by Σ i = 1 M h o p i / M , where h o p i measures the hop numbers from the i-th CH to the sink node. Obviously, since the total node number is fixed and the volume is decreased, average hop numbers, i.e., delay is lower with higher node density as shown in Figure 11. On the other hand, our algorithm always presents the lowest delay compared with relevant schemes.
Another performance we compare is the sensing quality which is measured by MSE between the original signal and reconstructed error. It can be observed from Figure 12 jointly with Figure 8 that our proposed algorithm tends to build a matrix Φ that leads to the smallest sensing error and meanwhile the energy consumed by our algorithm is the least in each round.
Besides the previous experiments, we vary the measurements ratio M / N as well to observe the MSE with varying ratio. We test the average MSE for first 20 rounds. It can be observed that the MSE decreases with the increase of measurement ratio for each algorithm. Figure 13 validates that our algorithm presents significant advantage when the measurement ratio is less than 0.5. The reason is that we add the factor B r , which considers the reconstruction quality, into the fitness function while performing PSO for routing. Our proposed algorithm works well to reduce the MSE when the measurement ratio is low. While the measurement ratio goes up, the superiority of our proposed algorithm becomes less significant.

6. Conclusions and Future Work

In this paper, we proposed a two-tier Particle Swarm Optimization (PSO) algorithm in the clustering and routing stages for distributed multi-hop compressed sensing in 3-D UWSN. We divided the whole network into different segments according to the vertical distances of the nodes. On top of that, we also divided the whole network into different layers according to the horizontal distances from the nodes to the sink and the PSO algorithm we apply in the network is firmly associated with the layers. Dividing the layers help to define the energy consumption in different layers to measure energy-consuming balance and to initialize the particle hierarchically so as to accelerate the particle convergence speed. And a factor to forecast the signal recovery performance is added on the fitness function of the PSO algorithm for routing to control the MSE of the reconstructed signal while maintaining a relatively long lifetime. Our proposed algorithm is compared with recently proposed algorithms for distributed multi-hop compressive sensing routing problem using real marine temperature data rendered by NASA. The results validate that our proposed algorithm has a longer life time with lower measurement error and postpones the round that has the first dead node.
For the future work, we will focus on the synthesized consideration of the clustering and routing stage while doing optimization. In the current study, the two stages are considered separately. On the further study, we will conduct the two steps consistently to improve the performance a step further.

Author Contributions

Conceptualization, X.C. and W.X.; methodology, X.C.; software, W.X.; validation, X.C. and W.X.; formal analysis, S.C.; investigation, X.C. and W.X.; resources, X.C.; data curation, W.X.; writing—original draft preparation, W.X.; writing—review and editing, X.C.; visualization, W.X.; supervision, X.C.; project administration, X.C. and S.C.; funding acquisition, X.C. and S.C. All authors have read and agreed to the published version of the manuscript.

Funding

This research was funded by the National Natural Science Foundation of China under grant 61301181, U1530120 and Scientific Research Starting Foundation of Central South University, and the APC was funded by the National Natural Science Foundation of China under No. U1530120.

Acknowledgments

The authors would like to thank the anonymous reviewers for their valuable comments and suggestions to improve the quality of the paper.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Wang, Y.C.; Chen, G.W. Efficient Data Gathering and Estimation for Metropolitan Air Quality Monitoring by Using Vehicular Sensor Networks. IEEE Trans. Veh. Technol. 2017, 66, 7234–7248. [Google Scholar] [CrossRef]
  2. Jin, J.; Gubbi, J.; Marusic, S.; Palaniswami, M. An Information Framework for Creating A Smart City through Internet of Things. IEEE Internet Things J. 2014, 1, 112–121. [Google Scholar] [CrossRef]
  3. Ramírez, C.A.; Barragán, R.C.; García-Torales, G.; Larios, V.M. Low-Power Device for Wireless Sensor Network for Smart Cities. In Proceedings of the Microwave Conference (LAMC) IEEE MTT-S Latin America, Puerto Vallarta, Mexico, 12–14 December 2016. [Google Scholar]
  4. Mahamuni, C.V. A Military Surveillance System Based on Wireless Sensor Networks with Extended Coverage Life. In Proceedings of the 2016 International Conference on Global Trends in Signal Processing Information Computing and Communication (ICGTSPICC), Jalgaon, India, 22–24 December 2016. [Google Scholar]
  5. Goyal, N.; Dave, M.; Verma, A.K. Data Aggregation in Underwater Wireless Sensor Network: Recent Approaches and Issues. J. King Saud Univ.-Comput. Inf. Sci. 2019, 31, 275–286. [Google Scholar] [CrossRef]
  6. Chu, Y.; Hsieh, Y.; Wang, C.; Pan, Y.; Chang, R. UPHSM: Ubiquitous Personal Health Surveillance and Management System via WSN Agent on Open Source Smartphone. In Proceedings of the 13th IEEE International Conference on e-Health Networking, Applications and Services, Columbia, MO, USA, 13–15 June 2011. [Google Scholar]
  7. Heidemann, J.; Ye, W.; Wills, J. Research Challenges and Applications for Underwater Sensor Networking. In Proceedings of the 2006 IEEE Wireless Communications and Networking Conference (WCNC), Las Vegas, NV, USA, 3–6 April 2006. [Google Scholar]
  8. Wang, Z.; Han, G.; Qin, H.; Zhang, S.; Sui, Y. An Energy-Aware and Void-Avoidable Routing Protocol for Underwater Sensor Networks. IEEE Access 2018, 6, 7792–7801. [Google Scholar] [CrossRef]
  9. Guan, Q.; Ji, F.; Liu, Y.; Yu, H.; Chen, W. Distance-Vector-Based Opportunistic Routing for Underwater Acoustic Sensor Networks. IEEE Internet Things J. 2019, 6, 3831–3839. [Google Scholar] [CrossRef]
  10. Khan, W.; Wang, H. A Multi-Layer Cluster Based Energy Efficient Routing Scheme for UWSNs. IEEE Access 2019, 7, 77398–77410. [Google Scholar] [CrossRef]
  11. Anuradha, D.; Srivatsa, S.K. Optimal Visiting Tour Scheduling for Mobile Data Gathering in UWSN. In Proceedings of the 2017 International Conference on Wireless Communications, Signal Processing and Networking (WiSPNET), Chennai, India, 22–24 March 2017. [Google Scholar]
  12. Donoho, D. Compressed Sensing. IEEE Trans. Inf. Theory 2006, 52, 1289–1306. [Google Scholar] [CrossRef]
  13. Candés, E.J.; Romberg, J.K.; Tao, T. Stable Signal Recovery from Incomplete and Inaccurate Measurements. Commun. Pure Appl. Math. 2006, 59, 1207–1223. [Google Scholar] [CrossRef] [Green Version]
  14. Chen, X.; Li, F.; Liu, X. Efficient and Robust Distributed Digital Codec Framework for Jointly Sparse Correlated Signals. IEEE Access 2019, 7, 77374–77386. [Google Scholar] [CrossRef]
  15. Wu, F.; Yang, K.; Duan, R.; Tian, T. Compressive Sampling and Reconstruction of Acoustic Signal in Underwater Wireless Sensor Networks. IEEE Sens. J. 2018, 18, 5876–5884. [Google Scholar] [CrossRef]
  16. Liu, B.; Zhang, Z. Quantized Compressive Sensing for Low-Power Data Compression and Wireless Telemonitoring. IEEE Sens. J. 2016, 16, 8206–8213. [Google Scholar] [CrossRef]
  17. Haupt, J.; Bajwa, W.; Rabbat, M.; Nowak, R. Compressed Sensing for Networked Data. IEEE Signal Process. Mag. 2008, 25, 92–101. [Google Scholar] [CrossRef]
  18. Quer, G.; Masiero, R.; Pillonetto, G.; Rossi, M.; Zorzi, M. Sensing, Compression, and Recovery for Wsns: Sparse Signal Modeling and Monitoring Framework. IEEE Trans. Wirel. Commun. 2012, 11, 3447–3461. [Google Scholar] [CrossRef] [Green Version]
  19. Davenport, M.; Laska, J.; Treichler, J.; Baraniuk, R. The Pros and Cons of Compressive Sensing for Wideband Signal Acquisition: Noise Folding Versus Dynamic Range. IEEE Trans. Signal Process 2012, 60, 4628–4642. [Google Scholar] [CrossRef]
  20. Hwang, S.; Ran, R.; Yang, J.; Kim, D.K. Multivariated Bayesian Compressive Sensing in Wireless Sensor Networks. IEEE Sens. J. 2016, 16, 2196–2206. [Google Scholar] [CrossRef]
  21. Luo, C.; Wu, F.; Sun, J.; Chen, C.W. Efficient Measurement Generation and Pervasive Sparsity for Compressive Data Gathering. IEEE Trans. Wirel. Commun. 2010, 9, 3728–3738. [Google Scholar] [CrossRef]
  22. Xie, R.; Jia, X. Transmission-Efficient Clustering Method for Wireless Sensor Networks Using Compressive Sensing. IEEE Trans. Parallel Distrib. Syst. 2014, 25, 806–815. [Google Scholar]
  23. Razzaque, M.A.; Dobson, S. Energy-Efficient Sensing in Wireless Sensor Networks Using Compressed Sensing. Sensors 2014, 14, 2822–2859. [Google Scholar] [CrossRef] [Green Version]
  24. Dengiz, O.; Konak, A.; Smith, A.E. Connectivity Management in Mobile Ad Hoc Networks using Particle Swarm Optimization. Ad Hoc Netw. 2011, 9, 1312–1326. [Google Scholar] [CrossRef]
  25. Shen, M.; Zhan, Z.; Chen, W.; Gong, Y.; Zhang, J.; Li, Y. Bi-Velocity Discrete Particle Swarm Optimization and Its Application to Multicast Routing Problem in Communication Networks. IEEE Trans. Ind. Electron. 2014, 61, 7141–7151. [Google Scholar] [CrossRef]
  26. Tukisi, T.W.; Mathaba, T.N.D. Multi-hop PSO Based Routing Protocol for Wireless Sensor Networks with Energy Harvesting. In Proceedings of the 2019 Conference on Information Communications Technology and Society (ICTAS), Durban, South Africa, 6–8 March 2019. [Google Scholar]
  27. RejinaParvin, J.; Vasanthanayaki, C. Particle Swarm Optimization-Based Clustering by Preventing Residual Nodes in Wireless Sensor Networks. IEEE Sens. J. 2015, 15, 4264–4274. [Google Scholar] [CrossRef]
  28. Nguye, M.T.; Rahnavard, N. Cluster-Based Energy-Efficient Data Collection in Wireless Sensor Networks Utilizing Compressive Sensing. In Proceedings of the Military Communications Conference, MILCOM 2013-2013 IEEE, San Diego, CA, USA, 18–20 November 2013. [Google Scholar]
  29. Nguyen, M.T.; Teague, K.A. Rahnavard, N. In Inter-Cluster Multi-hop Routing in Wireless Sensor Networks employing Compressive Sensing. In Proceedings of the 2014 IEEE Military Communications Conference, Baltimore, MD, USA, 6–8 October 2014. [Google Scholar]
  30. Nguye, M.T.; Teague, K.A.; Rahnavard, N. CCS: Energy-Efficient Data Collection in Clustered Wireless Sensor Networks Utilizing Block-Wise Compressive Sensing. Comput. Netw. 2016, 106, 171–185. [Google Scholar]
  31. Liu, G.; Kang, W. Distributed Random Multi-Hop Compressed Sensing in 3-D Underwater Sensor Networks. Inf. Technol. J. 2014, 13, 941–947. [Google Scholar]
  32. Chen, S.; Donoho, D.; Saunders, M. Atomic Decomposition by Basis Pursuit. SIAM Rev. 2001, 43, 129–159. [Google Scholar] [CrossRef] [Green Version]
  33. Fosson, S.M.; Matamoros, J.; Antόn-Haro, C. Distributed Recovery of Jointly Sparse Signals under Communication Constraints. IEEE Trans. Signal Process. 2016, 64, 3470–3482. [Google Scholar] [CrossRef]
  34. Matamoros, J.; Fosson, S.M.; Magli, E.; Antόn-Haro, C. Distributed ADMM for In-Network Reconstruction of Sparse Signals with Innovations. IEEE Trans. Signal Inf. Process. Netw. 2015, 1, 225–234. [Google Scholar] [CrossRef] [Green Version]
  35. Tropp, J.; Gilbert, A. Signal Recovery from Random Measurements via Orthogonal Matching Pursuit. IEEE Trans. Inf. Theory 2007, 53, 4655–4666. [Google Scholar] [CrossRef] [Green Version]
  36. Dai, W.; Milenkovic, O. Subspace Pursuit for Compressive Sensing Signal Reconstruction. IEEE Trans. Inf. Theory 2009, 55, 2230–2249. [Google Scholar] [CrossRef] [Green Version]
  37. Needell, D.; Tropp, J.A. CoSaMP: Iterative Signal Recovery from Incomplete and Inaccurate Samples. Appl. Comput. Harmon. Anal. 2009, 26, 301–321. [Google Scholar] [CrossRef] [Green Version]
  38. Preisig, J.C. Performance Analysis of Adaptive Equalization for Coherent Acoustic Communications in the Time-Varying Ocean Environment. J. Acoust. Soc. AM 2005, 118, 263–278. [Google Scholar] [CrossRef] [Green Version]
  39. Iglesias, I.; Song, A.; Garcia-Frias, J.; Badiey, M.; Arce, G.R. Image Transmission Over the Underwater Acoustic Channel via Compressive Sensing. In Proceedings of the 2011 45th Annual Conference on Information Sciences and Systems, Baltimore, MD, USA, 23–25 March 2011. [Google Scholar]
  40. Hassanin, M.; Garcia-Frias, J. Analog Mappings for Non-linear Channels with Applications to Underwater Channels. IEEE Trans. Commun. 2020, 68, 445–455. [Google Scholar] [CrossRef]
  41. Ji, S.; Xue, Y.; Carin, L. Bayesian Compressive Sensing. IEEE Trans. Signal Process. 2008, 56, 2346–2356. [Google Scholar] [CrossRef]
  42. Van, T.; Harry, L. Detection, Estimation and Modulation Theory; Wiley: New York, NY, USA, 2004. [Google Scholar]
  43. Zorzi, M.; Casari, P.; Baldo, N.; Harris, A.F. Energy-Efficient Routing Schemes for Underwater Acoustic Networks. IEEE J. Sel. Areas Commun. 2008, 26, 1754–1766. [Google Scholar] [CrossRef]
  44. Stojanovic, M. On the Relationship Between Capacity and Distance in an Underwater Acoustic Communication Channel. In Proceedings of the International Workshop on UnderWater Networks (WUWNet), Los Angeles, CA, USA, 25 September 2006. [Google Scholar]
Figure 1. The segment-divided model of the 3-D network.
Figure 1. The segment-divided model of the 3-D network.
Sensors 20 05961 g001
Figure 2. The FFT domain signal of temperature data.
Figure 2. The FFT domain signal of temperature data.
Sensors 20 05961 g002
Figure 3. The layer-divided model of the 3-D network.
Figure 3. The layer-divided model of the 3-D network.
Sensors 20 05961 g003
Figure 4. The flowchart of proposed algorithm.
Figure 4. The flowchart of proposed algorithm.
Sensors 20 05961 g004
Figure 5. The demo for mapping part a of sub-particle i into Φ , where c j denotes random measurement coefficient.
Figure 5. The demo for mapping part a of sub-particle i into Φ , where c j denotes random measurement coefficient.
Sensors 20 05961 g005
Figure 6. An example of hierarchical priorities initialization for part b and its corresponding topological routing path in the cross-section view.
Figure 6. An example of hierarchical priorities initialization for part b and its corresponding topological routing path in the cross-section view.
Sensors 20 05961 g006
Figure 7. The comparison results in terms of total energy consumption.
Figure 7. The comparison results in terms of total energy consumption.
Sensors 20 05961 g007
Figure 8. The comparison results in terms of remaining energy.
Figure 8. The comparison results in terms of remaining energy.
Sensors 20 05961 g008
Figure 9. The comparison results in terms of remaining living nodes.
Figure 9. The comparison results in terms of remaining living nodes.
Sensors 20 05961 g009
Figure 10. The comparison results in terms of average energy consumption with different node densities.
Figure 10. The comparison results in terms of average energy consumption with different node densities.
Sensors 20 05961 g010
Figure 11. The comparison results in terms of average hop numbers with two different node densities.
Figure 11. The comparison results in terms of average hop numbers with two different node densities.
Sensors 20 05961 g011
Figure 12. The comparison results in terms of data recovery qualities.
Figure 12. The comparison results in terms of data recovery qualities.
Sensors 20 05961 g012
Figure 13. The comparison results in terms of MSE in different measurement ratio.
Figure 13. The comparison results in terms of MSE in different measurement ratio.
Sensors 20 05961 g013
Table 1. Energy Consumption Parameters.
Table 1. Energy Consumption Parameters.
Energy Consumption ParameterValues
η 0.5
α (bps/Hz)0.5
k1.5
S N R t g t (dB)8
P r (W)2
b (dB re kHz)14.39
β (dB re kHz/km)−0.55
R c (km)3.5
Table 2. Performances by Different ϵ for round 1, 3, 5.
Table 2. Performances by Different ϵ for round 1, 3, 5.
ϵ Energy ConsumptionReconstruction Error
0.23.1640.01419
0.43.6430.01201
0.64.4450.01249
0.85.0500.01240
ϵ Energy ConsumptionReconstruction Error
0.23.1570.01421
0.43.6550.01203
0.64.4260.01251
0.85.0390.01242
ϵ Energy ConsumptionReconstruction Error
0.23.1680.01437
0.43.6370.01208
0.64.4390.01257
0.85.0120.01248
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Chen, X.; Xiong, W.; Chu, S. Two-Tier PSO Based Data Routing Employing Bayesian Compressive Sensing in Underwater Sensor Networks. Sensors 2020, 20, 5961. https://doi.org/10.3390/s20205961

AMA Style

Chen X, Xiong W, Chu S. Two-Tier PSO Based Data Routing Employing Bayesian Compressive Sensing in Underwater Sensor Networks. Sensors. 2020; 20(20):5961. https://doi.org/10.3390/s20205961

Chicago/Turabian Style

Chen, Xuechen, Wenjun Xiong, and Sheng Chu. 2020. "Two-Tier PSO Based Data Routing Employing Bayesian Compressive Sensing in Underwater Sensor Networks" Sensors 20, no. 20: 5961. https://doi.org/10.3390/s20205961

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