Next Article in Journal
An Improved Underwater Recognition Algorithm for Subsea X-Tree Key Components Based on Deep Transfer Learning
Next Article in Special Issue
Significant Wave Height Prediction in the South China Sea Based on the ConvLSTM Algorithm
Previous Article in Journal
Correction: Liu et al. Advancing Three-Dimensional Coupled Water Quality Model of Marine Ranches: Model Development, Global Sensitivity Analysis, and Optimization Based on Observation System. J. Mar. Sci. Eng. 2022, 10, 1028
Previous Article in Special Issue
PWPNet: A Deep Learning Framework for Real-Time Prediction of Significant Wave Height Distribution in a Port
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

A Variational Bayesian-Based Simultaneous Localization and Mapping Method for Autonomous Underwater Vehicle Navigation

1
Underwater Vehicle Laboratory, Ocean University of China, Qingdao 266100, China
2
Faculty of Information Science and Engineering, Ocean University of China, 238 Songling Road, Qingdao 266000, China
*
Author to whom correspondence should be addressed.
J. Mar. Sci. Eng. 2022, 10(10), 1563; https://doi.org/10.3390/jmse10101563
Submission received: 4 August 2022 / Revised: 29 September 2022 / Accepted: 15 October 2022 / Published: 21 October 2022

Abstract

:
Simultaneous Localization and Mapping (SLAM) is a well-known solution for mapping and realizing autonomous navigation of an Autonomous Underwater Vehicle (AUV) in unknown underwater environments. However, the inaccurate time-varying observation noise will cause filtering divergence and reduce the accuracy of localization and feature estimation. In this paper, VB-AUFastSLAM based on the unscented-FastSLAM (UFastSLAM) and the Variational Bayesian (VB) is proposed. The UFastSLAM combines unscented particle filter (UPF) and unscented Kalman filter (UKF) to estimate the AUV poses and features. In addition, to resist the unknown time-varying observation noise, the method of Variational Bayesian learning is introduced into the SLAM framework. Firstly, the VB method is used to estimate the joint posterior probability of the AUV path and observation noise. The Inverse-Gamma distribution is used to model the observation noise and real-time noise parameters estimation is performed to improve the AUV localization accuracy. Secondly, VB is reused to estimate the noise parameters in the feature update stage to enhance the performance of the feature estimation. The proposed algorithms are first validated in an open-source simulation environment. Then, an AUV SLAM system based on the Inertial Navigation System (INS), Doppler Velocity Log (DVL), and single-beam Sonar are also built to verify the effectiveness of the proposed algorithms in the marine environment. The accuracy of the proposed methods can reach 0.742% and 0.776% of the range, respectively, which is much better than 1.825% and 1.397% of the traditional methods.

1. Introduction

The Autonomous Underwater Vehicle (AUV) plays a vital role in marine resource surveys, security and defense, and environmental observations [1]. Underwater autonomous navigation, as the basis for AUV to accomplish complex tasks, has also become a hot research topic among scholars [2,3]. When AUV performs underwater missions, two things are very important: Where is the AUV? What is around it, which is the necessary guarantee to ensure the safety of AUV navigation [4,5,6,7]. Simultaneous Localization and Mapping (SLAM) is a well-known solution for robot navigation [8,9]. In an unknown environment, the robot can repeatedly observe the environmental features through the equipped detection sensors (Laser Radar, Sonar, Camera, etc.) [10,11,12], thus enabling the correction of its own position and environmental feature points. Therefore, SLAM provides a feasible solution for realizing autonomous navigation of AUV in an unknown environment [13].
The Extended Kalman Filter-SLAM (EKF-SLAM) algorithm is one of the most classic basic frameworks [14]. Common EKF-SLAM has the problems of inconsistent filtering due to the linearization of the nonlinear model. However, there are also some limitations in the application, such as the quadratic complexity and sensitivity of single hypothesis data association. The FastSLAM algorithm based on Rao–Blackwellized Particle Filter (RBPF) is another commonly used SLAM framework [15]. The RBPF decomposes the complete posterior distribution into robot localization and features estimation, which reduces the complexity of the SLAM algorithm. In the FastSLAM algorithm, each particle represents a different robot state, and the data association problem can be performed on individual particles. Therefore, the false data associations with lower particle weights will be discarded in the resampling stage [16,17]. Based on FastSLAM, FastSLAM 2.0 incorporates the observation information into the importance sampling function, which greatly improves the accuracy of the algorithm. FastSLAM 2.0 also has some shortcomings, namely the calculation of the Jacobian matrix and the linear approximation of nonlinear functions [18]. UFastSLAM [19] overcomes the shortcomings of FastSLAM 2.0 and combines UPF and UKF to estimate robot path and features, respectively. In the path estimation stage, the proposal distribution is generated by UPF to improve the path estimation accuracy. UKF is used to update the posterior state and covariance of the features. The SLAM algorithm based on UFastSLAM has been validated in various fields [20,21,22].
The traditional RBPF-SLAM algorithms(FastSLAM, UFastSLAM, etc.) also have problems that cannot be avoided in experimental applications. Inaccurate observation information will lead to particle degradation problems. The resampling method of re-screening and duplicating particles after too many invalid particles is proposed to solve the problem of particle degradation, but after multiple resampling, it will lead to particle depletion, resulting in poor particle diversity. Since the AUV pose and map history information carried by the discarded particles are deleted, the accuracy of AUV for navigation and features estimation decreases. Most of the current research focuses on optimizing the resampling stage by improving resampling or replacing it with other methods. Ref. [23] proposed a particle filter algorithm based on genetic operator. Using this strategy, the low-mass particles are corrected to large-mass particles, which finally alleviates the problem of particle depletion. Ref. [24] used an improved method of variance reduction to solve the particle degradation and particle depletion, thereby reducing the impact of unknown noise on FastSLAM. Ref. [25] presented hybrid indoor localization system using an IMU sensor and a smartphone camera. The IMU sensor errors are reduced by smartphone camera pose and the heading errors from camera-based localization is overcome by the IMU localization results. Moreover, a sensor fusion framework based on Kalman filter is proposed to enhance the results of the proposed method. Ref. [26] proposed an intelligent resampling step to FastSLAM, which is inspired by microbat behaviors to obtain the optimized state of the robot. Moreover, the proposed resampling only operates on small-weight particles and thus reduce the computational burden.
The AUV SLAM system mainly contains system noise caused by the motion model and observation noise generated by the sensors used for external detection. In practical applications, the characteristic of observation noise is time-varying [27,28], such as data anomalies caused by sonar multipath effects, reverberation interference. Therefore, real-time estimation of observation noise is a very critical step to improve the accuracy of SLAM algorithms.
In this paper, we propose a VB based AUV SLAM method to improve the estimated accuracy of AUV position and features. Firstly, we use an Inverse-Gamma distribution to model the observation noise. Then the VB method is used to estimate the joint posterior probability of robot path and observation noise. Real-time sonar noise estimation was performed for multiple observations of each particle to improve the AUV localization accuracy. At the same time, the VB is reused to estimate the noise parameters in the feature update stage. The main contributions of this paper are as follows:
(1) We propose a SLAM framework that fuses VB and RBPF-SLAM to address the problem of anomalous sonar observations in AUV SLAM.
(2) Based on FastSLAM and UFastSLAM, the improved VB-AFastSLAM algorithm and VB-AUFastSLAM algorithm are proposed. Furthermore, we elaborate the details of VB-SLAM with the VB-AUFastSLAM algorithm as an example in Section 3.
(3) The proposed algorithms are validated in simulation experiments and AUV sea trial experiments. Compared with the traditional SLAM algorithms, the proposed VB-AUFast-SLAM algorithm and VB-AFastSLAM algorithm have significantly improved effects.
The rest of this paper is organized as follows: Section 2 describes the AUV SLAM system. Section 3 presents the proposed VB-AUFastSLAM algorithm. Section 4 is a comparison of the two proposed algorithms with other algorithms in a simulation environment. Section 5 shows the experimental results in the actual sea trial environment. Section 6 is the conclusion and future work.

