ArticlePDF Available

A Novel FastSLAM Framework Based on 2D Lidar for Autonomous Mobile Robot

Authors:

Abstract and Figures

The autonomous navigation and environment exploration of mobile robots are carried out on the premise of the ability of environment sensing. Simultaneous localisation and mapping (SLAM) is the key algorithm in perceiving and mapping an environment in real time. FastSLAM has played an increasingly significant role in the SLAM problem. In order to enhance the performance of FastSLAM, a novel framework called IFastSLAM is proposed, based on particle swarm optimisation (PSO). In this framework, an adaptive resampling strategy is proposed that uses the genetic algorithm to increase the diversity of particles, and the principles of fractional differential theory and chaotic optimisation are combined into the algorithm to improve the conventional PSO approach. We observe that the fractional differential approach speeds up the iteration of the algorithm and chaotic optimisation prevents premature convergence. A new idea of a virtual particle is put forward as the global optimisation target for the improved PSO scheme. This approach is more accurate in terms of determining the optimisation target based on the geometric position of the particle, compared to an approach based on the maximum weight value of the particle. The proposed IFastSLAM method is compared with conventional FastSLAM, PSO-FastSLAM, and an adaptive generic FastSLAM algorithm (AGA-FastSLAM). The superiority of IFastSLAM is verified by simulations, experiments with a real-world dataset, and field experiments.
Content may be subject to copyright.
electronics
Article
A Novel FastSLAM Framework Based on 2D Lidar for
Autonomous Mobile Robot
Xu Lei 1,2, Bin Feng 1,2 , Guiping Wang 1,2,*, Weiyu Liu 1,2 and Yalin Yang 1,2
1The School of Electronics and Control Engineering, Chang’an University, Xi’an 710064, China;
xulei@chd.edu.cn (X.L.); fengbin.dev@outlook.com (B.F.); liuweiyu@chd.edu.cn (W.L.);
yangyalin1994@outlook.com (Y.Y.)
2The National Traffic Information and Control Virtual Simulation Experimental Teaching Center,
Chang’an University, Xi’an 710064, China
*Correspondence: gpwang@chd.edu.cn
Received: 24 March 2020; Accepted: 21 April 2020; Published: 24 April 2020