2. AUV SLAM System

2.1. Sailfish-210 AUV

The Sailfish-210 is an independently developed AUV by the Underwater Vehicle Lab at Ocean University of China. The length of Sailfish-210 is 1.7 m, and the outer diameter of the cabin is 0.21 m. Maximum working depth can reach 200 m. The AUV can reach speeds of 5 knots and sail at 3 knots for over 8 h. Figure 1 shows the basic structure of Sailfish-210 and the sensors required for this experiment, and Table 1 is the technical specifications of the sensors.

2.1.1. GPS

To accurately locate the Sailfish-210 AUV on the water surface and use it as a benchmark to evaluate the performance of different algorithms, the AUV is equipped with a high-precision, high-performance Global Positioning System (GPS) receiver. At the same time, a GPS filtering algorithm that has been proven to be effective in actual engineering was applied to this experiment.

2.1.2. Attitude Sensor

The INS equipped in Sailfish-210 AUV is HN-100, which mainly includes an inertial measurement unit. Through the acceleration and angular velocity obtained by the IMU, the position, velocity and attitude angle can be calculated.

2.1.3. Velocity Sensor

The speed measurement sensor used in this experiment is Pathfinder DVL, which works by sending sound waves to the seabed, and outputs the speed of the AUV in the carrier coordinate system by measuring the bottom three-axis speed and the distance to the bottom height fusion algorithm. DVL can obtain the speed of the carrier in real time without cumulative error. Therefore, during the experiment, the speed information measured by DVL is used as the current speed measurement value of the AUV.

2.1.4. Detection Sensor

Sonar is an essential external detection sensor for AUV SLAM. In this experiment, we choose Tritech small single-beam Mechanical Scanning Imaging Sonar (MSIS), which has the advantages of large detectable angle (0°–360°), small size, and lightweight (324 g in the air). Moreover, its farthest detection range can reach 100 m.

2.2. Auv Model Description

The AUV state vector consists of its position and yaw at time k, as shown in Equation (1), where ( x k , y k ) represent the coordinates of the AUV in the geographic coordinate system. φ k represents the angle between the AUV direction and the geographic north direction, in the range of 0 ° , 360 ° . AUV rotates clockwise to increase direction of φ k . The map M consists of the coordinates of feature points, for example, ( m x n , m y n ) represent the coordinates of the n-th feature point in the geographic coordinate system. That is, m x n represents m x n meters away from the origin in the horizontal direction and m y n represents m y n meters from the origin in the vertical direction.
X k = x k   y k   φ k T
M = m x 1   m y 1 m x n   m y n T
The motion model of Sailfish-210 AUV can be expressed as Equation (3).
X k = x k y k φ k = x k 1 + V x · Δ T · cos φ k 1 V y · Δ T · sin φ k 1 y k 1 + V x · Δ T · sin φ k 1 + V y · Δ T · cos φ k 1 φ k 1 + W · Δ T + δ k
where Δ T represents the sampling interval, V x and V y represent the forward and starboard velocity of AUV respectively, φ k denotes the yaw at the current moment and W represents the angular acceleration. δ k represents system noise, and δ k N 0 Q k , Q k represents its covariance matrix.
The observation model of AUV can be expressed as:
Z k , i = r k , i θ k , i = m x i x k 2 + m y i y k 2 arc tan m y i y k m x i x k φ k + ε k
where r k , i and θ k , i represent that the i-th feature point at time k is located r meters away from the AUV and rotated θ ° clockwise from the AUV direction. ε k represents observation noise, and satisfies ε k N 0 , R k , R k represents its covariance matrix. The navigation coordinate system of Sailfish-210 AUV can be represented by Figure 2.

3. Improved AUV SLAM Algorithm

We take the VB-AUFastSLAM as an example to introduce our proposed algorithm. VB-UPF is used to estimate the posterior probability p S k | z k , u k , n k of the AUV pose, and VB-UKF is used to estimate and update the features. We describe the algorithm with the model (Equations (3) and (4)) used by the Sailfish-210 AUV in this paper.

3.1. Vb-Based Sampling the New AUV Pose

For each particle, according to the UKF method, the state vector of the i-th particle is augmented with a control input. Assuming that the mean of the control noise is zero, the augmented state is formulated as:
X k 1 a u g m e n t i = X k 1 i 0 = x k 1 i y k 1 i φ k 1 i 0 R 6
P k 1 a u g m e n t i = P k 1 i 0 0 Q k R 6 × 6
here, X k 1 a u g m e n t i is the augmented vector for the state, X k 1 i and P k 1 i denote the previous state and covariance. Q k denotes the process noise. x k 1 i , y k 1 i , φ k 1 i respectively represent the X-axis position, Y-axis position and yaw of the AUV.
VB-AUFastSLAM extracts sigma points from the Gaussian and passes these points through the nonlinear function. A symmetric set of 2n + 1 sigma points χ k 1 | k 1 , j a u g m e n t i for the augmented state vector can be given by:
χ k 1 | k 1 , 0 a u g m e n t i = X k 1 a u g m e n t i χ k 1 | k 1 , j a u g m e n t i = X k 1 a u g m e n t i + n + λ P k 1 a u g m e n t i j   , j = 1 , 2 , , n χ k 1 | k 1 , j a u g m e n t i = X k 1 a u g m e n t i n + λ P k 1 a u g m e n t i j   , j = n + 1 , , 2 n , χ k 1 | k 1 a u g m e n t i R 6 × ( 2 n + 1 )
where the λ is computed by λ = α 2 n + κ n . α is a small number to avoid sampling nonlocal effects ( α = 0.002 is appropriate). κ κ > 0 is used to determine the distance between the sigma points and the mean which is not critical though, so a good default choice is κ = 0 . j represents the j-th column of matrix n + λ P k 1 a u g m e n t i . Each χ k 1 | k 1 a u g m e n t i contains the state and control noise components given by:
χ k 1 | k 1 a u g m e n t i = χ k 1 | k 1 i χ k u i R 6 × ( 2 n + 1 )
The weights corresponding to the state and the covariance can be calculated as:
ω m 0 = λ / n + λ ω c 0 = λ / n + λ + 1 α 2 + β w m j = ω c j = 1 / 2 n + λ   ,   j = 1 , 2 , , 2 n
β is the parameter used to introduce higher-order information items of the posterior probability distribution. For the Gaussian prior, the optimal choice is β = 2 .
The set of sigma points are transformed by the motion model characterized by a nonlinear function as follows:
χ k | k 1 i = f χ k 1 | k 1 i , χ k u i + u k = χ k | k 1 x , i χ k | k 1 y , i χ k | k 1 φ , i R 3
χ k | k 1 i is the transformed sigma point of the AUV state. The prediction state and the prediction state covariance matrix are calculated based on the weights as:
X k | k 1 i = j = 0 2 n ω m j × χ k | k 1 , j i   ,   X k | k 1 i R 3
P k | k 1 i = j = 0 2 n ω c j χ k | k 1 , j i X k | k 1 i χ k | k 1 , j i X k | k 1 i T   ,   P k | k 1 i R 3 × 3
When external observations are available, the statistical characteristic of the time-varying observations noise covariance are estimated to improve the performance of algorithm. Since the Inverse-Gamma distribution is the conjugate prior distribution of the variance of the Gaussian distribution, in Bayesian analysis, the Inverse-Gamma model is usually chosen to model the variance of the Gaussian distribution [29]. η and ξ represent the hyper-parameters of Inverse-Gamma distribution, respectively. The Inverse-Gamma distribution is shown as Equation (13).
I n v e r s e G a m m a σ 2 | η , ξ = ξ η σ 2 η + 1 Γ η exp ξ σ 2
We introduce the VB method to approximate the observation noise. Based on VB, the joint posterior estimation of the system state X k | k i and the observation noise covariance R k | k i can be expressed as:
f x k , R k | z k = Q x x k Q R R k
where Q x x k and Q R R k are the approximate probability distributions of the state vector and observation noise parameters, respectively. The VB approximation can be formed by minimizing the Kullback–Leibler (KL) divergence between the true distribution and the approximation:
K L Q X x k Q R R k | | f x k | k , R k | z k = Q X x k Q R R k log Q X x k Q R R k f x k | k , R k | k | z k d x k | k d R k | k
When minimizing the KL divergence, fixing Q X x k or Q R R k respectively, the following can be obtained:
Q X x k exp Q R R k log f x k , z k , R k | z 1 : k 1 d R k Q R R k exp Q X x k log f x k , z k , R k | z 1 : k 1 d x k
As the above equations are coupled, it cannot be solved directly, after computing the expectations separately, we can obtain:
Q R R k log f x k , z k , R k | z 1 : k 1 d R k = 1 2 z k h x k T R k 1 z k h x k 1 2 x k x k | k 1 T P k | k 1 1 x k x k | k 1 + c 1
where · = Q R R k · d R k denotes the expected value with respect to the approximating distribution Q R R k . As a function of x k , this is a quadratic implying that Q X x k is a Gaussian distribution, both the mean and variance can be obtained by standard matrix operations.
Similarly, the expectation of Q R R k can be calculated as follows:
Q X x k log f x k , z k , R k | z 1 : k 1 d x k = i = 1 d 3 / 2 + η k , i ln σ k , i 2 i = 1 d ξ k , i σ k , i 2 1 2 1 σ k , i 2 z k h x k 2 + c 2
where · = Q X x k · d x k . From the above equation, it can be seen that Q R R k is the product of the Inverse-Gamma distribution. If we assume that R k is d-dimensional, then R k can be expressed as:
R k = diag ξ k , 1 / η k , 1 , . . . , ξ k , d / η k , d R d × d
To ensure that the joint predicted probability distribution of R k at time k keeps the same form as the posterior probability distribution at time k 1 , a forgetting factor ρ   ϵ   0 , 1 is introduced to reflect the degree of fluctuation of the noise. The prior of the observation noise parameters can be expressed as:
η k | k 1 , j = ρ η k 1 | k 1 , j
ξ k | k 1 , j = ρ ξ k 1 | k 1 , j
The exact observation noise posterior distribution is obtained cyclically and iteratively during the observation update. It should be emphasized that the loop iteration of the observation noise using the VB method is performed on the covariance matrix, so the observation noise still satisfies the Gaussian white noise distribution, i.e., R k | k * N 0 , R k .
As feature points are observed and matched with existing features after data association, the following stage will be employed to iterative update the X k | k i and the covariance P k | k i of the robot. From the observation model, the predicted observation of the sigma points can be calculated as:
z ¯ k | k 1 , j i = h χ k | k 1 , j i   ,   z ¯ k | k 1 , j i R 2
The predicted observation and cross-covariance matrix can be obtained as:
Z k | k 1 i = j = 0 2 n ω m j × z ¯ k | k 1 , j i   ,   Z k | k 1 i R 2
P x z , k | k 1 i = j = 0 2 n w c j χ k | k 1 , j i X k | k 1 i z ¯ k | k 1 , j i Z k | k 1 i T   ,   P x z , k | k 1 i R 3 × 2
The mean and covariance of the state vector are calculated as:
S k i = j = 0 2 n w c j z ¯ k | k 1 i Z k | k 1 i z ¯ k | k 1 i Z k | k 1 i T   ,   S k i R 2 × 2
P z z , k | k i = S k i + R k | k *   ,   P z z , k | k i R 2 × 2
K k i = P x z , k | k 1 i P z z , k | k i 1   ,   K k i R 3 × 2
X k | k i = X k | k 1 i + K k i Z k Z k | k 1 i
P k | k i = P k | k 1 i K k i S k i + R k | k * 1 K k | k i T
What needs to be noted here that the observation noise R k | k * at this time has been modeled as an Inverse-Gamma distribution. Furthermore R k | k * denotes the temporary value during the filtering loop, when the loop ends, save the final estimated noise of this observation:
R k | k i j = R k | k *
where i represents the i-th particle and j represents the observed noise for the j-th feature. The noise of each observed feature is estimated and R k | k i j will be used in the subsequent mapping stage. Moreover, the update of the noise hyper-parameters can be expressed as:
η k | k i = η k | k 1 i + 1 / 2 , . . . , 1 / 2 , η k | k i R 2
ξ k | k i = ξ k | k 1 i + Z k Z k | k 1 i 2 + diag S k i / 2 , S k i R 2