Abstract:
The autonomous navigation and environment exploration of mobile robots are carried out
on the premise of the ability of environment sensing. Simultaneous localisation and mapping (SLAM)
is the key algorithm in perceiving and mapping an environment in real time. FastSLAM has played an
increasingly significant role in the SLAM problem. In order to enhance the performance of FastSLAM,
a novel framework called IFastSLAM is proposed, based on particle swarm optimisation (PSO). In this
framework, an adaptive resampling strategy is proposed that uses the genetic algorithm to increase
the diversity of particles, and the principles of fractional differential theory and chaotic optimisation
are combined into the algorithm to improve the conventional PSO approach. We observe that the
fractional differential approach speeds up the iteration of the algorithm and chaotic optimisation
prevents premature convergence. A new idea of a virtual particle is put forward as the global
optimisation target for the improved PSO scheme. This approach is more accurate in terms of
determining the optimisation target based on the geometric position of the particle, compared to an
approach based on the maximum weight value of the particle. The proposed IFastSLAM method
is compared with conventional FastSLAM, PSO-FastSLAM, and an adaptive generic FastSLAM
algorithm (AGA-FastSLAM). The superiority of IFastSLAM is verified by simulations, experiments
with a real-world dataset, and field experiments.
Keywords:
FastSLAM; genetic algorithm; resampling; particle swarm optimisation; fractional
differential; chaotic; robot
1. Introduction
Owing to the rapid development of autonomous mobile robots, simultaneous localisation and
mapping (SLAM) [
1
] has emerged as a crucial technology in a great many applications, such as
self-driving, exploration, and navigation. SLAM can help a robot acquire information on the surrounding
environment through a self-positioning process in an unknown environment, and gradually builds
an incremental map. The robot performs the SLAM process iteratively in order to eliminate uncertain
factors and to estimate the position accurately. Due to the high accuracy and high frequency of lidar,
it is very suitable for observation of complex environments. SLAM based on lidar is therefore widely
used in practical robot applications. Lidar-based SLAM technologies include 2D lidar SLAM and 3D
lidar SLAM. The 3D lidar can identify more details of the environmental space and is suitable for
high-precision application scenarios, such as autonomous vehicles, but its application is expensive. The
2D lidar has high measurement accuracy in the two-dimensional plane, which can meet the navigation
and positioning requirements of mobile robots. Compared with 3D Lidar, it has lower cost and has the
possibility of wide application.
Electronics 2020,9, 695; doi:10.3390/electronics9040695 www.mdpi.com/journal/electronics
Electronics 2020,9, 695 2 of 25
At present, the most widely used SLAM frameworks based on 2D lidar include the approach
based on extended Kalman filter (EKF-SLAM) [
2
,
3
] and that based on Rao-Blackwellised particle filter
(RBPF-SLAM, also known as FastSLAM) [
4
]. EKF-SLAM ignores the higher-order terms of the Taylor
expansion when performing state estimation, resulting in a large uncertainty in the state estimation of
the robot. As part of the flow of the algorithm, the covariance matrix must be continuously calculated,
which creates increasing computational complexity as the maps expand. In contrast, FastSLAM is
a SLAM framework based on a particle filter, which was inspired by early probabilistic experiments by
Murphy [5] and Thrun [6]. The particle filter in FastSLAM takes advantage of Monte Carlo sampling
technology, which can properly estimate non-linear systems with better state accuracy.
In this paper we focus on the FastSLAM based on 2D lidar. The main drawback of FastSLAM is the
particle degeneracy problem, which arises due to insufficient particle diversity during resampling [
7
].
To overcome the issue of particle degeneracy, researchers have proposed many optimisation algorithms
to improve the resampling process in FastSLAM. Cugliari [
8
] introduced an unscented Kalman filter
into FastSLAM and proposed a resampling strategy based on adaptive selection. Liu [
9
] used an
adaptive fading extended Kalman filter to compute the proposal distribution in FastSLAM, and showed
that the distribution was closer to the posterior position of the mobile robot and that the degree of
particle degradation was reduced. Zhang [
10
] used a nonlinear adaptive square-root unscented Kalman
filter to replace the particle filter in FastSLAM to solve the problem of particle degradation, and found
that the accuracy and reliability of the algorithm were improved. While these algorithms have made
some progress compared to conventional FastSLAM, they fail to make effective use of the information
carried by all particles, and do not use collaborative optimisation methods to solve the issue of particle
degeneracy [11].
The genetic algorithm (GA) [
12
] is a commonly used method of ensuring the diversity of particles
before the resampling step. Conventional resampling algorithms suffer from particle degeneracy
problems, since higher-weight particles are repeatedly selected and lower-weight particles are deleted
after resampling. As a result, the remaining particles cannot closely approximate the true state of the
robot [
13
]. Due to the crossover and mutation steps used, the GA can improve the particle degeneracy
problem to a certain extent. Tai-Zhi [
14
] proposed a new FastSLAM algorithm based on revised
genetic resampling and a square-root unscented particle filter, in which a fast Metropolis–Hastings
algorithm was used as the mutation operator and was combined with traditional crossover to form
a new resampling method. Khairuddin [
15
] integrated the GA and PSO into FastSLAM, and overcame
the particle depletion problem by improving the accuracy of FastSLAM in terms of robot and landmark
set position estimation. However, in this approach, the scalar parameters of GA are undetermined,
and need to be tuned empirically. To solve these problems, we propose an adaptive genetic resampling
algorithm in which the crossover and mutation coefficients are determined adaptively based on the
distribution of particle weights. The new resampling algorithm is called AGA-Resampling.
PSO [
16
] is a group algorithm that optimises a problem by iteratively updating the particle set using
local and global optimal values. Global optimal solution can be obtained with high probability. It has
been proved that the PSO algorithm can effectively improve positioning accuracy in the problem of
positioning of mobile robots [
17
]. Tdor [
18
] introduced the PSO algorithm into SLAM for the first time,
while Havangi [
19
] used PSO to optimise the proposal distribution. PSO makes the particles aggregate
at locations with high posterior probability before the weights are updated, and the impoverishment of
particles can be prevent. Ye [
20
] proposed a random weight PSO strategy to improve the FastSLAM
algorithm, to avoid particle degeneracy and maintain particle diversity. Seung [
21
] proposed a relational
FastSLAM approach that integrated the PSO algorithm into the calculation of the weights and formation
of the particles. Zuo [
22
] proposed a new FastSLAM method based on quantum-behaved PSO to
improve the proposal distribution of particles and optimise the estimated particles. Due to the
collaborative optimisation of PSO, the accuracy of SLAM was significantly improved. However,
there still are some problems in with FastSLAM based on the PSO algorithm: The most typical of
these is that the algorithm can easily fall into a local optimum, and another is the low calculation
Electronics 2020,9, 695 3 of 25
speed. To further enhance the algorithm, we propose an improved PSO algorithm FCPSO, in which
the fractional differential is employed to speed up the evolution of the PSO algorithm and chaotic
optimisation is utilised to address the problem of premature convergence.
After particle filtering process in FastSLAM is complete, the map and the robot’s path are stored
in separate particles, each of which stores different information. The robot autonomously chooses one
particle from the particle set to represent the results of FastSLAM. In most cases, the particle that has
the highest importance weight is selected to represent the results [
23
]; however, the particle with the
highest weight does not always produce the best result, and this cannot be guaranteed. Nosan [
24
] has
proved that representation by means of particles provides a better result with a higher probability than
when the particle with the highest weight is used alone. Hence, we define a virtual particle based on
the mean of the particles, and the global optimisation value of the FCPSO algorithm is calculated using
the position of this virtual particle. The improved FCPSO algorithm is then introduced into FastSLAM
based on AGA-Resampling, which not only maintains the diversity of the particles but also alleviates
the particle degeneracy problem in FastSLAM. We call this improved FastSLAM method IFastSLAM.
The remainder of this paper is organised as follows. In Section 2, we describe the standard
FastSLAM algorithm, and the proposed improved algorithm is introduced. In Section 3, we discuss
simulation experiments and field experiments. Finally, a summary and future prospects are given in
Section 4.
2. Methodology
2.1. FastSLAM Algorithm Based on AGA-Resampling
SLAM is the process by which the robot draws the environment map and estimates its position [
1
].
A schematic diagram of this approach is shown in Figure 1. The mobile robot uses LIDAR to observe
unknown landmarks by moving within the environment. The variables described below are defined at
time t:
xt: state vector that represents the location and orientation of the robot
ut: The control input that drives the robot from state xt1to state xt
mt: A vector describing the position of the ith landmark
zt: The observation of the ith landmark from the robot
Besides, we define the following collections:
x1:t={x1,x2,...,xt}={x1:t1,xt}: The trajectory of the robot
u1:t={u1,u2,...,ut}={u1:t,ut}: The control input of the robot
m={m1,m2,...,mn}: The collection of landmark
z1:t={z1,z2,...,zt}: The collection of landmarks’ observation
n1:t={n1,n2,...,nt}: The correspondence variable of landmarks
The core idea of the FastSLAM algorithm is to calculate the posterior probability of the robot
trajectory and map by factorisation, as shown in
p(x1:t,m|z1:t,u1:t,n1:t) = p(x1:t|z1:t,u1:t,n1:t)
N
n=1
p(mn|x1:t,z1:t,n1:t). (1)
In FastSLAM, the Rao-Blackwellised particle filter is used to calculate the robot’s trajectory,
which is represented by
p(x1:t|z1:t
,
u1:t
,
n1:t)
. The possible trajectory of the robot is dictated by
particles. The map is represented by a series of landmarks that follow a Gaussian distribution,
which is updated using the observation model. Based on the premise that the position of the robot is
known, the extended Kalman filter is used to estimate the landmarks of the map, which are represented
by p(mn|x1:t,z1:t,n1:t).
Electronics 2020,9, 695 4 of 25
Figure 1. Schematic diagram of simultaneous localisation and mapping (SLAM).
2.1.1. Basic Flow of FastSLAM
Based on information from LIDAR and an odometer, the basic steps of the FastSLAM algorithm
are as follows:
1. Initialisation of the particles.
We initialize N particles, each of which has an initial weight ω(i)
0=0.
2. Retrieval.
The initial step involves retrieval of a particle representing the posterior at time
t
1 and the
sampling of the robot’s position at time t. The position of the robot is predicted by sampling
from a proposal distribution
π
, and is denoted as
x(i)
t
for the
i
th particle. Normally, the proposal
distribution generally adopts the probabilistic motion model p(xt|xt1,ut).
3. Importance weight.
The importance weight for the
i
th particle
ω(i)
t
represents the proportion between the target
distribution
p(x(i)
1:t|z1:t
,
u1:t1
,
n1:t)
and the proposal distribution
π
mentioned above. It is defined
as follows:
ω(i)
t=p(x(i)
1:t|z1:t,u1:t1,n1:t)
π(x(i)
1:t|z1:t,u1:t1,n1:t),i=1, . . . , N(2)
4. Resampling.
We define the effective number of particles Ne f f as follows:
Ne f f =1
N
i=1(ω(i)
t)2. (3)
By comparing
Ne f f
with the threshold set in advance, it can be determined whether to perform
resampling. The threshold selected here is
Nth =N/
2, where
N
denotes the total number of
particles. When
Ne f f >Nth
, resampling is performed, in which higher weighted particles are
copied and lower weighted particles are discarded.
5. Measurement update.
Electronics 2020,9, 695 5 of 25
The posterior of the map feature estimation
p(mn|x1:t
,
z1:t)
is updated based on the robot trajectory
x1:tand the observation z1:tof each particle.
The process of the standard FastSLAM is graphically depicted in Figure 2.
(a) (b)
(c) (d)
Figure 2.
The process of the standard FastSLAM. (
a
) Sampling. (
b
) Measurement. (
c
) Importance
weight. (d) Resampling.
2.1.2. Particle Degeneracy Problem in FastSLAM
In the resampling phase, it is essential to remove those particles with large estimation errors.
However, the resampling process leads to insufficient particle diversity: Only the higher weighted
particles are replicated, while the lower weighted particles are rejected, and the diversity of the particles
is therefore reduced.
Electronics 2020,9, 695 6 of 25
The particle degeneracy problem can be effectively solved by adding those particles that can
accurately estimate the robot’s position. However, since the position of the robot is unknown, it is
difficult to maintain good particles. Only when the particle swarm is able to share the most likely
position of the robot can a sufficient number of good particles be maintained.
2.1.3. Adaptive GA Resampling
In this section, we propose an adaptive strategy by introducing an improved resampling method
based on the GA [
25
]. Before resampling is applied, higher weighted particles are used to correct for
lower weighted particles through the crossover and mutation operations of the GA. The adaptive
strategy is used to determine the crossover degree and mutation probability for the GA. Compared
with traditional particle filtering, this resampling method based on an adaptive GA can effectively
improve the diversity of the particle swarm, and this can to some extent solve the particle degradation
problem of FastSLAM.
We assume that the particle sets are represented as
x(i)
t,ω(i)
t
(i= 1, ..., N), where
ω(i)
t
represents
the normalised particle weights. We sort particle weights
ω(i)
t
(i= 1, ..., N) in descending order and
store them in W:
W=nω(1)
t,ω(2)
t,...,ω(N)
to. (4)
Then we define a threshold WTbased on Ne f f :
WT=W(Nef f ). (5)
where W(i)represents the ith weight in the set W.
The particles are divided into two groups by WTas follows:
x(i)
tXL,i f ω(i)
tWT
XH,i f ω(i)
t>WT
(6)
where
XL
and
XH
are particle sets that contain the lower and higher weight particles, respectively.
We assume that
x(i)
t,L
and
x(i)
t,H
represent the particles from
XL
and
XH
, respectively. If
x(i)
t,c
represents
the modified particles, the formulation of the crossover operator can be given by:
x(k)
t,c=µx(i)
t,L+ (1µ)x(j)
t,H(7)
where
i=
1, . . .
NL
,
j=
1, . . .
NH
, and
k=i+j
.
NL
and
NH
denote the numbers of particles contained
in
XL
and
XH
, respectively. The parameter
µ[
0, 1
]
represents the crossover degree of the particles.
The greater the value of
µ
, the more information will be transferred from
x(i)
t,L
to
x(i)
t,c
and the less
information will be transferred from
x(j)
t,H
to
x(i)
t,c
. Especially when
µ
=1,
x(i)
t,c=x(i)
t,L
, no crossover occurs.
A mutation operator is applied to further increase the diversity of the particles. We assume that
x(i)
t,mrepresents the mutated particles. It may happen on the modified particles x(i)
t,caccording to:
x(i)
t,m=2x(j)
t,Hx(i)
t,c,i f rlPM
x(i)
t,c,i f rl>PM
(8)
where
rl
is a random variable drawn from a uniform distribution on [0,1].
PM
denotes the mutation
probability, which needs to be set in advance; if PM= 0, no mutation will occur.
An adaptive selection strategy is proposed here in order to determine the crossover degree
µ
and
the variation probability
PM
. It is well known that the smaller the variance in the particle weights,
the better the approximation to the true posterior distribution. We assume that
σ2
represents the
variance in the particle weights. Mathematical theorems have shown that for a sequence in the range
Electronics 2020,9, 695 7 of 25
[0,1], the variance is between zero and 1/4 [
26
], and the proof of this theorem is listed in Appendix A.
We can therefore draw the conclusion that when the weights of the particles are within the range [0,1],
the variance
σ2
is within the range [0,1/4]. The higher the value of
σ2
, the more crossover needs to be
performed. When
σ2
= 0, the quality of the particles is good enough that no crossover is necessary.
The relationship between µand σ2can therefore be represented as:
µ=14σ2(9)
When
σ2
= 0, the parameter
µ
= 1, meaning that no crossover occurs. Conversely, when
σ2
= 1/4,
the parameter
µ
= 0, meaning that a higher degree of crossover is needed to mitigate the degeneracy
problem of the particles.
Mutation is applied to the particles
x(i)
t,c
which are obtained from crossover with a certain
probability PM. In general, Pmin = 0.005 and Pmax = 0.01 [27].
When crossover is applied, the weights of the particle set also change. The variance in the new
particle weights is expressed as
σ2
. Similarly, the probability of mutation can also be determined
based on
σ2
; the greater the value of
σ2
, the more mutation need to be performed, and the higher
the probability of mutation
PM
. In particular, when
σ2
= 1/4, the mutation probability
PM=Pmax
,
and when
σ2
= 0, the mutation probability
PM=Pmin
. We therefore propose an adaptive selection
strategy for PMas follows:
PM=Pmin + (Pmax Pmin)·4σ2
(10)
In summary, we propose an improved resampling method based on the adaptive GA, which is
referred to here as AGA-Resampling. This approach is used to replace the classical resampling
of FastSLAM.
2.2. FastSLAM Optimised by FCPSO
2.2.1. PSO Improved by Fractional Differential
The PSO algorithm is derived from animal predation behavior. In this algorithm, the particle
swarm is randomly initialised using the fitness function to evaluate the solution, and the optimal
solution is found by iteration [28].
We assume that
Xi= (xi1
,
xi2
, . . . ,
xiN )
represents the position of the
i
th particle,
Pi=
(pi1
,
pi2
,...,
piN )
represents the local optimal of the particles, and
Pg= (pg1
,
pg2
,...,
pgN )
represents
the global optimisation of the particles. After t iterations, the velocities of the particles are updated by
Equation (11) and the positions are updated using Equation (12):
vt
id =ωivt1
id +c1r1(pid xt
id ) + c2r2(pgd xt
id )(11)
xt+1
id =xt
id +vt
id. (12)
In Equation (11),
d
denotes the dimension, where
d=
1, ...,
N
;
vid
is the d-dimensional component
of the velocity of the
i
th particle;
xid
is the d-dimensional component of the position of the
i
th particle;
pid
is the d-dimensional component of
Pi
;
pgd
is the d-dimensional component of
Pg
;
t
is the number of
iterations;
ω
is the inertia factor that determines the global and local optimisation ability;
c1
represents
the individual learning factor of each particle;
c2
represents the collective learning factor for each
particle; and
r1
and
r2
are random numbers between zero and one. In Equation (12), because the
sample period between
t
and
(t+
1
)
is 1, the moving distance in unit time is
vt
id ×
1, so the position
xt+1
id
can be calculated with the sum of a position
xt
id
plus a velocity
vt
id
. The standard PSO algorithm
has the problems of slow convergence and easy to fall into local convergence. So it is necessary to
make improvements.
The convergence speed of PSO is limited by its algorithm structure. Since fractional-order model
has superior memory characteristics, fractional differential theory is of great assistance to the dynamic
Electronics 2020,9, 695 8 of 25
evolution of particles in a particle swarm [
29
]. In this part, we introduce the fractional differential into
the PSO algorithm to change the convergence speed.
The fractional differential equation [
30
] for the discrete-time domain defined by Grunwald–Letnikov
is as follows:
Dα[x(t)] = 1
Tα·
r
k=0
(1)kΓ(α+1)x(tkT)
Γ(k+1)Γ(αk+1)(13)
where
Γ
denotes the gamma function,
T
denotes the sampling period, and
r
denotes the cut-off order
of the equation.
The speed update formula for the PSO algorithm is rearranged as follows:
vt
id ωivt1
id =c1r1(pid xt
id ) + c2r2(pgd xt
id ). (14)
Assuming
ω
= 1, this equation is a discrete form of differentiation. Assuming
T=
1 and following
Pires et al. [30] , we transform Equation ( 14 ) as follows:
Dα[x(t)] = c1r1(pid xt
id ) + c2r2(pgd xt
id ). (15)
Non-integer calculus cannot be directly processed by existing simulation tools, so it is necessary
to use finite-dimensional ideas to approximate fractional calculus [
31
]. Only the first four items are
considered, and Equation ( 15 ) can be expressed as:
vt=αv(t1)+1/2αvt2+1/6α(1α)vt3+1/24αv(1α)(2α)t4+c1r1(pid xt
id ) + c2r2(pgd xt
id ).(16)
By applying the idea of the fractional differential, the order of velocity differential
α
can be
generalised to a fraction between zero and one, which will result in a more stable change and
a longer memory effect. The value of
α
greatly affects the specific performance of the PSO algorithm:
The dynamic performance of the PSO algorithm is weakened when
α
is small, while if the value of
α
is
relatively large, the particle diversity will be increased and the global optimal value will be obtained
easier. Based on previous experiments [
32
], the fractional order
α
is set to 0.6 where the algorithm
converges at the fastest rate.
2.2.2. PSO Improved by Chaotic Optimisation
PSO is a relatively simple and fast-running algorithm. However, it cannot search for the global
optimal solution when all particles move toward a local optimum, and this gives rise to the premature
convergence phenomenon. The introduction of chaotic optimisation into the search algorithm can help
particles escape from local optima by generating many neighboring solutions for the local optimum [
33
].
Hence, we use a chaotic search to update a certain particle whenever it is judged that PSO is showing
premature convergence.
The judgment of premature convergence is based on the variance in the fitness of the particle
swarm [34]. The variance in the fitness of the particle swarm is denoted by σ2
f:
σ2
f=
N
i=1
fifavg
f, (17)
f=max1im|fifavg |,max1im|fifav g |>1
1, others (18)
where
f
is the normalization factor,
fi
the fitness of the
i
th particle, and
favg
the average fitness of the
particle swarm.
Electronics 2020,9, 695 9 of 25
The fitness variance
σ2
f
reveals the aggregation degree of the particle swarm. The smaller the value
of
σ2
f
, the more aggregated the particle swarm. When
σ2
f
is less than a constant C, chaotic operation
is performed.
The chaotic search space in this work is determined by the optimal position
pg=
(pg1
,
pg2
, . . . ,
pgn)
, which is found when the PSO algorithm falls into local convergence. The chaotic
variables is generated by the Logistic function [35] as show in Equation (19).
yq0=4yq(1yq),q=1, 2, . . . , n. (19)
N chaotic variables
yq0(
0
<yq0<
1
)
can be obtained by substituting n initial values
yq(
0
<yq<
1
)
with small differences into Equation (19). A solution vector to the objective function is then generated
according to Equation (20).
zq0=yq0pgq,q=1, 2, . . . , n. (20)
In summary, when the particles fall into a local optimum, the following steps are performed:
(1) Use the Logistic function to generate the chaotic sequence with initial chaotic variable with values
in the range [0,1]. (2) Calculate the fitness of each chaotic sequence and record the sequence with
the best fitness value. (3) Replace the local optimal particle of the current particles with the chaotic
sequence with the best fitness.
The standard PSO is improved by both fractional differential theory and chaotic optimisation.
This improved algorithm is referred to here as fractional differential and chaotic particle swarm
optimisation (FCPSO). The particle update speed is accelerated, and the hereditary nature of PSO is
increased. The particle swarm is also updated when premature convergence occurs, which increases
the diversity of the particle swarm.
2.2.3. The Proposal of the Virtual Particle
In general particle filter algorithm based on a standard PSO algorithm, the particle fitness in the
PSO algorithm is calculated based on the weight of the particle, and the particle with the largest weight
is taken as the global optimisation target [
36
]. However, it is proved that the mean value of the particle
positions is closer to the real location than the particle with the maximum weight [
24
]. We therefore define
a virtual particle according the mean value of the particle positions in this part. The virtual particle is not
a real particle in PSO, and it is just used to determine a global optimum for PSO optimisation.
The position of the virtual particle is calculated as follows:
xvir =1
N
N
i=1
xi, (21)
where xirepresents the initial position of the ith particle.
We introduce FCPSO optimisation into the FastSLAM algorithm. In particular,the fitness function
is calculated based on the position of the particle instead of the importance weight:
fi=kxixvir k, (22)
For each particle, we calculate the local optimum as follows:
Pi=xi. (23)
We select the virtual particle as the global optimum target rather than the largest weighted particle
as follows:
Pg=xvir. (24)
The main process of FCPSO is shown in Figure 3.
Electronics 2020,9, 695 10 of 25
We use the FCPSO algorithm to optimise the FastSLAM algorithm. First, we use the particle filter
based on AGA-Resampling to resample the possible robot position. We then define the virtual particle
and use it as the optimisation target of FCPSO, which attracts particles to move to the actual position
of the robot. The proposed method, which uses FastSLAM based on AGA-Resampling and is further
optimised by FCPSO, is called IFastSLAM. This approach is different from the standard FastSLAM
scheme because it uses an additional process to compensate for particle degeneracy. This compensation
process serves as a key strategy. The overall scheme of the algorithm is shown in Figure 4, and
pseudo-code is given in Algotithm 1.
IFastSLAM has several advantages: AGA-Resampling can effectively improve the diversity of
particles, and the iteration speed of PSO with fractional differential optimisation is increased, further
improving the speed of SLAM. In addition, PSO optimised by chaos can avoid local convergence and
can effectively improve the accuracy of SLAM.
(a) (b)
(c) (d)
Figure 3.
Particle update process of FCPSO. (
a
) Information sharing between particles. (
b
) Define the
virtual particle to get the global optimisation goal. (
c
) Deal with particle premature convergence using
chaotic optimisation. (d) Particles move toward global optimisation target.
Electronics 2020,9, 695 11 of 25
Figure 4. Scheme of IFastSLAM.
Electronics 2020,9, 695 12 of 25
Algorithm 1: IFastSLAM
1for m=1toNdo
2Retrieval. Retrieval mth particle from the particle set;
3Prediction. Sample a new pose x[k]
tp(xt|xt1,µt,n1:t);
4Measurement update. For each observed feature zi
tidentify the correspondence j for the
measurement zi
t, and incorporate the measurement zi
tinto the corresponding EKF, by
updating the mean µ[k]
j,tand covariance [k]
j,t;
5Importance weight. Calculate the importance weight ω(i)
tfor the new particle;
6AGA-Resampling. Use crossover and mutation operators [Equations (7) and (8)] where
the coefficients and mutation probability are given by [Equations (9) and (10)] to modify
the robot state;
7end
8Define the virtual particle: calculate the position of the virtual particle. [Equation (21)] ;
9for m=1toNdo
10 Initialize the velocity of the mth particle;
11 Initialize the velocity of the mth particle;
12 Initialize the fitness value of the mth particle;
13 end
14 for k=1toNdo
15 for m=1toNdo
16 Calculate the fitness value of the mth particle. [Equation (22)] ;
17 end
18 Determine the global optimal. [Equation (24)] ;
19 for m=1toNdo
20 Determine the local optimal of the mth particle. [Equation (23)] ;
21
Update the velocity of the m_th particle using Fractional Differential. [Equation (16)] ;
22 Update the position of the m_th particle. [Equation (12)] ;
23 end
24 Calculate the aggregation extent of the particle set. [Equation (17)] ;
25 if premature convergence occurred then
26 Implement Chaotic optimisation. [Equations (19) and (20)];
27 end
28 end
3. Experiments
In this section, we perform experiments with the simulation environment, the Victoria Park
dataset, and field experiments, in order to study the performance of the improved algorithm.
We performed simulation experiments using Matlab on Intel(R) Core (TM) i5-8250 CPU@1.6 GHz
RAM 8 GB PC. We used a robot equipped with LiDAR (SLAMTEC RPLIDAR) and an odometer for
field experiments.
3.1. Simulation
3.1.1. Simulation Setup
The simulation was performed using MATLAB to verify the accuracy and stability of IFastSLAM.
We developed the SLAM simulator based on the source code published by Bailey [37].
Electronics 2020,9, 695 13 of 25
In this work, we assumed that the robot moved at a constant speed. The model for the motion is
as follows:
xt+1
yt+1
θt+1
=
xt
yt
θt
+
vtcos(G+θt)
vtsin(G+θt)
vtcos(G)/WB
+Wt(25)
where
[xt
,
yt
,
θt]T
is the vector of the robot pose;
v
is the robot speed;
G
is the steering angle of the
robot;
WB
is the wheelbase of the robot;
t
is the sampling time interval;
Wt
is the system noise,
and WtN(0, Q).
The observation model used in the simulation experiment is as follows:
zt="ρi
βi#="q(mxxt)2+ (myyt)2
atan(myyt,mxxt)θt#+Vt(26)
where
[mx
,
my]T
is the coordinate of the
i
th landmark detected by the robot;
ρi
and
βi
represent
the distance and angle, respectively, of the
i
th landmark from the current robot position;
Vt
is the
observation noise; and VtN(0, R).
The simulation environment is illustrated in Figure 5a. It is in effect a search area of size
250
×
200 m. In this simulation experiment, 17 waypoints and 35 landmarks were randomly set.
The red trajectory represents the designated simulation path, the red ‘o’ is the waypoint, and the blue
asterisk is the stationary landmark. The robot starts from (0,0) and moves counterclockwise along
the red trajectory shown in Figure 5a to obtain the estimated trajectory and the estimated landmark.
Figure 5b shows a screenshot of the process of simulation at a certain moment. In Figure 5b, the black
triangle represents the robot, and the green circle represents the observation range of the robot, which
is centered on the robot. The robot can observe landmarks within a certain measuring angle inside the
green circle. The estimated trajectory is represented by a black line, and the estimated landmark is
denoted by a red asterisk.
(a) (b)
Figure 5.
Simulation interface. (
a
) Simulation environment. (
b
) A screenshot of the process of simulation.
The relevant parameters in the simulation are as follows. The initial position of the robot is
[
0, 0, 0
]T
; its speed is
v=
3 m/s; the maximum steering angle is 20
; The sampling time is 0.025 s; error
in the speed is
σv=
0.3 m/s; the sampling time of the laser radar is 0.2 s; the maximum measuring
distance is 30 m, the measurement error in the distance is
σρ=
0.1 m; and the error in the angle is
σβ= 1; The systematic noise Qand the observation noise Rare as follows:
Q="0.320
0(3π
180 )2#,R="0.120
0(π
180 )2#(27)
We use one hundred particles for simulation. Resampling is performed when Ne f f >50.
Electronics 2020,9, 695 14 of 25
3.1.2. Results and Analysis
We simulated FastSLAM, PSO-FastSLAM (FastSLAM based on PSO with particle weights),
AGA-FastSLAM (FastSLAM based on AGA-Resampling), and IFastSLAM with the same simulation
parameters in order to verify the superiority of the improved algorithm. The estimated robot path and
landmark location are shown in Figure 6.
(a)
(b)
Figure 6. Cont.
Electronics 2020,9, 695 15 of 25
(c)
(d)
Figure 6.
The simulation result of four SLAM algorithms. (
a
) FastSLAM. (
b
) Particle swarm
optimisation (PSO)-FastSLAM. (
c
) Adaptive generic FastSLAM algorithm (AGA-FastSLAM). (
d
)
IFastSLAM.
From the results, we can conclude that the estimated landmark location of IFastSLAM is essentially
consistent with the actual landmark location, and the estimated path substantially coincides with
the actual path. The proposed IFastSLAM algorithm is therefore more accurate than the other
three algorithms.
Electronics 2020,9, 695 16 of 25
In order to compare these four algorithms more intuitively, we compared the location estimation
error of the robot in X axis and Y axis, as shown in Figure 7. The positioning error is calculated
as follows:
error(t) = v
u
u
t(
N
i=1
xi(t)/Nxtrue )T(
N
i=1
xi(t)/Nxtrue )(28)
The positioning error reflects the absolute error between the actual position of the robot and the
average position of the particle swarm.
As shown in Figure 7a, the positioning error in X axis is less than 12 m in FastSLAM, less
than 7 m in the standard PSO-FastSLAM algorithm optimised by particle weight, less than 4 m in
AGA-FastSLAM, and within 3 m in IFastSLAM. The values of the estimation accuracy of the three
improved FastSLAM algorithms are higher than that of the standard FastSLAM. In PSO-FastSLAM,
the positioning accuracy is effectively improved due to the use of PSO optimisation. In AGA-FastSLAM,
adaptive genetic resampling is used to handle the particle degeneracy problem, and the positioning
accuracy is therefore also effectively improved. Furthermore, since the position of the virtual particle is
used as the optimisation target, and the premature convergence phenomenon is solved in the FCPSO
algorithm, the positioning error in IFastSLAM is smaller than in the other three algorithms. Similarly,
in the IFastSLAM algorithm, the positioning error in Y axis is also smaller than for the other three
algorithms, and the estimation accuracy is higher, as can be seen from Figure 7b.
As shown in Table 1, the IFastSLAM algorithm requires a shorter calculation time than
PSO-FastSLAM and IFastSLAM for the same number of particles; the reason for this is that the
use of fractional differential theory improves the evolution speed of the particle swarm. In addition,
the calculation time increases as the particle number increases.
(a) (b)
Figure 7. The estimation error. (a) Robot position error in X axis. (b) Robot position error in Y axis.
Table 1. Comparison of the RMSE and running time of SLAM algorithms.
Particle Number 20 50 100
FastSLAM Time (s) 30.49 76.13 153.57
RMSE (m) 8.43 7.90 6.84
PSO-FastSLAM Time (s) 34.02 81.35 159.05
RMSE (m) 6.31 5.10 4.79
AGA-FastSLAM Time (s) 33.95 80.96 158.84
RMSE (m) 5.12 3.78 3.25
IFastSLAM Time (s) 31.17 78.05 156.98
RMSE (m) 2.85 2.10 1.71
Electronics 2020,9, 695 17 of 25
As shown in Figure 8, the estimation accuracy of IFastSLAM is significantly higher than the other
three algorithms for the same number of particles. We can also clearly see that FCPSO-FastSLAM
maintains a low RMSE with fewer particles than the other three algorithms, since the use of the virtual
particle in the IFastSLAM algorithm, it can maintain more effective particles than the FastSLAM
algorithm and can therefore resolve the problem of particle degeneracy to some extent.
Compared with standard FastSLAM, IFastSLAM sacrifices a certain amount of calculation
time, but its estimation accuracy is significantly improved, and the running time is lower than for
PSO-FastSLAM and AGA-FastSLAM. In this sense, the IFastSLAM has better overall performance.
Figure 8. Simulation environment.
3.2. Verification Using the Victoria Park Dataset
In order to further compare the performance of IFastSLAM with PSO-FastSLAM and
AGA-FastSLAM, we applied several algorithms to the Victoria Park dataset [
38
]. This dataset is
provided by the Australian Center for Field Robotics (ACFR) and is widely applied by researchers to
verify the effectiveness and evaluate the performance of the SLAM algorithm in the real environment.
The mobile test platform used by the ACFR is shown as Figure 9. It is equipped with LiDAR,
an odometer, and GPS, and is driven a distance of 4 km over about half an hour. LiDAR is used to
provide observation information on the features of the road (trees in the park). The odometer is used
to provide information on the linear speeds and heading angles of vehicles. The GPS sensor is used to
provide reference vehicle location information. In this dataset, the errors caused by the inaccuracy of
GPS data is ignored, and the vehicle trajectory is approximately represented by GPS data [39].
Figure 9. The mobile test platform used by the ACFR.
Electronics 2020,9, 695 18 of 25
The validation results of several algorithms on the Victoria Park dataset are shown in Figure 10a–c,
where the blue line represents the real GPS track of the vehicle, the red line represents the vehicle track
estimated by the algorithm, and the yellow point represents the position of the landmark feature point.
From the white box in Figure 10, it can be seen that the IFastSLAM algorithm obtains an estimation
result that is closer to the real GPS track.
The RMSE of the robot trajectory and CPU running times of three algorithms on the Victoria Park
dataset are shown in Table 2. We can draw the conclusion that the RMSE of IFastSLAM is lower than
the other two algorithms, and it also requires less running time. Overall, we have verified the superior
performance of IFastSLAM on the Victoria Park dataset.
(a)
(b)
Figure 10. Cont.
Electronics 2020,9, 695 19 of 25
(c)
Figure 10.
The Victoria Park dataset validation results. (
a
) PSO-FastSLAM. (
b
) AGA-FastSLAM.
(c) IFastSLAM.
Table 2. Comparison of RMSE and running time with Voctoria Park dataset.
Algorithms Running Time (s) RMSE (m)
PSO-FastSLAM 1359.22 16.37
AGA-FastSLAM 1491.30 11.49
IFastSLAM 1406.57 9.15
3.3. Field Experiment
We used the mobile robot shown in Figure 11a to perform field experiments to test the
practicability of IFastSLAM. The robot was equipped with an internal odometer and a SLAMTEC
RPLIDAR A2 LiDAR, and moved at a speed of 0.3 m/s to create a grid map in real-time using LiDAR
and odometer data. The National Key Laboratory of Virtual Simulation of Chang’an University was
selected as the experimental site, as shown in Figure 11b.
(a) (b)
Figure 11.
Field experiment condition. (
a
) Mobile robot used in the field experiment. (
b
) Field
experimental site.
Electronics 2020,9, 695 20 of 25
The robot was driven along the specified path within the experimental site to build an
environmental map using radar scanning. Three algorithms were compared in this field experiment.
Figure 12a shows the map built by the PSO-FastSLAM algorithm, while Figure 12b,c show the
maps built by AGA-FastSLAM and IFastSLAM in the same environment, respectively. There are
obvious defects in the grid map built by PSO-FastSLAM as can be seen from Figure 12a, and a large
deviation appears at the boundary of the map. Similarly, blurring occurs at the edge of the grid map
built by the AGA-FastSLAM, as shown in Figure 12b. In contrast, the grid map built by the IFastSLAM
is more precise, as shown in Figure 12c.
(a)
(b)
(c)
Figure 12. Grid map by different algorithm. (a) PSO-FastSLAM. (b) AGA-FastSLAM. (c) IFastSLAM.
The results reveal that the map generated by IFastSLAM has fewer defects and higher precision,
while the maps generated by the PSO-FastSLAM and AGA-FastSLAM algorithms are of low quality.
Figure 13 shows the estimated trajectory for the different algorithms. We can see that the
trajectory estimated by the IFastSLAM algorithm correctly follows the ground truth, while the trajectory
estimated by PSO-FastSLAM and AGA-FastSLAM obviously deviates from the ground truth of the
Electronics 2020,9, 695 21 of 25
robot in some places. IFastSLAM has better localisation accuracy than the other two algorithms.
In addition, the running times of PSO-FastSLAM, AGA-FastSLAM, and IFastSLAM are 592.53 s,
647.09 s, and 629.74 s respectively, meaning that the computational efficiency of IFastSLAM is clearly
higher. Table 3show the RMSE of different algorithms in field experiment. It can be seen that the
RMSE of IFastSLAM algorithm is the smallest. It can be therefore concluded that IFastSLAM has better
overall performance.
Table 3. Comparison of RMSE for different algorithms in field experiment.
Algorithms PSO-FastSLAM AGA-FastSLAM IFastSLAM
RMSE (m) 0.27 0.16 0.09
Figure 13. The estimated trajectory for different algorithms in the field experiment.
4. Conclusions
In the resampling process of the conventional FastSLAM process, the accuracy decreases with the
number of iterations, due to particle degeneracy. We propose a framework named IFastSLAM that can
enhance the performance of FastSLAM based on PSO. In this framework, an adaptive GA is introduced
at the resampling stage, and a novel algorithm called FCPSO is proposed based on fractional differential
and chaotic optimisation to improve PSO-FastSLAM. Compared with conventional frameworks,
IFastSLAM has four significant benefits: (i) The diversity of particles is enriched by an adaptive GA;
(ii) the evolutionary speed of the PSO algorithm is increase; (iii) the problem of premature convergence
in PSO is alleviated; and (iv) the global optimisation accuracy is improved by using a virtual particle
as the optimisation target, and the errors in the trajectory and landmark estimations are reduced.
We compare our proposed IFastSLAM approach with FastSLAM, PSO-FastSLAM,
and AGA-FastSLAM on a series of SLAM issues. This comparison was made based on simulations, an
experiment with the Victoria Park dataset provided by ACFR, and a field experiment with a mobile
robot, showing promising results. In future work, we plan to integrate IFastSLAM into 3D maps and
carry out further study on path planning and collision detection for mobile robots. In addition, the
parameters used in FCPSO are taken directly from other studies, and we will readjust the parameters
in the next study to make them more suitable for robot systems.
Electronics 2020,9, 695 22 of 25
Author Contributions:
Conceptualization, X.L. and B.F.; methodology, X.L. and B.F.; software, B.F.; validation,
X.L., B.F. and W.L.; formal analysis, X.L., B.F. and W.L.; investigation, X.L., B.F., G.W. and Y.Y.; resources, X.L. and
G.W.; data curation, B.F. and Y.Y.; writing—original draft preparation, X.L. and B.F.; writing—review and editing,
G.W. and W.L.; visualization, B.F. and Y.Y.; supervision, G.W.; project administration, X.L. and G.W.; funding
acquisition, X.L. and G.W. All authors have read and agreed to the published version of the manuscript.
Funding:
This work was funded by the Key Research and Development Programs of Shaanxi Province (grants
2019ZDLGY15-04-02, 2018ZDCXL-GY-05-04, 2018ZDCXL-GY-05-07-02) and the Fundamental Research Funds for
the Central Universities (grants 300102329502, 300102320502).
Conflicts of Interest: The authors declare no conflict of interest.
Abbreviations
The following abbreviations are used in this paper:
Symbols Implication
SLAM Simultaneous localization and mapping
FastSLAM Rao-Blackwellized particle filter SLA
EKF-SLAM extended Kalman filter SLAM
AGA-Resampling adaptive genetic algorithm resampling
PSO Particle Swarm Optimisation
FCPSO fractional differential and chaotic PSO
IFastSLAM FastSLAM based on AGA-Resampling and optimized by FCPSO
xtthe state vector describing the position and orientation of the robot
utthe control vector, drive the robot from state xt1to state xt
mithe vector describing the position of the ith landmark
ztthe observation of the ith landmark from the vehicle at time t
ω(i)
tthe importance weight of ith particle
πthe proposal distribution of particles
Ne f f the effective number of particles
µthe crossover degree of the particles
PMthe mutation probability
Pithe local optimal position of the particles of PSO
Pgthe global optimal position of the swarm of PSO
vt
id the velocity of ith particle at time t
xt
id the position of ith particle at time t
σ2
fthe variance of particles’ population fitness
fithe fitness of the ith particle
favg the average fitness of the particle swarm
fthe normalization factor
mxthe mean of the particle position
vthe moving speed of the robot
Gthe steering angle of the robot
WB the wheelbase of the robot
W(t)the system noise at time t
V(t)observation noise at time t
Qsystematic noise covariance
Rthe observation noise covariance
Appendix A. Mathematical Proofs in the Paper
Theorem A1. For a sequence in the range [0,1], the variance is in the range [0,1/4].
Proof of Theorem A1.
Assume that there is a sequence consists of n random variables in the range
[0,1], namely
X1
,
X2
, ...,
Xn
. The average value of this sequence is denoted by Y. The variance is denoted
by Z. According to the calculation formula of variance,
Z= [(X1Y)2+ (X2Y)2+... + (XnY)2]/n
Electronics 2020,9, 695 23 of 25
= [(X1)2+ (X2)2+... + (Xn)22Y(X1+X2+... +Xn) + nY2]/n
= [(X1)2+ (X2)2+... + (Xn)22Y(nY) + nY2]/n
= [(X1)2+ (X2)2+... + (Xn)2nY2]/n
= [n(X1)2+n(X2)2+... +n(Xn)2(X1+X2+... +Xn)2]/n2
When
X2
,
X3
, ...,
Xn
are regarded as fixed values, the above formula is a quadratic function of
opening upward for
X1
. So when
X1
= 0 or
X1
= 1 (one of the two endpoints of the domain), the
variance Z takes the maximum value.
Similarly, when X2= 0 or X2= 1, the variance Z takes the maximum value.
...
Similarly, when Xn= 0 or Xn= 1, the variance Z takes the maximum value.
Therefore, only when the values of all random variables take values in 0 or 1, the variance Z takes
the maximum value. We will seek the maximum variance next. Assuming that in the sequence, the
number of random variables with a value of 0 is a, and the number of random variables with a value
of 1 is (na), then the average Y= (na)/n.
Z=[a(0Y)2+ (na)(1Y)2]/n
=a[0(na)/n]2/n+ (na)[1(na)/n]2/n
=[a(na)2+ (na)a2]/n3
=a(na)/n2
=(a2+na)/n2
=[(an/2)2+n2/4]/n2
1/4
Therefore, when
a=n/
2, in other words, the number of random variables with a value of 0 is
n/2, and the number of random variables with a value of 1 is n/2. Under these circumstances, the
variance Z takes the maximum value of 1/4. Because Z is a positive number, the variance Z is therefore
in the range [0,1/4].
In conclusion, for a sequence in the range [0,1], the variance is in the range [0,1/4].
References
1.
Durrant-Whyte, H.; Bailey, T. Simultaneous localization and mapping: Part I. IEEE Robot. Autom. Mag.
2006
,
13, 99–110.
2.
Dissanayake, M.G.; Newman, P.; Clark, S.; Durrant-Whyte, H.F.; Csorba, M. A solution to the simultaneous
localization and map building (SLAM) problem. IEEE Trans. Robot. Autom. 2001,17, 229–241.
3. Maybeck, P.S. Stochastic models, estimation, and control, ser. Math. Sci. Eng. 1979,141, 1.
4.
Montemerlo, M.; Thrun, S.; Koller, D.; Wegbreit, B. FastSLAM: A factored solution to the simultaneous
localization and mapping problem. AAAI/IAAI 2002, 593–598, doi:10.1007/s00244-005-7058-x.
5.
Murphy, K.P. Bayesian map learning in dynamic environments. In Advances in Neural Information Processing
Systems; The MIT Press: Denver, CO, USA, 2000; pp. 1015–1021.
6.
Thrun, S.; Burgard, W.; Fox, D. A real-time algorithm for mobile robot mapping with applications to
multi-robot and 3D mapping. In Proceedings of the 2000 IEEE International Conference on Robotics and
Automation, San Francisco, CA, USA, 24–28 April 2000; Volume 1, pp. 321–328.
7.
Bailey, T.; Nieto, J.; Nebot, E. Consistency of the FastSLAM algorithm. In Proceedings of the 2006 IEEE
International Conference on Robotics and Automation, Orlando, FL, USA, 15–19 May 2006; pp. 424–429.
8. Cugliari, M.; Martinelli, F. A FastSLAM algorithm based on the unscented filtering with adaptive selective
resampling. In Field and Service Robotics; Springer: Berlin, Germany, 2008; pp. 359–368.
9.
Liu, D.; Duan, J.; Yu, H. FastSLAM algorithm based on adaptive fading extended Kalman filter. Syst. Eng.
Electron. 2017,38, 644–651.
10.
Zhang, Y.F.; Zhou, Q.X.; Zhang, J.Z.; Jiang, Y.; Wang, K. A FastSLAM algorithm based on nonlinear adaptive
square root unscented Kalman filter. Math. Probl. Eng. 2017,2017, 4197635.
Electronics 2020,9, 695 24 of 25
11.
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.
12.
Mallik, S.; Mallik, K.; Barman, A.; Maiti, D.; Biswas, S.K.; Deb, N.K.; Basu, S. Efficiency and cost optimized
design of an induction motor using genetic algorithm. IEEE Trans. Ind. Electron. 2017,64, 9854–9863.
13.
Li, T.; Bolic, M.; Djuric, P.M. Resampling methods for particle filtering: classification, implementation, and
strategies. IEEE Signal Process. Mag. 2015,32, 70–86.
14.
Lv, T.Z.; Zhao, C.X.; Zhang, H.F. An improved FastSLAM algorithm based on revised genetic resampling
and SR-UPF. Int. J. Autom. Comput. 2018,15, 325–334.
15.
Khairuddin, A.R.; Talib, M.S.; Haron, H.; Abdullah, M.Y.C. GA-PSO-FASTSLAM: A hybrid optimization
approach in improving FastSLAM performance. In International Conference on Intelligent Systems Design and
Applications; Springer: Berlin, Germany, 2016; pp. 57–66.
16.
Kennedy, J.; Eberhart, R. Particle swarm optimization. In Proceedings of the ICNN’95—International
Conference on Neural Networks, Perth, WA, Australia, 27 November–1 December 1995.
17. Kwok, N.M.; Liu, D.; Dissanayake, G. Evolutionary computing based mobile robot localization. Eng. Appl.
Artif. Intell. 2006,19, 857–868.
18.
Todor, B.; Darabos, D. Simultaneous localization and mapping with particle swarm localization. In
Proceedings of the 2005 IEEE Intelligent Data Acquisition and Advanced Computing Systems: Technology
and Applications, Sofia, Bulgaria, 5–7 September 2005; pp. 216–221.
19.
Havangi, R.; Taghirad, H.D.; Nekoui, M. A.; Teshnehlab, M. A square root unscented FastSLAM with
improved proposal distribution and resampling. IEEE Trans. Ind. Electron. 2013,61, 2334–2345.
20.
Zhao, Y.; Wang, T.; Qin, W.; Zhang, X. Improved Rao-Blackwellised particle filter based on randomly
weighted particle swarm optimization. Comput. Electr. Eng. 2018,71, 477–484.
21.
Lee, S.H.; Eoh, G.; Lee, B.H. Relational FastSLAM: An improved Rao-Blackwellized particle filtering
framework using particle swarm characteristics. Robotica 2016,34, 1282–1296.
22.
Zuo, T.; Min, H.; Tang, Q.; Tao, Q. A Robot SLAM Improved by Quantum-Behaved Particles Swarm
Optimization. Math. Probl. Eng. 2018,2018.
23. Thrun, S. Probabilistic robotics. Commun. ACM 2002,45, 52–57.
24.
Kwak, N.; Lee, B.H.; Yokoi, K. Result representation of Rao-Blackwellized particle filtering for SLAM. In
Proceedings of the 2008 International Conference on Control, Automation and Systems, Seoul, Korea, 14–17
October 2008; pp. 698–703.
25.
Yin, S.; Zhu, X. Intelligent particle filter and its application to fault detection of nonlinear system. IEEE Trans.
Ind. Electron. 2015,62, 3852–3861.
26. DeGroot, M.H.; Schervish, M.J. Probability and Statistics; Pearson Education: NewYork, USA, 2012.
27.
Back, T. The interaction of mutation rate, selection, and self-adaptation within a genetic algorithm.
In Proceedings of the 2nd Conference of Parallel Problem Solving from Nature, Brussels, Belgium,
28–30 September 1992; Elsevier Science Publishers: Netherlands, 1992.
28.
Xin Zhang, Dexuan Zou, X.S. A Novel Simple Particle Swarm Optimisation Algorithm for Global
Optimisation. Mathematics 2018, 286–288, doi:10.3390/math6120287.
29.
Couceiro, M.S.; Ferreira, N.F.; Machado, J.T. Application of fractional algorithms in the control of a robotic
bird. Commun. Nonlinear Sci. Numer. Simul. 2010,15, 895–910.
30.
Pires, E.S.; Machado, J.T.; de Moura Oliveira, P.; Cunha, J.B.; Mendes, L. Particle swarm optimization with
fractional-order velocity. Nonlinear Dyn. 2010,61, 295–301.
31.
Couceiro, M.S.; Rocha, R.P.; Ferreira, N.F.; Machado, J.T. Introducing the fractional-order Darwinian PSO.
Signal Image Video Process. 2012,6, 343–350.
32.
Couceiro, M.S.; Ferreira, N.; Tenreiro Machado, J. Fractional order Darwinian particle swarm optimization.
In Symposium on Fractional Signals and Systems; Springer International Publishing, Berlin, Germany, 2011; pp.
127–136.
33.
Fan, S.K.S.; Jen, C.H. An Enhanced Partial Search to Particle Swarm Optimization for Unconstrained
Optimization. Mathematics 2019,7, 357.
34.
Pan, I.; Korre, A.; Das, S.; Durucan, S. Chaos suppression in a fractional order financial system using
intelligent regrouping PSO based fractional fuzzy control policy in the presence of fractional Gaussian noise.
Nonlinear Dyn. 2012,70, 2445–2461.
Electronics 2020,9, 695 25 of 25
35.
Shi, Y.; Chen, G. Chaos of discrete dynamical systems in complete metric spaces. Chaos Solitons Fractals
2004
,
22, 555–571.
36.
Zhang, G.; Cheng, Y.; Yang, F.; Pan, Q. Particle filter based on PSO. In Proceedings of the 2008 International
Conference on Intelligent Computation Technology and Automation (ICICTA), Hunan, China, 20–22 October
2008; Volume 1, pp. 121–124.
37.
Bailey, T. Source code for SLAM simulations of Tim Bailey. Available online: www.acfr.usyd.edu.au/
homepages/academic/tbailey/software (accessed on 1 March 2020).
38.
ACFR. Victoria Park Dataset. Available online: www.acfr.us-yd.edu.au/homepages/academic/enebot/
dataset.htm. (accessed on 1 March 2020).
39.
Nieto, J.I.; Guivant, J.E.; Nebot, E.M.; Thrun, S. Real time data association for FastSLAM. In Proceedings of
the 2003 IEEE International Conference on Robotics and Automation, Taipei, Taiwan, 14–19 September 2003;
Volume 1, pp. 412–418.
©
2020 by the authors. Licensee MDPI, Basel, Switzerland. This article is an open access
article distributed under the terms and conditions of the Creative Commons Attribution
(CC BY) license (http://creativecommons.org/licenses/by/4.0/).
... Compared to the previous methods, this enhancement improves the accuracy of SLAM as well as decreases the consumption time. In [14], a novel framework called IFastSLAM is introduced to enhance the performance of FastSLAM based on the PSO algorithm. The authors also use a GA algorithm to increase the diversity of particles in the resampling strategy. ...
... The FastSLAM 2.0 algorithm is implemented using the MATLAB code developed by Bailey [25]. Fig. 1 shows the tested environment map that is considered a two-dimensional map with 35 landmarks and 17 robot waypoints [10,11,14,16]. The blue trajectory indicates real motion path of the robot, the red 'o' represents the waypoint, the green '*' represents a real landmark, the red '·' represents an estimated landmark, the green triangle represents a real robot, and the red triangle represents an estimated robot. ...
... It provides the absolute error between the actual position and the corresponding average estimations of positions. The PE can be determined using the following equation [14]: ...
... Fast SLAM breaks down a SLAM problem into a robot positioning problem and a set of landmark estimation problems that are conditional on the robot status estimation [7]. So far, advanced versions of Fast SLAM have been offered by Lei et al. [8], but all of them are based on one basic rule; as reported by Murphy [9], the representation as such is accurate due to the natural conditional independence in the SLAM problem. Fast SLAM uses a modified particle filter to estimate the posterior paths of the robot. ...
... Fast SLAM based on the crow search algorithm is obtained by substituting the position obtained from the crow search algorithm, i.e. Equation (17), in the observed position in Equation (8). Therefore, we will have the following for the mean value: ...
... In other words: (20) where is the fitness function and ̃ is the estimated position using the proposed algorithm. The normalization factor ( ) [8], and are calculated as follows: ...
... SLAM, bir robotun oluşturulan haritada anlık olarak bulundugu konum tespit edilirken aynı zamanda bulundugu noktanın çevresinin haritasını oluşturmayla ilgilenen bir yöntemdir. Bu yöntemde robot çevresinin haritasını oluştururken aynı anda oluşturdugu haritayı da kullanabilmektedir [15,16]. ...
... Robot ilk başlangıç noktasında çevre haritasını ve konumunu bilmemektedir. Başlangıç noktasından itibaren kinematik bir modele sahip olan robot, bilinmeyen bir ortamda hareket etmektedir.Şekil 1'den de görülecegi üzere haritalama esnasında hem robot hem de yer işareti konumlarının eşzamanlı tahmini gerekmektedir [15,16]. ...
... Sekil 1: Temel SLAM çalışma prensibi [15,16] TOK'2022 Otomatik Kontrol Ulusal Toplantısı, 15-18 Eylül 2022, Elazığ ...
Conference Paper
Full-text available
Gezgin robotların bilinmeyen bir ortamda çevreyi haritalaması ve konum bilgisini elde etmesi için yaygın olarak SLAM (Simultaneous Localization and Mapping-Eş zamanlı Konum Belirleme ve Haritalama) kullanılmaktadır. SLAM uygulamalarında farklı tiplerde sensörler, algılayıcılar, kameralar vb. donanımlar birlikte kullanılabilmektedir. Bu sayede robot bulunduğu ve daha önce bilmediği ortamdan bilgi toplayabilmekte ve bunları işleyebilmektedir. Bu çalışmada, Gazebo simülasyon ortamında oluşturulan bir labirent içerisinde özerk gezgin bir robotun aranan bir nesneyi bulması, bu nesnenin lokasyonunun tespiti ve ortamın eş zamanlı haritalaması yapılmıştır. Sonrasında da robotun çıkarmış oldugu harita üzerinden en kısa yol hesaplanarak robotun başlangıç noktasına dönmesi sağlanmıştır. Çalışmada özerk gezgin robot olarak açık kaynak kodlu Turtlebot3 Waffle-Pi robotu LiDAR ve kamera eklenerek kullanılmıştır.
... Another method is the fractional α-stable filter [8], which introduces an adaptive filtering structure grounded in α-stable statistics and fractional-order calculus to address the state estimation problem in the presence of non-Gaussian noise, effectively enhancing the estimation accuracy of rapidly changing systems. Despite advancements in SLAM algorithm precision and robustness, addressing this degradation issue in particle filtering continues to be a subject of ongoing research and development [9][10][11]. ...
... Perform scan matching to refine the guess 11 Use the motion model to predict the pose 12 ...
Article
Full-text available
With the rapid advancement of mobile robotics technology, Simultaneous Localization and Mapping (SLAM) has become indispensable for enabling robots to autonomously navigate and construct maps of unknown environments in real time. Traditional SLAM algorithms, such as the Extended Kalman Filter (EKF) and FastSLAM, have shown commendable performance in certain applications. However, they encounter significant limitations when dealing with nonlinear systems and non-Gaussian noise distributions, especially in dynamic and complex environments coupled with high computational complexity. To address these challenges, this study proposes an enhanced particle filtering method leveraging particle swarm optimization (PSO) to improve the accuracy of pose estimation and the efficacy of map construction in SLAM algorithms. We begin by elucidating the foundational principles of FastSLAM and its critical role in empowering robots with the ability to autonomously explore and map unknown territories. Subsequently, we delve into the innovative integration of PSO with FastSLAM, highlighting our novel approach of designing a bespoke fitness function tailored to enhance the distribution of particles. This innovation is pivotal in mitigating the degradation issues associated with particle filtering, thereby significantly improving the estimation accuracy and robustness of the SLAM solution in various operational scenarios. A series of simulation experiments and tests were conducted to substantiate the efficacy of the proposed method across diverse environments. The experimental outcomes demonstrate that, compared to the standard particle filtering algorithm, the PSO-enhanced particle filtering effectively mitigates the issue of particle degeneration, ensuring reliable and accurate SLAM performance even in challenging, unknown environments.
... Lei et al. [20] proposed a novel framework termed IFastSLAM, which enhances the performance of the conventional FastSLAM algorithm by integrating PSO. They introduced an adaptive genetic algorithm for resampling to increase particle diversity and employed fractional differential theory and chaotic optimization to refine the PSO approach. ...
Article
Full-text available
In the realm of mobile robotics, the capability to navigate and map uncharted territories is paramount, and Simultaneous Localization and Mapping (SLAM) stands as a cornerstone technology enabling this capability. While traditional SLAM methods like Extended Kalman Filter (EKF) and FastSLAM have made strides, they often struggle with the complexities of non-linear dynamics and non-Gaussian noise, particularly in dynamic settings. Moreover, these methods can be computationally intensive, limiting their applicability in real-world scenarios. This paper introduces an innovative enhancement to the FastSLAM framework by integrating Multi-Objective Particle Swarm Optimization (MO-PSO), aiming to bolster the robustness and accuracy of SLAM in mobile robots. We outline the theoretical underpinnings of FastSLAM and underscore its significance in robotic autonomy for mapping and exploration. Our approach innovates by crafting a specialized fitness function within the MO-PSO paradigm, which is instrumental in optimizing the particle distribution and addressing the challenges inherent in traditional particle filtering methods. This strategic fusion of MO-PSO with FastSLAM not only circumvents the pitfalls of particle degeneration, but also enhances the overall robustness and precision of the SLAM process across a spectrum of operational environments. Our empirical evaluation involves testing the proposed method on three distinct simulation benchmarks, comparing its performance against four other algorithms. The results indicate that our MO-PSO-enhanced FastSLAM method outperforms the traditional particle filtering approach by significantly reducing particle degeneration and ensuring more reliable and precise SLAM performance in challenging environments. This research demonstrates that the integration of MO-PSO with FastSLAM is a promising direction for improving SLAM in mobile robots, providing a robust solution for accurate mapping and localization even in complex and unknown settings.
... Zhang and collaborators, by comparing three SLAM algorithms and integrating a path planning analysis to assess their applicability in indoor rescue environments, have provided guidance for researchers in the construction of SLAM systems [29]. Lei improved the FastSLAM algorithm framework by introducing virtual particles as a global optimization objective and utilizing a particle swarm optimization approach [30]. Mu and colleagues proposed a graph-based multi-sensor SLAM (Simultaneous Localization and Mapping) method. ...
Article
Full-text available
In this study an innovative parameterized water-bomb wheel modeling method based on recursive solving are introduced, significantly reducing the modeling workload compared to traditional methods. A multi-link supporting structure is designed upon the foundation of the water-bomb wheel model. The effectiveness of the supporting structure is verified through simulations and experiments. For robots equipped with this water-bomb wheel featuring the multi-link support, base on the kinematic model of multi-link structure, a mapping algorithm that incorporates parameterized kinematic solutions and IMU-fused parameterized odometry is proposed. Based on this algorithm, SLAM and autonomous navigation experiments are carried out in simulation environment and real environment respectively. Compared with the traditional algorithm, this algorithm the precision of SLAM is enhanced, achieving high-precision SLAM and autonomous navigation with a robot error rate below 5%.
... In the past decades, various techniques have been studied for SLAM problem and there have been remarkable achievements (Bresson et al. 2017;Sahu and Parhi 2022;Dissanayake et al. 2001;Luo and Qin 2018;Zeng et al. 2020;Lei et al. 2020). Among the proposed algorithms, the extended Kalman filter (EKF) and particle filter are the most often used probabilistic SLAM solutions. ...
Article
Full-text available
This paper presents a method that employs an evolutionary normal distributions transform (NDT) for simultaneous localization and mapping (SLAM) using light detection and ranging (LiDAR) for autonomous mobile robots. An adaptive inertia weight and two genetic operators were employed in the Taguchi-based whale optimization algorithm (WOA) to improve the search diversity and avoid local optima. NDT was used to model the environment of differential-drive mobile robots and WOA was applied to optimize the scan matching for the robotic SLAM problem. The NDT-WOA determines the SLAM pose estimation using sensed data from the physical world. A nonholonomic mobile robot was steered to achieve the NDT-WOA SLAM task with the derived robot kinematics and actuator dynamics. The proposed method was implemented in a TurtleBot3 Burger robotic development kit, which includes a single-board computer and an OpenCR control board. The Robot Operating System (ROS) was utilized to implement the evolutionary NDT-WOA SLAM system due to its flexibility, open source, and client library. Simulation and comparisons were conducted to illustrate the efficiency of the proposed NDT-WOA SLAM method compared to other SLAM paradigms. The experimental results show the effectiveness of the proposed evolutionary NDT-WOA SLAM for autonomous mobile robots. The results could have theoretical and practical significance for robotics research.
... The traditional resampling algorithms in SLAM may reduce the diversity of the samples [28][29][30], resulting in the loss of a lot of potentially helpful information. Therefore, many researchers proposed corresponding improved algorithms to increase particle diversity and enhance position accuracy [31]. The adaptive fading UKF-based SLAM method combined with gravitational field optimization was proposed to adjust the proposal distribution [32]. ...
Article
Full-text available
Simultaneous localization and mapping (SLAM) is crucial and challenging for autonomous underwater vehicle (AUV) autonomous navigation in complex and uncertain ocean environments. However, inaccurate time-varying observation noise parameters may lead to filtering divergence and poor mapping accuracy. In addition, particles are easily trapped in local extrema during the resampling, which may lead to inaccurate state estimation. In this paper, we propose an innovative simulated annealing particle swarm optimization-adaptive unscented FastSLAM (SAPSO-AUFastSLAM) algorithm. To cope with the unknown observation noise, the maximum a posteriori probability estimation algorithm is introduced into SLAM to recursively correct the measurement noise. Firstly, the Sage–Husa (SH) based unscented particle filter (UPF) algorithm is proposed to estimate time-varying measurement noise adaptively in AUV path estimation for improving filtering accuracy. Secondly, the SH-based unscented Kalman filter (UKF) algorithm is proposed to enhance mapping accuracy in feature estimation. Thirdly, SAPSO-based resampling is proposed to optimize posterior particles. The random judgment mechanism is used to update feasible solutions iteratively, which makes particles disengage local extreme values and achieve optimal global effects. The effectiveness and accuracy of the proposed algorithm are evaluated through simulation and sea trial data. The average AUV navigation accuracy of the presented SAPSO-AUFastSLAM method is improved by 18.0% compared to FastSLAM, 6.5% compared to UFastSLAM, and 5.9% compared to PSO-UFastSLAM.
Article
Simultaneous Localization and Mapping is an important field of work not only in robotics, but also in mobile platforms. This research work provides insight into how SLAM techniques are deployed in an indoor environment to aid first responders with their duties. Due to the hazardous nature of the environment and the need for sensitivity due to potential involvement of human subjects, autonomous robots cannot be used. So, the first responders must carry the scanning equipment and perform SLAM at the same time. As a result, unlike standard robot platforms, there will be no reliable odometry source, and SLAM will have to deal with the user’s unpredictable movement. In this work, we compare and examine ROS-based SLAM approaches without using any odometry for their application in the above-mentioned circumstances. Gmapping, HectorSLAM, and Cartographer have been chosen as the candidates for this evaluation. We evaluated these approaches in two different environments: a lab office, and a long corridor. The research results show that Cartographer outperforms the other two techniques in our test setup in terms of map quality and trajectory tracking. The Cartographer’s mapping error ranged from 0.017m to 0.3548m.
Article
Full-text available
Particle swarm optimization (PSO) is a population-based optimization technique that has been applied extensively to a wide range of engineering problems. This paper proposes a variation of the original PSO algorithm for unconstrained optimization, dubbed the enhanced partial search particle swarm optimizer (EPS-PSO), using the idea of cooperative multiple swarms in an attempt to improve the convergence and efficiency of the original PSO algorithm. The cooperative searching strategy is particularly devised to prevent the particles from being trapped into the local optimal solutions and tries to locate the global optimal solution efficiently. The effectiveness of the proposed algorithm is verified through the simulation study where the EPS-PSO algorithm is compared to a variety of exiting “cooperative” PSO algorithms in terms of noted benchmark functions.
Article
Full-text available
In order to overcome the several shortcomings of Particle Swarm Optimization (PSO) e.g., premature convergence, low accuracy and poor global searching ability, a novel Simple Particle Swarm Optimization based on Random weight and Confidence term (SPSORC) is proposed in this paper. The original two improvements of the algorithm are called Simple Particle Swarm Optimization (SPSO) and Simple Particle Swarm Optimization with Confidence term (SPSOC), respectively. The former has the characteristics of more simple structure and faster convergence speed, and the latter increases particle diversity. SPSORC takes into account the advantages of both and enhances exploitation capability of algorithm. Twenty-two benchmark functions and four state-of-the-art improvement strategies are introduced so as to facilitate more fair comparison. In addition, a t-test is used to analyze the differences in large amounts of data. The stability and the search efficiency of algorithms are evaluated by comparing the success rates and the average iteration times obtained from 50-dimensional benchmark functions. The results show that the SPSO and its improved algorithms perform well comparing with several kinds of improved PSO algorithms according to both search time and computing accuracy. SPSORC, in particular, is more competent for the optimization of complex problems. In all, it has more desirable convergence, stronger stability and higher accuracy.
Article
Full-text available
We propose a new SLAM method based on fast simultaneous localization and mapping (FastSLAM). The technique presented uses an improved quantum-behaved particles swarm optimization (QPSO) to improve the proposal distribution of particles and optimize the estimated particles. This method makes the sampled particles closer to the true pose of the robot and improves the estimation accuracy of robot poses and landmarks. In the QPSO algorithm, the Gaussian disturbance is added to increase the diversity of the particles. By using this technique the premature convergence of particles swarm is overcome. In the resample step, the threshold value is used to evaluate the particle diversity. When the particle diversity is below the threshold value, the linear optimization is used to produce new sample particles, which increases the particle diversity and eliminates the loss of diversity. Simulations and experiments show that the proposed approach improves the accuracy of SLAM. The accuracy of estimated poses and landmarks with the proposed method is better than that with the traditional SLAM method.
Article
Full-text available
For fast simultaneous localization and mapping (FastSLAM) problem, to solve the problems of particle degradation, the error introduced by linearization and inconsistency of traditional algorithm, an improved algorithm is described in the paper. In order to improve the accuracy and reliability of algorithm which is applied in the system with lower measurement frequency, a new decomposition strategy is adopted for a posteriori estimation. In proposed decomposition strategy, the problem of solving a 3-dimensional state vector and N 2-dimensional state vectors in traditional FastSLAM algorithm is transformed to the problem of solving N 5-dimensional state vectors. Furthermore, a nonlinear adaptive square root unscented Kalman filter (NASRUKF) is used to replace the particle filter and Kalman filter employed by traditional algorithm to reduce the model linearization error and avoid solving Jacobian matrices. Finally, the proposed algorithm is experimentally verified by vehicle in indoor environment. The results prove that the positioning accuracy of proposed FastSLAM algorithm is less than 1 cm and the azimuth angle error is 0.5 degrees.
Conference Paper
Full-text available
FastSLAM algorithm is one of the introduced Simultaneous Localization and Mapping (SLAM) algorithms for autonomous mobile robot. It decomposes the SLAM problem into one distinct localization problem and a collection of landmarks estimation problems. In recent discovery, FastSLAM suffers particle depletion problem which causes it to degenerate over time in terms of accuracy. In this work, a new hybrid approach is proposed by integrating two soft computing techniques that are genetic algorithm (GA) and particle swarm optimization (PSO) into FastSLAM. It is developed to overcome the particle depletion problem occur by improving the FastSLAM accuracy in terms of robot and landmark set position estimation. The experiment is conducted in simulation where the result is evaluated using root mean square error (RMSE) analysis. The experiment result shows that the proposed hybrid approach able to minimize the FastSLAM problem by reducing the degree of error occurs (RMSE value) during robot and landmark set position estimation.
Article
In this paper, a new Rao-Blackwellised particle filter simultaneous localization and mapping method based on randomly weighted particle swarm optimization is proposed in order to solve some problems in the Rao-Blackwellised particle filter, including the depletion of particles and the loss of the diversity in the process of resampling. The particle swarm optimization strategy is introduced in the modified algorithm, and the inertia weight is randomly set. Modified particle swarm optimization method is utilized to optimize the particle set in order to avoid particle degenerating and to keep the diversity. The proposed algorithm is simulated in the Qt platform. To verify the proposed method, the experiment is performed using turtlebot robots under the robot operating system. Results show that the proposed method is superior than extended Kalman filter based on simultaneous localization and mapping method.
Article
In the context of electricity shortage and an attempt to save the environment, introduction of energy efficient motors in different fields of application has become a necessity. This paves the way for fusing the conventional machine design procedures with optimization techniques. Unfortunately, the mathematics of electrical machine design involves calculations with highly nonlinear equation sets, and hence the conventional analytical optimization techniques do not fit well. In this study, design of an efficiency-optimized squirrel cage induction motor is considered, where genetic algorithm is chosen as the tool for optimization. The various constraints considered are selected on the basis of material, mechanical, and performance considerations as approved by standards and practices. The influence of change of materials and change of upper limit of customer's budget on different key motor design performance indicators are studied with and without cost constraints. Also, a systematic and statistics-based approach is proposed to achieve an optimized motor design, even at very low cost, provided relaxation of some constraints is allowed by the specific application. The optimized results are validated through tests on laboratory prototypes.
Article
FastSLAM is a popular framework which uses a Rao-Blackwellized particle filter to solve the simultaneous localization and mapping problem (SLAM). However, in this framework there are two important potential limitations, the particle depletion problem and the linear approximations of the nonlinear functions. To overcome these two drawbacks, this paper proposes a new FastSLAM algorithm based on revised genetic resampling and square root unscented particle filter (SR-UPF). Double roulette wheels as the selection operator, and fast Metropolis-Hastings (MH) as the mutation operator and traditional crossover are combined to form a new resampling method. Amending the particle degeneracy and keeping the particle diversity are both taken into considerations in this method. As SR-UPF propagates the sigma points through the true nonlinearity, it decreases the linearization errors. By directly transferring the square root of the state covariance matrix, SR-UPF has better numerical stability. Both simulation and experimental results demonstrate that the proposed algorithm can improve the diversity of particles, and perform well on estimation accuracy and consistency.