3.2. Feature State Estimation by VB-UKF

Based on X k | k i known in Section 3.1, feature state estimation in VB-AUFastSLAM can be divided into two parts: the feature update stage and feature augmentation stage.
(1) Feature augmentation
Since the path at time k is known, the observation noise can be used as the initial feature covariance matrix, so that in the mapping stage of the VB-AUFastSLAM, current observation Z k and the observation noise covariance matrix are chosen as the initial inputs, we can obtain the sigma point of the observation as:
Γ k 1 | k 1 , 0 i = Z k Γ k 1 | k 1 , j , i = Z k + n + λ R k | k   j = 1 , , l Γ k 1 | k 1 , j , i = Z k n + λ R k | k   j = l + 1 , , 2 l , Γ k 1 | k 1 i R 2 × ( 2 l + 1 )
where λ = α 2 n + κ n , in the feature update stage, it is usually set α = 0.001 , κ = 0 . After nonlinear transformation, the mean and covariance of the new features can be obtained as follows:
Y k | k 1 , j i = h 1 Γ k 1 | k 1 , j i , X k | k i   j = 0 , , 2 l , Y k | k 1 , j i R 2
X k | k 1 f , i = j = 0 2 l w m j Y k | k 1 , j i , X k | k 1 f , i R 2
P k | k 1 f , i = j = 0 2 l w c j Y k | k 1 , j i X k | k 1 f , i Y k | k 1 , j i X k | k 1 f , i T , P k | k 1 f , i R 2 × 2
(2) Feature update
Feature points will be updated after feature matching is completed. We convert the feature points position to sigma points as:
χ k | k 1 , 0 f , i = X k | k 1 f , i χ k | k 1 , j f , i = X k | k 1 f , i + n + λ P k | k 1 f , i   j = 1 , , n χ k | k 1 , j f , i = X k | k 1 f , i n + λ P k | k 1 f , i   j = n + 1 , , 2 n
According to the X k | k i at time k and the nonlinear observation model h · , the predicted observations can be obtained:
z ¯ k | k 1 , j f , i = h χ k | k 1 , j f , i , X k | k i j = 1 , , 2 n , z ¯ k | k 1 , j f , i R 2
Z k | k 1 f , i = j = 0 2 n ω m j × z ¯ k | k 1 , j f , i , Z k | k 1 f , i R 2
P x z , k | k 1 f , i = j = 0 2 n w c j χ k | k 1 , j f , i X k | k 1 , j f , i z ¯ k | k 1 , j f , i Z k | k 1 f , i T
P x z , k | k 1 i R 2 × 2 is the cross-covariance between state and observation in the feature update stage, which is used to compute the Kalman gain K k i :
S k f , i = j = 0 2 n w c j z ¯ k | k 1 , j f , i Z k | k 1 f , i z ¯ k | k 1 , j f , i Z k | k 1 f , i T , S k f , i R 2 × 2
P z z , k | k f , i = S k f , i + R k | k i j , P z z , k | k f , i R 2 × 2
K k f , i = P x z , k | k 1 f , i P z z , k | k f , i 1 , K k f , i R 2 × 2
Similar to the path estimation stage, when calculating the innovation covariance P z z , k | k i , the observation noise R k | k needs to be estimated by the VB method. The difference is that the initial observation noise R k | k i j in the feature update stage is already obtained from the path estimation stage, so the observation noise requires fewer cycles than the path estimation stage. After loop iteration, the position and covariance of the feature can be obtained:
X k | k f , i = X k | k 1 f , i + K k f , i Z k Z k | k 1 f , i
P k | k f , i = P k | k 1 f , i K k f , i S k f , i + R k | k 1 K k f , i T

3.3. Calculating Importance Weights and Resampling

Considering the latest observations in the proposed distribution, the weight calculation can be expressed by Equations (46) and (47):
W k i = 2 π L k i 1 2 exp 1 2 Z k Z k | k 1 i T L k i 1 Z k Z k | k 1 i
L k i = P x z , k | k 1 i T P k | k i P x z , k | k 1 i + P z z , k | k f , i
The particles with high weights are replicated, and the ones with low weights are thrown away. However, excessive resampling will lead to a reduction in particle diversity, resulting in particle depletion. To avoid redundant resampling steps, the effective number of particles ( N e f f ) is utilized as a criterion:
N e f f = 1 i = 1 N W k i
where N is the number of particles. N e f f is set to 75% of the total number of particles in simulation tests and marine environment tests. If the effective particles are less than 75% of the total number of particles, resampling will be performed.

4. Simulations and Result Discussion

We first evaluate the effectiveness of the proposed algorithms in the simulation environment. We built a simulation map in Figure 3 based on the open-source simulation environment [30] presented by Tim. The robot trajectory path is specified by 20 waypoints with 127 landmarks and starts off at (0,0).
We additionally propose the VB-AFastSLAM algorithm based on FastSLAM, which has the same idea as VB-AUFastSLAM in Section 3, and compare the two proposed algorithms with FastSLAM and UFastSLAM. The initial observation noise covariance R 0 during the simulation is set to R 0 = diag 0.001 , 0.001 , other parameters are shown in Table 2. To simulate dynamic noise, we modify the observation noise covariance as Table 3.
Where p represents the probability of abnormal noise, n represents the degree of abnormal noise mutation. Changing p and n respectively to simulate the degree of the fluctuation of observed noise during the simulation. For each case, we have performed 30 Monte Carlo simulation experiments.
The n is set to fixed and p is varying to simulate the frequency of anomalous observation noise, and the simulation results are shown in Table 4. Where Path denotes the position error, Path-x, Path-y represent the northward and eastward error of the position respectively, and Feature displays the error of mapping. It can be seen from the Table 4 that the performance of VB-AFastSLAM and VB-AUFastSLAM are far better than traditional methods, of which VB-AUFastSLAM performs the best, and VB-AFastSLAM is the second. As the frequency of anomalous noise increases, the performance of the traditional algorithms deteriorates, in contrast, the error of our proposed algorithms remain stable.
Keeping p constant and at a low probability, n is varied to simulate the stability of each algorithm for abrupt observed noise, and the comparison results are shown in Table 5. In this case, we can arrive at the same conclusion. Especially when the noise is extremely abnormal, such as n = 6; p = 0.2, both VB-AFastSLAM and VB-AUFastSLAM show excellent noise adaptability. Figure 4 shows the performance comparison of the four algorithms with less anomalous noise and fewer occurrences (n = 2; p = 0.3), where the blue trajectory is obtained by the algorithm and the red points represent the estimated features. Figure 5 is the error comparison diagram of the whole process.
Too many invalid particles are the main cause of particle depletion. The number of effective particles is another important criterion for judging RBPF-SLAM. Figure 6 shows the comparison of effective particle numbers of the four algorithms. N e f f is calculated according to Equation (48), and the N e f f of each algorithm under each type of noise is the average of 30 simulation results. As the noise gradually increases, the average effective particles of VB-AUFastSLAM and VB-AFastSLAM are higher and remain stable, showing good adaptiveness to dynamic noise. The traditional algorithms have fewer effective particles than the proposed algorithms when there are no anomalous noise. As the random abnormal noise increases, the number of effective particles decreases gradually, and the error increases accordingly.
The above dynamic noise experiments show that the proposed two algorithms are significantly better than the traditional ones. We also verify the performance of the proposed algorithms under large initialization errors. As shown in Table 6, it represents the corresponding performance when η and ξ are initialized to different parameters. The initial observation noise covariance (obtained by Equation (19)) is in the range of 0.2 to 1, which is much higher than the basic R = diag[0.001, 0.001]. By setting different initialization parameters and conducting experiments under the condition that the observation noise is n = 2, p = 0.3, it can be found from Table 6 that the performance of the two proposed algorithms decreases with the increase of the initialization error, but still within the normal range.
Remark1. 
According to Equations (20) and (21), ρ represents the degree of fluctuation of the observation noise, with a larger ρ representing a smaller degree of noise fluctuation. According to Equation (19), η and ξ are two variables that directly affect the initialization of observation noise. According to Equation (31), η increases by a fixed amount during the iteration process. We have found in many experiments that a larger value of η will achieve relatively good results, and ξ should be set much smaller than η. If ξ and η are similar, then will lead to an increase in filtering error.
The running time of the SLAM algorithm is also an important index. Table 7 shows running time comparison of four algorithms. It can be seen from Table 7 that due to the use of the UKF-based method, VB-AUFastSLAM performs a large number of UT transformations, resulting in a large increase in running time compared to VB-AFastSLAM. Compared with their respective basic algorithms, VB-AFastSLAM and VB-AUFastSLAM increase the running time by 19.91% and 22.36%. Compared with UFastSLAM, the running time of VB-AFastSLAM is reduced by 11.19%. Therefore, the amount of time to perform calculations has increased a little. That can be ignored against the high accuracy obtained.

5. Sea Trial Results and Analysis

In this section, we compare the two proposed algorithms with traditional algorithms on the Sailfish-210 AUV platform.

5.1. Experiment Description

The experimental area is around 36.05° N, 120.29° E, Tuandao, Qingdao and the experimental site is shown in Figure 7. The red line represents the trajectory of the AUV. The AUV first sailed along the coastline, then sailed along the bridge shown in the figure, and finally passed through the bridge hole to continue sailing on the east side of the bridge. In order to distinguish clearly, we name the path along the coastline as path 1 and the path along the bridge as path 2. During the whole experiment, by reducing the buoyancy, the rest of the AUV was immersed in the water except the antenna and the rudder. The scanning sonar is located about 25 cm below the water surface. The advantage of this is that it does not affect the normal operation of the sonar. Accurate GPS data will also be obtained. The GPS data are only used to verify the accuracy of the algorithms and will not be applied to AUV navigation. The sailfish-210 during the experiment is shown in Figure 8.
We use Nearest Neighbor (NN) to achieve data association in this experiment. First, set an association gate according to the predicted position of the feature to be associated to limit the number of potential observation decisions, and the candidate observations are preliminarily screened out by the association gate. Then, calculate the Mahalanobis distance between the observation and each feature according to Equation (49).
D = Z k Z k | k 1 f , i T S k f , i Z k Z k | k 1 f , i
where S k f , i can be obtained by Equation (41). The observation with the smallest Mahalanobis distance is regarded as the observation generated by the feature. The most significant advantage of using this method is the low computational complexity of only O(M), where M is the number of features contained in the state. Furthermore, this method has been successfully applied in the field of AUV SLAM.

5.2. Results and Analysis

In this experiment, the sailing distance is 361.5643 m. Figure 9a is a comparison of the paths of the four algorithms, where the black line represents the GPS trajectory after wild value filtering as the true value, and the comparison shows that the trajectories of VB-AUFastSLAM and VB-AFastSLAM fit the GPS trajectory better. After calculating the error of each algorithm and GPS trajectory separately, we obtain Figure 9b. “steps” represents the sampling period, in this experiment, our data was recorded at a frequency of 10 Hz, where data points 1 to 1800 and 3600 to the end indicate that the AUV sails along the coastline, i.e., path 1 in Figure 7, and data points 1800 to 3600 indicate that the AUV sails along the bridge, i.e., path 2 in Figure 7. During the movement of the AUV in path 1, the sonar can always detect the wall along the coast. Since the sonar is affected by dynamic ocean noise and self-noise, the wrong external observation leads to a larger AUV positioning error. For example, in Figure 9b, the error growth rate of the traditional algorithms during this period is larger than that of the proposed new algorithms, and with the same other settings, it can be inferred that the proposed algorithms can dynamically adjust the observation noise and thus improve the positioning accuracy. During the movement of the AUV in path 2, due to the existence of many bridge holes, only bridge piers can be detected, so the sonar observations at this time is far less than that in the process of path 1. From Figure 9b, it can be found that during path 2, the error difference between the four algorithms increases slowly and stays in a more stable range. It should also be noted that the presence of a reference with obvious structural features such as bridge piers in path 2 is beneficial to improve the success rate of feature matching and increase the localization accuracy. The data points 1800 to 2800 and 3200 to 3600 in Figure 9b are the corresponding data when the AUV moves on the west and east sides of the bridge, respectively, which verifies our above point. However, during the process of AUV passing through the bridge hole (data points 2800 to 3200), we found that there are a large number of uneven reefs on both sides of the bridge hole, the observed features increase, and the difficulty of feature correlation increases. Corresponding to Figure 9b, the localization error increases here, but the error of the proposed algorithms grows less rapidly than the conventional algorithms.
Table 8 shows the RMSE of different algorithms, and we evaluate the accuracy of navigation according to Equation (50). For path estimation, the accuracy of traditional FastSLAM and UFastSLAM algorithms are 1.825% and 1.397%, respectively, while the accuracy of VB-AUFastSLAM is 0.742%, which is slightly better than the 0.776% of VB-AFastSLAM.
A c c u r a c y = R M S E D i s t a n c e × 100
Since the true location of the features are not available, it cannot be quantitatively analyzed. Figure 10a,b are the feature prediction maps of VB-AFastSLAM and VB-AUFastSLAM, respectively. The eastward error (data points 2800 to 3200) of VB-AUFastSLAM in Figure 9b is smaller than that of VB-AFastSLAM. There is some deviation in the map constructed using the VB-AFastSLAM algorithm in Figure 10b. Nevertheless, the maps constructed by the two proposed algorithms generally fit the environmental characteristics.

6. Conclusions and Future Work

This paper proposes the AUV SLAM algorithms that combine the VB method and RBPF-SLAM. The dynamic noise of the sonar is estimated in real-time to improve the accuracy of the algorithm. Based on FastSLAM and UFastSLAM, we propose VB-AFastSLAM and VB-AUFastSLAM, respectively, and verify them in the simulation environment and the real sea trial environment, respectively. In the simulation verification stage, we demonstrated the adaptive ability of the proposed two algorithms to the observation noise by adding time-varying observation noise. At the same time, the large initialization error is verified, and the results show that, as the initialization error gradually increases, the positioning accuracy and feature estimation accuracy both decrease but are still within a reasonable range. Compared with their traditional algorithms, the running time of the two algorithms has increased to a certain extent, but they can meet the real-time performance. In addition, we verified the algorithms in the marine environment with the Sailfish-210 AUV. The Sonar, INS, and DVL data obtained below the water surface are used to locate the robot and map the coastline. The experimental results show that the proposed two algorithms have better localization results than the traditional algorithms, and the map construction is consistent with the actual coastline features.
There are still some challenges in the follow-up work of this paper. First of all, this paper considers the observation noise as white noise and has not solved the problem of colored noise for the time being. In addition, the filter’s performance is somewhat degraded due to the rejection of higher-order components in the linearization of the nonlinear model. Finally, when AUV faces the coastline environment with a single structure and sparse features for a long time, the use of more accurate feature matching techniques is also a key content that needs to be studied.

Author Contributions

Conceptualization, P.M.; methodology, P.M.; software, P.M.; validation, P.M., X.Z., P.Q. and B.H.; formal analysis, P.M.; investigation, P.M. and X.Z.; resources, B.H. and P.Q.; data curation, P.Q.; writing—original draft preparation, P.M.; writing—review and editing, P.M., P.Q. and X.Z.; supervision, P.Q.; project administration, P.M.; funding acquisition, B.H. All authors have read and agreed to the published version of the manuscript.

Funding

This work is supported by the Marine S&T Fund of Shandong Province for Pilot National Laboratory for Marine Science and Technology (Qingdao) (No.2018SDKJ0102-7), the National Key Research and Development Program of China (2016YFC0301400).

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

Not applicable.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Meng, X.; Sun, B.; Zhu, D. Harbour protection: Moving invasion target interception for multi-AUV based on prediction planning interception method. Ocean Eng. 2021, 219, 108268. [Google Scholar] [CrossRef]
  2. Paull, L.; Saeedi, S.; Seto, M.; Li, H. AUV Navigation and Localization: A Review. IEEE J. Oceanic Eng. 2014, 39, 131–149. [Google Scholar] [CrossRef]
  3. Chen, X.; Huang, J. Combining particle filter algorithm with bio-inspired anemotaxis behavior: A smoke plume tracking method and its robotic experiment validation. Measurement 2020, 154, 107482. [Google Scholar] [CrossRef]
  4. Zhao, D.; Liu, X.; Zhao, H.; Wang, C.; Tang, J.; Liu, J.; Shen, C. Seamless integration of polarization compass and inertial navigation data with a self-learning multi-rate residual correction algorithm. Measurement 2021, 170, 108694. [Google Scholar] [CrossRef]
  5. Mu, X.; He, B.; Wu, S.; Zhang, X.; Song, Y.; Yan, T. A practical INS/GPS/DVL/PS integrated navigation algorithm and its application on Autonomous Underwater Vehicle. Appl. Ocean Res. 2021, 106, 102441. [Google Scholar] [CrossRef]
  6. Zhang, X.; He, B.; Gao, S.; Mu, P.; Xu, J.; Zhai, N. Multiple model AUV navigation methodology with adaptivity and robustness. Ocean Eng. 2022, 254, 111258. [Google Scholar] [CrossRef]
  7. Song, J.; Li, W.; Zhu, X.; Dai, Z.; Ran, C. Underwater Adaptive Height-Constraint Algorithm Based on SINS/LBL Tightly Coupled. IEEE Trans. Instrum. Meas. 2022, 71, 1–9. [Google Scholar] [CrossRef]
  8. Cadena, C.; Carlone, L.; Carrillo, H.; Latif, Y.; Scaramuzza, D.; Neira, J.; Reid, I.; Leonard, J.J. Past, Present, and Future of Simultaneous Localization and Mapping: Toward the Robust-Perception Age. IEEE Trans. Robot. 2016, 32, 1309–1332. [Google Scholar] [CrossRef] [Green Version]
  9. Guo, J.; Jiang, R.; He, B.; Yan, T.; Ge, S.S. General Learning Modeling for AUV Position Tracking. IEEE Intell. Syst. 2020, 35, 28–38. [Google Scholar] [CrossRef]
  10. Gu, C.; Cong, Y.; Sun, G. Environment Driven Underwater Camera-IMU Calibration for Monocular Visual-Inertial SLAM. In Proceedings of the 2019 International Conference on Robotics and Automation (ICRA), Montreal, QC, Canada, 20–24 May 2019; pp. 2405–2411. [Google Scholar]
  11. Rahman, S.; Li, A.Q.; Rekleitis, I. Sonar Visual Inertial SLAM of Underwater Structures. In Proceedings of the 2018 IEEE International Conference on Robotics and Automation (ICRA), Brisbane, Australia, 21–25 May 2018; pp. 1–7. [Google Scholar]
  12. Hess, W.; Kohler, D.; Rapp, H.; Andor, D. Real-time loop closure in 2D LIDAR SLAM. In Proceedings of the 2016 IEEE International Conference on Robotics and Automation (ICRA), Stockholm, Sweden, 16–21 May 2016; pp. 1271–1278. [Google Scholar]
  13. Mallios, A.; Ridao, P.; Ribas, D.; Maurelli, F.; Petillot, Y. EKF-SLAM for AUV navigation under probabilistic sonar scan-matching. In Proceedings of the 2010 IEEE/RSJ International Conference on Intelligent Robots and Systems, Taipei, Taiwan, 18–22 October 2010; pp. 4404–4411. [Google Scholar]
  14. Simanek, J.; Reinstein, M.; Kubelka, V. Evaluation of the EKF-Based Estimation Architectures for Data Fusion in Mobile Robots. IEEE/ASME Trans. Mechatron. 2015, 20, 985–990. [Google Scholar] [CrossRef]
  15. Montemerlo, M.; Thrun, S.; Koller, D.; Wegbreit, B. FastSLAM: A factored solution to the simultaneous localization and mapping problem. In Proceedings of the Eighteenth National Conference on Artificial Intelligence, Edmonton, AB, Canada, 28 July–1 August 2002; pp. 593–598. [Google Scholar]
  16. Chen, L.; Yang, A.; Hu, H.; Naeem, W. RBPF-MSIS: Toward Rao-Blackwellized Particle Filter SLAM for Autonomous Underwater Vehicle With Slow Mechanical Scanning Imaging Sonar. IEEE Syst. J. 2020, 14, 3301–3312. [Google Scholar] [CrossRef] [Green Version]
  17. Liu, D.; Duan, J.; Shi, H. A Strong Tracking Square Root Central Difference FastSLAM for Unmanned Intelligent Vehicle With Adaptive Partial Systematic Resampling. IEEE Trans. Intell. Transport. Syst. 2016, 17, 3110–3120. [Google Scholar] [CrossRef]
  18. Sandoy, S.S.; Matsuda, T.; Maki, T.; Schjolberg, I. Rao-Blackwellized Particle Filter with Grid-Mapping for AUV SLAM Using Forward-Looking Sonar. In Proceedings of the 2018 OCEANS—MTS/IEEE Kobe Techno-Oceans (OTO), Kobe, Japan, 28–31 May 2018; pp. 1–9. [Google Scholar]
  19. Kim, C.; Sakthivel, R.; Chung, W.K. Unscented FastSLAM: A Robust and Efficient Solution to the SLAM Problem. IEEE Trans. Robot. 2008, 24, 808–820. [Google Scholar] [CrossRef]
  20. Nguyen, H.K.; Wongsaisuwan, M. A study on Unscented SLAM with path planning algorithm integration. In Proceedings of the 2014 11th International Conference on Electrical Engineering/Electronics, Computer, Telecommunications and Information Technology (ECTI-CON), Nakhon Ratchasima, Thailand, 14–17 May 2014; pp. 1–5. [Google Scholar]
  21. Tang, M.; Chen, Z.; Yin, F. An improved H-infinity unscented FastSLAM with adaptive genetic resampling. Robot. Auton. Syst. 2020, 134, 103661. [Google Scholar] [CrossRef]
  22. Lin, M.; Yang, C.; Li, D. An Improved Transformed Unscented FastSLAM With Adaptive Genetic Resampling. IEEE Trans. Ind. Electron. 2019, 66, 3583–3594. [Google Scholar] [CrossRef]
  23. Yin, S.; Zhu, X. Intelligent Particle Filter and Its Application on Fault Detection of Nonlinear System. IEEE Trans. Ind. Electron. 2015, 62, 3852–3861. [Google Scholar] [CrossRef]
  24. Cui, J.; Feng, D.; Li, Y.; Tian, Q. Research on simultaneous localization and mapping for AUV by an improved method: Variance reduction FastSLAM with simulated annealing. Def. Technol. 2020, 16, 651–661. [Google Scholar] [CrossRef]
  25. Poulose, A.; Han, D.S. Hybrid Indoor Localization Using IMU Sensors and Smartphone Camera. Sensors 2019, 19, 5084. [Google Scholar] [CrossRef] [Green Version]
  26. Lin, M.; Yang, C.; Li, D.; Zhou, G. Intelligent Filter-Based SLAM for Mobile Robots with Improved Localization Performance. IEEE Access 2019, 7, 113284–113297. [Google Scholar] [CrossRef]
  27. Wang, J.; Zhang, T.; Jin, B.; Zhu, Y.; Tong, J. Student’s t-Based Robust Kalman Filter for a SINS/USBL Integration Navigation Strategy. IEEE Sens. J. 2020, 20, 5540–5553. [Google Scholar] [CrossRef]
  28. Zhang, T.; Wang, J.; Zhang, L.; Guo, L. A Student’s T-Based Measurement Uncertainty Filter for SINS/USBL Tightly Integration Navigation System. IEEE Trans. Veh. Technol. 2021, 70, 8627–8638. [Google Scholar] [CrossRef]
  29. Sarkka, S.; Nummenmaa, A. Recursive Noise Adaptive Kalman Filtering by Variational Bayesian Approximations. IEEE Trans. Automat. Control 2009, 54, 596–600. [Google Scholar] [CrossRef]
  30. Bailey, T.; Durrant-Whyte, H. Simultaneous localization and mapping (SLAM): Part II. IEEE Robot. Automat. Mag. 2006, 13, 108–117. [Google Scholar] [CrossRef]
Figure 1. The Sailfish-210 AUV.
Figure 1. The Sailfish-210 AUV.
Jmse 10 01563 g001
Figure 2. Navigation coordinate system of Sailfish AUV.
Figure 2. Navigation coordinate system of Sailfish AUV.
Jmse 10 01563 g002
Figure 3. Simulation Environment.
Figure 3. Simulation Environment.
Jmse 10 01563 g003
Figure 4. Dynamic observation noise is set to n = 3; p = 0.2.
Figure 4. Dynamic observation noise is set to n = 3; p = 0.2.
Jmse 10 01563 g004
Figure 5. n = 2; p = 0.3, algorithms error comparison.
Figure 5. n = 2; p = 0.3, algorithms error comparison.
Jmse 10 01563 g005
Figure 6. Comparison of Neff with different observation noise.
Figure 6. Comparison of Neff with different observation noise.
Jmse 10 01563 g006
Figure 7. AUV trajectory.
Figure 7. AUV trajectory.
Jmse 10 01563 g007
Figure 8. Sailfish-210 during the mission.
Figure 8. Sailfish-210 during the mission.
Jmse 10 01563 g008
Figure 9. Comparison chart of sea trial trajectory and error comparison of four algorithms.
Figure 9. Comparison chart of sea trial trajectory and error comparison of four algorithms.
Jmse 10 01563 g009
Figure 10. The results of the proposed two algorithms for building the map.
Figure 10. The results of the proposed two algorithms for building the map.
Jmse 10 01563 g010
Table 1. Specifications of sensors.
Table 1. Specifications of sensors.
SensorsParameterValue
INSyaw0.3° RMS
Pitch, Roll0.02° RMS
Update Rate100 Hz
DVLOperational Altitude0.2–89 m
Sound Frequency614.4 kHz
Accuracy±0.2 cm/s
GPSPosition Accuracy2.5 m CEP
Update Rate1 Hz
PSAccuracy0.01% Range
Update Rate1 Hz
SONARFrequency675 kHz
Vertical beam width30°
Horizontal beam width
Detection distance0.3–100 m
Table 2. Parameters and initial values of the experiments.
Table 2. Parameters and initial values of the experiments.
ParameterValue/Initial Value
ρ 0.99
ξ 5
η 50
Table 3. Add dynamic observation noise.
Table 3. Add dynamic observation noise.
 For each observation noise
  If rand (1) < p
    R = n R 0
  end
 end
Table 4. n is constant, p increases.
Table 4. n is constant, p increases.
Comparison of RMSE of Each Algorithm (m)
FastSLAMUFastSLAMVB-AFastSLAMVB-AUFastSLAM
n = 2; p = 0.1Path2.7704783.195631.6253582.054199
Path-X0.8558390.903841.1322220.709995
Path-Y2.6030473.053171.1002741.847457
Feature9.27988310.6976.3312786.836124
n = 2; p = 0.2Path5.6693235.412722.8337152.058928
Path-X1.5225711.459131.2046610.751841
Path-Y5.4545975.212.4315792.023639
Feature18.9959818.14389.5488796.838111
n = 2; p = 0.3Path8.762458.1474793.1587632.102712
Path-X2.331232.1523311.4437480.666417
Path-Y8.44357.8566572.7543221.719888
Feature29.384627.3239610.199546.18904
n = 2; p = 0.4Path11.251710.775472.9660792.064112
Path-X2.96152.8165751.3206110.794151
Path-Y10.851310.397662.5077382.017267
Feature37.740336.130949.7352617.237978
n = 2; p = 0.5Path13.732412.83472.8956832.166283
Path-X3.571523.3588061.2683610.693661
Path-Y13.256512.384382.4832411.718042
Feature46.047943.033849.5721767.156179
Table 5. p is constant, n increases.
Table 5. p is constant, n increases.
Comparison of RMSE of Each Algorithm (m)
FastSLAMUFastSLAMVB-AFastSLAMVB-AUFastSLAM
n = 2; p = 0.2Path5.6693235.412722.8337152.058928
Path-X1.5225711.459131.2046610.751841
Path-Y5.4545795.212.4315792.023639
Feature18.9959818.14389.5488796.838111
n = 3; p = 0.2Path8.572497.8406942.5560532.149585
Path-X2.266092.1878151.2668310.6415
Path-Y8.265317.5225452.1007561.707999
Feature28.739126.301878.4059796.906663
n = 4; p = 0.2Path12.2688611.38832.7346132.019741
Path-X3.180363.056271.1757040.673702
Path-Y11.84710.96592.3189341.672129
Feature41.1418738.20469.4842666.615162
n = 5; p = 0.2Path15.4261416.16542.7973012.14828
Path-X4.0475954.213731.2731380.705636
Path-Y14.8841115.60392.3452351.512899
Feature51.7377954.239510.153736.941755
n = 6; p = 0.2Path18.6215918.08942.7978172.102595
Path-X4.8933864.857731.2756680.737804
Path-Y17.9637617.41992.3956131.746299
Feature62.448660.694610.035496.681115
Table 6. RMSE comparison with large error initialization (m).
Table 6. RMSE comparison with large error initialization (m).
Dynamic Observation Noise Is Set to n = 2; p = 0.3
η = 50 , ξ = 10 η = 50 , ξ = 20 η = 50 , ξ = 30 η = 50 , ξ = 40 η = 50 , ξ = 50
VB-AFastSLAMPath3.2215253.2230393.4064393.4705733.472635
Path-X1.4461311.3173211.4467591.2592491.310155
Path-Y2.7757322.7582772.9470623.1711443.125832
Feature10.544711.2057411.211611.2450311.47512
VB-AUFastSLAMPath2.1227992.5790162.7898132.7941722.863803
Path-X0.9946031.04251.0641960.9607371.030024
Path-Y1.8969492.399922.5465682.5291192.578043
Feature7.0215288.1312289.1887759.2278639.734567
Table 7. Running time comparison.
Table 7. Running time comparison.
FastSLAMUFastSLAMVB-AFastSLAMVB-AUFastSLAM
Running time (s)76.8727103.789892.1792126.9096
Table 8. The respective RMSE for each algorithm (m).
Table 8. The respective RMSE for each algorithm (m).
FastSLAMUFastSLAMVB-AFastSLAMVB-AUFastSLAM
Path6.59995.050282.805732.68190
Path-North5.496504.721672.190312.05031
Path-East3.653391.791971.753471.72882
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Mu, P.; Zhang, X.; Qin, P.; He, B. A Variational Bayesian-Based Simultaneous Localization and Mapping Method for Autonomous Underwater Vehicle Navigation. J. Mar. Sci. Eng. 2022, 10, 1563. https://doi.org/10.3390/jmse10101563

AMA Style

Mu P, Zhang X, Qin P, He B. A Variational Bayesian-Based Simultaneous Localization and Mapping Method for Autonomous Underwater Vehicle Navigation. Journal of Marine Science and Engineering. 2022; 10(10):1563. https://doi.org/10.3390/jmse10101563

Chicago/Turabian Style

Mu, Pengcheng, Xin Zhang, Ping Qin, and Bo He. 2022. "A Variational Bayesian-Based Simultaneous Localization and Mapping Method for Autonomous Underwater Vehicle Navigation" Journal of Marine Science and Engineering 10, no. 10: 1563. https://doi.org/10.3390/jmse10101563

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