Next Article in Journal
Experience Replay Optimisation via ATSC and TSC for Performance Stability in Deep RL
Next Article in Special Issue
Underwater Target Recognition via Cayley-Klein Measure and Shape Prior Information in Hyperspectral Imaging
Previous Article in Journal
Kinesthetic Learning Based on Fast Marching Square Method for Manipulation
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Radar Target Localization with Multipath Exploitation in Dense Clutter Environments

National Key Laboratory of Science and Technology on Automatic Target Recognition, National University of Defense Technology, Changsha 410072, China
*
Author to whom correspondence should be addressed.
Appl. Sci. 2023, 13(4), 2032; https://doi.org/10.3390/app13042032
Submission received: 19 December 2022 / Revised: 29 January 2023 / Accepted: 2 February 2023 / Published: 4 February 2023
(This article belongs to the Special Issue Object Detection Technology)

Abstract

:
The performance of classic radar geometry based on the line-of-sight (LOS) signal transmitted from radar to the target in the free space is affected by multipath echoes in urban areas, where non-line-of-sight (NLOS) signals reflected by obstacles are received by the radar. Based on prior information of the urban situation, this article proposes a novel two-stage localization algorithm with multipath exploitation in a dense clutter environment. In the offline stage, multipath propagation parameters of uniformly distributed samples in the radar field of view are predicted by the ray-tracing technique. In the online stage, a rough location of the target is estimated by the maximum similarity between measurements and the predicted parameters of reference samples at different locations. The similarity is described by the likelihood between measurements and the predicted multipath parameters with respect to all possible associated hypotheses. A gating threshold is derived to exclude less likely hypotheses and reduce the computational burden. The accurate target location is acquired by a non-linear least squares (NLS) optimization of the associated multipath components. Simulation results in various noise conditions show that the proposed method provides robust and accurate target localization results under dense clutter conditions, and the offline pre-calculation of ray-tracing ensures the real-time performance of the proposed localization algorithm. The root mean square error (RMSE) of simulation results shows the advantage of the proposed method over the existing method. The presented results suggest that the proposed method can be applied to NLOS target localization applications in complex environments.

1. Introduction

Target localization in urban areas is an important requirement for both military and civilian applications, such as emergency rescue, security surveillance and intelligent transportation. A variety of techniques has been developed to detect and locate targets, including vision cameras, sonars, lidars and radars [1]. The all-time and all-weather advantages make radar an irreplaceable part of these techniques. However, dense buildings become obstacles to radar electromagnetic (EM) waves, which make EM waves propagate through not only the line-of-sight (LOS) path but also non-line-of-sight (NLOS) paths, such as reflection, diffraction and transmission. Radar systems commonly acquire range and angle measurements from time-of-arrival (TOA) [2,3] and direction-of-arrival (DOA) [4,5] of echo signals as LOS path returns. However, the lengths of received NLOS signals are longer than the range of the direct path from radar to the target in multipath propagations, and the received DOA of NLOS signals are different from the DOA of LOS path. Therefore the NLOS propagations lead to considerable errors in range and angle measurements in multipath scenarios [6]. The performances of classic radar target localization methods based on LOS geometry of free space propagation degrade significantly in such multipath environments.
To mitigate the multipath effect, multiple techniques have been proposed. Conventional researchers consider multipath signals as clutter and attempt to separate multipath signals from the received signal so that only the LOS signal is applied for further processing [7,8]. However, multipath signals propagated through NLOS paths provide extra spatial information that can be utilized to detect and locate targets. Early studies in constrained multipath scenarios demonstrated the possibility and effectiveness of multipath exploitation where the fixed multipath propagation can be modeled via analytical geometry methods [9,10,11,12]. A typical application is the over-the-horizon radar (OHTR) where EM waves are reflected by ionosphere layers at different heights. Classic data association methods (e.g., joint probabilistic data association filter (JPDAF), probabilistic multi-hypothesis tracker (PMHT) and probability hypothesis density (PHD) filter) combined the analytical geometry reflection model with unknown height have been proposed to improve the performance of OHTR target tracking problem [13,14,15,16,17]. Through-the-wall radar is another application that exploits the transmission of EM waves to detect and locate targets behind the wall [18,19,20].
In urban environments, a common task is indoor positioning which locates a target in the presence of both LOS and NLOS signals [21,22]. In this case, the NLOS signal reflected by obstacle walls is equivalent to the bistatic radar geometry model where a signal is transmitted from the radar tothe target and received by a virtual radar mirrored on the reflecting wall with the original radar. Therefore, target localization can be derived from the LOS path combined with the NLOS paths using the bistatic radar geometry without extra radar sources. In [23], the propagation path and wall association algorithm is proposed to associate multipath TOA signals to their corresponding reflecting obstacles, and target localization is derived by a non-linear least squares (NLS) optimization. The Cramer–Rao bound of the TOA-based multipath localization method is given in [24] to analyze the localization performance of radar at different places and obtain the optimal radar position setup in the given scenario. In [25], directional constraints are introduced to ultra-wideband radar for indoor positioning tasks to improve location accuracy in the absence of some NLOS paths. Liu et al. [26] proposed a multi-target location method based on target association hypothesis and consistency checking. Another typical task in urban areas is to detect targets behind the corner, where the LOS path does not exist and only reflected signals can be obtained [27,28]. Considering at least two NLOS paths are required to locate targets behind the corner, the multipath returns with the two largest echo amplitudes are selected to obtain candidate target positions, and the target true position is further derived by a correlation coefficient function [29,30]. Researchers also attempted to solve the NLOS target localization problem under real-world conditions with the latest deep learning methods [31,32,33].
The studies above based on analytical geometry modeling of multipath propagation implied prior information of the propagation model determined by the specific scenario, while the propagation model mismatching leads to significant localization error in the actual complex scene, especially in dense clutter environments. A widely used solution to predict EM wave propagation characteristics precisely is the ray-tracing technique based on physical optics (PO) which approximates the EM wave propagation in terms of rays [34,35]. The reflection, diffraction and transmission paths from the radar to the target can be computed with known scene information. A sequential Monte Carlo PHD filter based on real-time ray-tracing prediction is implemented to track mobile terminals in a large-scale urban scene [36]. For simple scenarios, validation of a 2D ray-tracer has been proved by comparison with measured data [37]. The ray-tracing technique is also used to generate multipath fingerprints for localization methods based on DOA, time difference of arrival or received signal strength [38,39,40]. However, real-time ray-tracing calculation is time-consuming in complex environments because of its high computational complexity. This paper concentrates on a preliminary offline calculation for ray-tracing prediction of multipath signals combined with high-accuracy real-time online localization in dense clutter environments. The main contributions of this paper are summarised as follows:
  • Derivation of the likelihood of cluttered multipath measurement with respect to the reference multipath parameters predicted by the ray-tracing technique and the approximation of multipath likelihood;
  • Proposal of an accurate target localization method based on NLS optimizations of associated multipath measurements;
  • Simulation results in various conditions validating the robustness and performance of the proposed method.
The remainder of this paper is organized as follows. Section 2 introduces the multipath propagation model and the multipath measurement model used in this paper. Section 3 describes the proposed localization algorithm in detail. In Section 4, simulations are carried out in different conditions to analyze the performance of the proposed method. Finally, conclusions are given in Section 5.

2. Model

In this section, we describe the multipath propagation model generated through the ray-tracing technique and the measurement model used by the proposed algorithm in Section 3.

2.1. Multipath Propagation Model via Ray-Tracing

Computational electromagnetics is widely used to simulate the propagation of EM waves in the field of communication, chip design and radar. The ray-tracing technique provides an effective approximation of EM waves when the wavelength is small compared to the size of structures in large-scale scenes, where the full-wave numerical method, such as a finite-difference time-domain (FDTD) method, cannot be applied because of the high computational complexity. The ray-tracing method describes the reflection, diffraction, and transmission of EM waves based on PO theory by representing EM waves radiated from the source as rays [41]. Since the implementation of the ray-tracing method is beyond the scope of our paper, details of the ray-tracing technique are not described further. In this paper, reflection paths from a given radar position to the target position are calculated by a commercial software Wireless Insite [42], with environmental information supposed to be prior knowledge. The diffraction paths are not included in the simulation because the irregular propagation geometry of diffraction paths is usually not applicable to localization algorithms. Let us denote the radar position by
r = [ x r , y r ] T ,
and the target position is
x = [ x d , y d ] T .
Then the detections of multipath propagation parameters can be abstracted into a non-linear function related to radar and target position as
H ( r , x ) = H x = { h x k } k = 1 N p ,
where N p is the number of propagation paths. and h x is the measurement vector for each path composed of corresponding TOA τ and DOA ϕ given by
h x k = [ τ x k , ϕ x k ] T .
Note that N p varies when the target location changes, so the set representation H x is used instead of vector representation, indicating that the number of elements is not fixed.
Since the multipath propagation H ( r , x ) has no closed form, an intuitive idea is to sample H x with a numerical method. Randomly distributed particles on the target state space sampled by a real-time ray-tracing method in previous studies revealed high-precision positioning results, while real-time ray-tracing calculation is time-consuming for the high computational complexity [43]. Instead, this paper uses fixed uniformly distributed samples which can be computed offline in advance. The position of uniformly distributed samples are indexed as
s ( i , j ) = s i j = [ i · Δ x , j · Δ y ] T , 1 i N x , 1 j N y ,
where Δ x and Δ y are the interval of samples in the x and y direction, and N x and N y are the corresponding number of samples. Figure 1 illustrates an example of a 3D ray-tracing result from Wireless Insite software and a 2D simplification ray-tracing result which ignored the altitude in elevation. For ease of simulation and illustration, the paper makes some simplifications, and 2D ray-tracing is adopted for subsequent simulation verification. Meanwhile, the method can be extended easily to 3D scenarios without modifying the localization algorithm. The parameters of single-trip multipath propagation from the radar to the sampled target positions are acquired by a ray-tracing method with proper simulation setups as
H 1 ( i , j ) = { h 1 ( i , j ) } k 1 = 1 N 1 ,
where N 1 is the number of single-trip paths. The round-trip path from the radar to the target and back to the radar is a combination of any two single-trip paths, so the number of round-trip paths is given as
N p = N 1 2 .
The TOA of the round-trip path is the sum of two single-trip paths, and the DOA of the round-trip path is equal to the DOA of the return path; thus, the multipath parameter set of round-trip propagation for the target located at x ( i , j ) is given as
H i j = { h i , j k } k = 1 N p ,
where each measurement vector is given by
h i , j k = [ τ i j k 1 + τ i j k 2 , ϕ i j k 2 ] , 1 k 1 , k 2 N l .

2.2. Measurement Model

In this subsection, we will introduce the radar measurement model. Let us denote the measured set of multipath echo as
Z = { z j } j = 1 N m ,
where N m is the number of detections, and z j is the measurement vector composed of TOA and DOA pairs as
z j = [ τ j , ϕ j ] T .
The radar detection process will produce false alarms and noise; therefore, the measured set Z is not the same as the theoretical multipath parameter set H x of the target. The measurement set consists of two parts denoted by
Z = C Z x ,
where the first part C denotes false alarms generated from clutter, and the second part Z x denotes measurements from the detected multipath components of target H x .
The clutter C is modeled as a Poisson point process (PPP) with Poisson rate λ ; thus, the number of clutter measurements is a Poisson distribution with the probability density function (PDF) given by
p ( | C | = n ) = e λ λ n n ! , n = 0 , 1 ,
Each clutter measurement c C is randomly distributed in the measurement space independently with the PDF given by
p ( c ) = 1 V ,
where V is the volume of the measurement space. The measurement vector z is specified by the radar TOA and DOA range as
τ [ τ m i n , τ m a x ] , ϕ [ ϕ m i n , ϕ m a x ] ,
thus the volume V is derived as
V = ( τ m a x τ m i n ) · ( ϕ m a x ϕ m i n ) .
The second part Z x is detections from the target. Each path of multipath echos from the target either generates one measurement with detection probability P D , or becomes a missed detection with probability 1 P D . The measurement noise for each detected path is modeled as an additive zero-mean Gaussian white noise w ; therefore the detected set Z x is the union of detections of each path expressed as
Z x = D ( h x 1 + w ) D ( h x N p + w ) ,
where D ( · ) denotes for the detection process which is a Bernoulli distribution with probability parameter P D denoted as
P r ( D ( h x + w ) = { h x + w } ) = P D , P r ( D ( h x + w ) = ) = 1 P D .

3. Method

In this section, the proposed two-stage localization algorithm is introduced. Figure 2 illustrates the framework of target detection and the localization algorithm. The overall structure of the proposed algorithm contains an offline stage and an online stage. In the offline stage, multipath propagation parameters of uniformly distributed targets are simulated by the ray-tracing technique introduced in Section 2.1. In the online stage, a two-step localization algorithm with multipath exploitation is proposed to locate targets with dense clutter. The first step is to obtain the multipath propagation model and a rough location by the maximum likelihood estimation (MLE) of measurement set Z and the sampled target multipath parameters H i j . In the second step, the accurate target location is estimated by an NLS method to eliminate off-grid errors originating from samples. A detailed discussion of the proposed likelihood function and localization algorithm is presented in the following subsections.

3.1. Likelihood Function with Multi-Measurement

The classic likelihood function describes the probability between target state and measurement, assuming that a target generates at most one measurement in one observation. However, this is not the case in multipath scenarios where a target may generate more than one measurement. Therefore, finite-set statistics (FISST) theory [44] is introduced to describe both the uncertainty of target location and the uncertainty of multipath propagation simultaneously. This subsection derives the likelihood function f ( Z | H x ) to describe the conditional probability density that the measurement set Z is generated by a potential target multipath propagation H x .
We introduce a multipath measurement association hypothesis variable θ = [ θ 1 , , θ N p ] to interpret whether each path h x k is detected in the measurement set Z as
θ k = j { 1 , , N m } , if z j is the detection of h x k , 0 , if h x k is not detected .
So the measurements generated from multipath component detections are given as
z x θ k = h x k + w , k = 1 , , N p .
With the assumption that all measurements, including false alarms from clutter and detections from target multipath returns, are independent of each other, the conditional probability density of detected set Z x with the given association hypothesis is derived as
p ( Z x | H x , θ ) = θ k = 0 ( 1 P d ) θ k > 0 P d · p ( z θ k | h x k ) ,
where the first product component denotes the probability of undetected paths, and the second component denotes the probability of detected paths, and the conditional probability density of each measurement given the associated path parameter is modeled as a Gaussian distribution
p ( z | h x ) = 1 ( 2 π ) N 2 det 1 2 ( Σ ) exp 1 2 ( z h x ) T Σ 1 ( z h x ) ,
where N is the dimension of vector h x , and Σ is the covariance of measurement noise w .
Measurements unassociated with target multipath echos in the hypothesis are false alarms generated from clutter, which can be expressed as
C = { z j | θ k = j , k = 1 , , N p } .
Then, the probability function of clutter conditioned on an association hypothesis is given as
p c ( C | θ ) = e λ ( λ V ) | C | ,
where | C | denotes the cardinality of the set.
The measurement likelihood conditioned on an association hypothesis is given as
p ( Z | H x , θ ) = p c ( C | θ ) p ( Z x | H x , θ ) .
Finally, the likelihood function of measurement set Z given target state set H x is derived by summing up all association hypotheses as
p ( Z | H x ) = θ Θ p ( Z | H x , θ ) ,
where Θ denotes the space of all possible association hypotheses.

3.2. Approximation of Likelihood

Let us consider the number of all possible hypotheses in Θ . The association variable θ is an N p -dimensional vector; therefore, the number of nonzero values of θ does not exceed N p . In addition, each measurement z in the measurement set is associated with the target propagation path at most once; thus, the number of nonzero values of θ does not exceed N m . Considering the case where θ contains k nonzero values, then the number of associations is expressed as
N m k N p k k ! ,
where N m k denotes the number of ways to select k measurements from Z , N p k denotes the number of ways to select k paths from H x , and k ! denotes the number of ways to assign the selected k elements. Therefore, the number of hypotheses in Θ is given as
N ( N m , N p ) = k = 0 m i n ( N m , N p ) N m k N p k k ! .
Since N ( N m , N p ) increases exponentially with the number of measurements and target paths, the O ( n ! ) level time complexity of p ( Z | H x ) is practically impossible to compute. Hence, appropriate approximation and complexity reduction techniques are introduced to reduce the numerical burden.
No threshold is set in the previous formula indicating that the measurement can be associated with any target path parameter h x . However, when the measurement is far away from h x , the conditional probability density p ( z | h x ) becomes small and can be ignored. Hence, we introduce a distance matrix D to describe the distance between each predicted path and measurement, where the normalized scale-invariant metric Mahalanobis distance is applied to obtain the distance between the k-th predicted path and j-th measurement as
d j , k = ( z j h x k ) T Σ 1 ( z j h x k )
Then, only measurements within a gate around the predicted target path are considered valid, and the association matrix G is acquired by a gating threshold T as
G j , k = 1 , if d j , k 2 < T , 0 , otherwise .
Without losing generality, we consider two hypotheses θ and θ that differ only in the K-th association expressed as
θ k = θ k , k = 1 , , N p , k K , θ k > 0 , θ k = 0 , k = K .
The threshold T should satisfy that the probability of a valid association between z θ K and h x K is larger than the probability that they are not associated with; therefore, we obtain the inequality as
p ( Z x | H x , θ ) > p ( Z x | H x , θ ) .
By substituting (21) and (24) into (32), we obtain
P d · p ( z θ K | h x K ) > λ V ( 1 P d ) .
Therefore, the threshold T is given by substituting (22) as
T = 2 log 2 π det ( Σ ) λ V 1 P d P d .
The number of hypotheses decreases significantly after the gating step. All valid hypotheses are enumerated by the recursive method proposed in the next step. Considering the case where two multipath components are associated with three measurements by an association matrix
G = 1 1 0 1 0 0 ,
we extend the matrix by appending an N m -dimentional identity matrix to the right as
G = 1 1 0 1 0 0 | 1 0 0 0 1 0 0 0 1 ,
where the left part denotes the associations with the target multipath, and the right part denotes the associations with clutter.
A valid assignment hypothesis under the extended association matrix expression is defined as a N m × ( N p + N m ) matrix A with the elements satisfying
A j k { 0 , 1 } , j , k , j A j k = 1 , k , k A j k { 0 , 1 } , j .
The first constraint denotes that the j-th measurement and the k-th target path are assigned. The second constraint denotes that each measurement must be assigned to a target path or clutter. The third constraint denotes that each target path or clutter is assigned at most once.
Considering that G is a sparse matrix, it is feasible to enumerate all possible assignment matrices A by a recursive enumeration method. Assume that m nonzero values are found in the first row of G . We have m valid assignment matrices initialized with A 1 K 1 = 1 separately, where K 1 is the corresponding column of the nonzero value. We then remove the first row and the K 1 -th column in G , and G is reduced to a ( N m 1 ) × ( N p + N m 1 ) association matrix. The procedure is repeated with the search and remove steps in the reduced association matrix until it is empty. The column of the nonzero value in the j-th recursion is recorded as K j , therefore A j K j is set to 1 recursively. The result of all valid assignment matrices for the example association matrix in (36) is given by
A 1 = 1 0 0 0 0 0 1 0 0 0 0 0 0 0 1 , A 2 = 1 0 0 0 0 0 0 0 1 0 0 0 0 0 1 , A 3 = 0 1 0 0 0 0 0 0 1 0 0 0 0 0 1 , A 4 = 0 0 1 0 0 0 1 0 0 0 0 0 0 0 1 , A 5 = 0 0 1 0 0 0 0 0 1 0 0 0 0 0 1 ,
where each assignment matrix can be converted into an association vector as
θ k = j , A j k = 1 , k = [ 1 , , N p ] , 0 , otherwise .
Therefore, the corresponding valid association vectors are given as
θ 1 = [ 1 , 2 ] , θ 2 = [ 1 , 0 ] , θ 3 = [ 2 , 0 ] , θ 4 = [ 0 , 2 ] , θ 5 = [ 0 , 0 ] .

3.3. Target Localization Algorithm

In this subsection, we proposed a two-step localization algorithm based on the likelihood function derived in the previous subsection. In the first step, the target multipath propagation model is estimated by traversal of the maximum likelihood between measurement set Z and all predicted samples H i j as
H ^ = arg max 1 i N x , 1 j N y p ( Z | H i j ) .
The sample location corresponding to the multipath propagation model H ^ obtained by MLE can be regarded as a rough estimation of the target location, while the uniformly distributed samples lead to off-grid errors. Hence, in the second step, an NLS-based localization algorithm is proposed to obtain the accurate target location based on the roughly estimated target location x ^ .
By law of reflection, the reflection path from radar to the target is equivalent to the path propagated to the target from a virtual radar mirroring the real radar with respect to the reflection obstacle as illustrated in Figure 3. We denote the normal vector of the reflecting surface as n = [ n 1 , n 2 , n 3 ] T ; therefore, the reflecting plane equation can be expressed as
n T · [ x x 0 , y y 0 , z z 0 ] T = 0 ,
where t = [ x 0 , y 0 , z 0 ] T is a point on the plane. Then, the distance from the radar r = [ x r , y r , z r ] T to the plane is given as
d = n T ( r t ) n ,
where n = n 1 2 + n 2 2 + n 3 2 is the length of the vector. The virtual radar position with the same distance as r in the opposite direction is derived as
r 1 = r 2 d n n .
We assume that n is a unit normal vector; thus, the mirrored virtual radar position can be rewritten into a matrix form as
x r 1 y r 1 z r 1 = 1 2 n 1 n 1 2 n 2 n 1 2 n 3 n 1 2 n 1 n 2 1 2 n 2 n 2 2 n 3 n 2 2 n 1 n 3 2 n 2 n 3 1 2 n 3 n 3 x r y r z r + 2 n T t n 1 n 2 n 3 .
Therefore, the mirroring of a radar point r with respect to a plane p is a linear transformation denoted as
r 1 = S p ( r ) .
The virtual radar position of multi-bounce reflection can be derived by the cascade of multiple single-bounce reflections. Let us denote the single-trip multi-bounce reflection path from target to the target as R O 1 O n T , where O 1 , , O n are reflection points with corresponding reflection planes p 1 , , p n . The virtual radar with respect to p 1 is given as r 1 = S p 1 ( r ) , and the equivalent path starting from virtual radar is given as R 1 O 2 O n T . By recursion, the equivalent virtual radar of the single-trip multi-bounce reflection is obtained by
r n = S p n ( r n 1 ) = S p n ( S p n 1 ( r n 2 ) ) S ( r ) .
As described in the previous subsection, measurements and predicted paths of x ^ are associated by the assignment matrices. Let us denote one of the predicted paths p x ^ is associated with measurement z . The round-trip signal received by the radar consists of single-trip paths, the transmitted path and the received path. The two virtual radars r 1 = [ x r 1 , y r 1 ] T and r 2 = [ x r 2 , y r 2 ] T of the transmitted path and the received path can be obtained by (47). If the transmitted path and the received path are the same, the radar geometry is equivalent to a monostatic radar geometry from virtual radar to the target directly. If the two paths are different, the radar geometry is equivalent to a bistatic radar geometry where the signal is transmitted from virtual radar r 1 to the target and received by virtual radar r 2 . Therefore, the length of the received round-trip path is derived as
h 1 = ( x r 1 x d ) 2 + ( y r 1 y d ) 2 + ( x r 2 x d ) 2 + ( y r 2 y d ) 2 ,
where x = [ x d , y d ] T is the target location, and the received DOA is given as
h 2 = arcsin y r 2 y d ( x r 2 x d ) 2 + ( y r 2 y d ) 2 .
The path parameter is expressed as a non-linear function of the target location by
h ( x ) = [ h 1 , h 2 ] T .
The conditional probability function of the measurement z with respect to the associated path is given as
p ( z | h ( x ) ) = 1 2 π det 1 2 ( Σ ) exp 1 2 z h ( x ) T Σ 1 z h ( x ) ,
where h = [ h 1 , h 2 ] T . Therefore, the probability of the assignment θ ^ is derived as
p ( Z | x ) = p c ( C | θ ^ ) θ ^ k = 0 ( 1 P d ) θ ^ k > 0 P d · p ( z θ ^ k | h k ( x ) ) ,
where θ ^ is the most significant association hypothesis selected from all valid hypotheses by
θ ^ = arg max θ p ( Z | H x , θ ) .
By maximizing the logarithmic likelihood function, the target localization problem is converted into an NLS optimization problem as
x ^ = arg min θ ^ k > 0 z θ ^ k h k ( x ) T Σ 1 z θ ^ k h k ( x ) .
The NLS optimization problem can be solved by numerical methods initialized with the target location estimated in the first step.

4. Simulation Results

Simulations are presented to evaluate the proposed algorithm in this section. The scenario setup is illustrated in Figure 4, where the dark blocks represent the obstacles in the scenario. A radar locates at ( 60 , 40 ) with the main lobe direction facing north. A total of 100 targets distributed from (35.5, 125.5) to (134.5, 125.5) along the x-axis direction at intervals of 1 m are simulated to study the robustness of the proposed localization algorithm in different multipath propagation conditions. The sampled locations computed offline are located at grids from (0, 0) to (160, 180) with intervals of 1 m along the x and y directions. Therefore, the off-grid error of localization caused by the distance between the targets and their nearest sample is 2 / 2 m.
Figure 5 illustrates the number of round-trip multipath components in the study area restricted by a rectangle with length of 160 m and width of 180 m, where the times of bounces for a simulated single-trip path in Figure 5a,b is limited to less than one and two, respectively. The increase in reflection times complicates the multipath propagation model not only in the maximum received multipath components but also in the heterogeneity of multipath components. As is shown in Figure 5, the maximum number of round-trip paths is 25 for the single-bounce case, while the number increases to 144 for the double-bounce case. Moreover, the propagation model varies quickly and becomes more sensitive to target locations as the reflection times increase. However, the increased paths do not contribute to the localization area because they still cannot reach the shadow regions compared to the single-bounce case. Considering the requirement of radar signal receiving energy, the times of bounces are limited to less than one in the following simulations, and single-trip reflection paths of more than one bounce are considered undetectable.
The ground truth of target multipath measurements as well as the cluttered measurements are illustrated in Figure 6. In the simulation, the probability of each path being detected P D is set to 0.8. Since the measurement of distance and angle are independent, zero-mean Gaussian noises are added to the distance and angle measurements separately with the corresponding standard deviation (STD) of the noises as s t d ( τ ) and s t d ( ϕ ) . Therefore, the covariance of measurement is given as
Σ = s t d 2 ( τ ) 0 0 s t d 2 ( ϕ ) .
We assume the Poisson rate λ equals 20, which means that each radar scan produces 20 cluttered measurements on average. Each cluttered measurement c = [ τ , ϕ ] is generated by two uniform distributions as
τ U ( 0 , 350 ) , ϕ U ( 0 , 180 ) ,
where [ 0 , 350 ] and [ 0 , 180 ] are distance and angle range of radar, respectively.
The localization results of the proposed algorithm are illustrated in Figure 7, where the dotted lines denote the grid-based localization error of the first step, and the solid lines denote the NLS-based localization error of the second step. Results from index 38 to 48 are excluded because no path of the target behind the obstacle propagates to the radar as shown in Figure 6b. Localization error is defined as the Euclidean distance between the estimated target location and the ground truth by x ^ x . The red lines present the simulation results that the STD of distance and angle measurement equals one. In the case of low noise level, the grid-based method results are accurate, and the off-grid error is the main cause of localization error. Therefore, the NLS-based method can improve the localization accuracy based on the correct estimation of the multipath propagation model. However, in the case of high noise levels displayed in the blue lines, the NLS-based approach shows little improvement due to the incorrect multipath propagation model estimated in the first step.
Furthermore, the impact of measurement noise is analyzed by Monte Carlo simulation of a target located at (110.5, 125.5). The root mean square error (RMSE) of localization is obtained by 100 simulations as
R M S E = 1 100 i = 1 100 x ^ i x 2 .
Figure 8 shows the RMSE with respect to different distance and angle noise STD, where Figure 8a is the grid-based result, and Figure 8b is the NLS-based result. The simulation result in Figure 8a shows that the first step of the proposed algorithm is more sensitive to distance measurement than angle measurement. Accurate localization results are obtained regardless of angle error in the condition that the STD of distance noise is less than one. However, the localization error increases along with the STD of distance when the STD of angle is less than one. The reason is that nearby samples share similar received angles, while the distance varies greatly. Therefore, if the distance measurement is precise, measurements with large angle errors are not associated with nearby samples. However, if the angle measurement is accurate and the distance measurement is inaccurate, the measurement is more likely to be associated with a nearby sample with similar angles and result in a wrong estimated location. Results illustrated in Figure 8b validate the effectiveness of the NLS-based re-localization process when the first step estimates the correct sample location.
The detailed performance of the proposed algorithm is illustrated in Figure 9. The NLS-based method improves the localization accuracy when the STD of distance is less than 1.5. When the STD of the angle equals 0.5, the proposed algorithm can locate the target in the high clutter environment with precision less than the off-grid error. When the STD of the angle becomes larger, the proposed algorithm still has fairly good performance, although the NLS-based method has no more improvement. If the radar distance measurement is accurate while the angle measurement is inaccurate, which is often the case, the proposed algorithm provides precise location results as shown in Figure 9b.
Existing multipath localization algorithms do not consider detections with clutter, and most of them have strict restrictions on the target scene, such as in the corner of a corridor [28] or in an urban canyon [25]. We choose an NLOS target localization algorithm based on grid matching of TOA returns proposed in [45] to verify the performance of the proposed algorithm. Since the original referenced algorithm does not consider measurements with clutter, the performance of the referenced algorithm is evaluated by Monte Carlo simulations with clean measurements as well as cluttered measurements. Since the referenced TOA-only algorithm does not use angle measurements, we restrict the proposed algorithm by fixed STD of angle measurements and analyze the performance of the two algorithms with varying STD of distance measurement. The Monte Carlo results illustrated in Figure 10 show that the proposed algorithm of our paper outperforms the referenced algorithm under both conditions even if the STD of angle measurement is set up to four. Table 1 shows the RMSE of the two localization algorithms. The proposed algorithm performs well in both scenes, and the RMSEs are less than 1 m. However, the performance of the referenced algorithm decreases significantly in the presence of cluttered measurement, and the algorithm is not applicable in dense clutter environments.

5. Conclusions

In this work, we presented a target localization method in multipath scenarios with high clutter. Multipath propagation is predicted by the ray-tracing technique based on prior knowledge of the urban environment. The proposed method determines the multipath propagation model by the likelihood function of multipath measurement and the predicted multipath with respect to all possible association hypotheses between them. Approximation of the proposed likelihood function is derived by excluding impossible hypotheses with a gating threshold. Then, accurate target location is obtained by an NLS optimization based on the estimated multipath propagation model. Simulation results showed that the proposed method provides robust and accurate estimation of target location in a high clutter environment. The promotion of the proposed multi-measurement likelihood function to the classic single-measurement tracking problem can be an interesting and practical topic. Particularly, considering the association explosion in the multi-target multi-measurement localization problem, integration of localization and the tracking process is expected to provide a possible solution in future work.

Author Contributions

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

Funding

This research was funded by National Defense Basic Research program of China grant number WDZC20195500208.

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. Zekavat, S.; Buehrer, R.M. Source Localization: Algorithms and Analysis. In Handbook of Position Location: Theory, Practice, and Advances; Wiley-IEEE Press: Piscataway, NJ, USA, 2012; pp. 25–66. [Google Scholar]
  2. Zou, Y.; Fan, J.; Wu, L.; Liu, H. Fixed Point Iteration Based Algorithm for Asynchronous TOA-Based Source Localization. Sensors 2022, 22, 6871. [Google Scholar] [CrossRef] [PubMed]
  3. Abu-Shaban, Z.; Zhou, X.; Abhayapala, T.D. A Novel TOA-Based Mobile Localization Technique Under Mixed LOS/NLOS Conditions for Cellular Networks. IEEE Trans. Veh. Technol. 2016, 65, 8841–8853. [Google Scholar] [CrossRef]
  4. Wielandt, S.; De Strycker, L. Indoor multipath assisted angle of arrival localization. Sensors 2017, 17, 2522. [Google Scholar] [CrossRef]
  5. Li, C.; Zhen, J.; Chang, K.; Xu, A.; Zhu, H.; Wu, J. An Indoor Positioning and Tracking Algorithm Based on Angle-of-Arrival Using a Dual-Channel Array Antenna. Remote Sens. 2021, 13, 4301. [Google Scholar] [CrossRef]
  6. Zhu, K.; Wei, Y.; Xu, R. TOA-based localization error modeling of distributed MIMO radar for positioning accuracy enhancement. In Proceedings of the 2016 CIE International Conference on Radar (RADAR 2016), Guangzhou, China, 10–13 October 2016. [Google Scholar] [CrossRef]
  7. Chen, Z.; Xu, A.; Sui, X.; Wang, C.; Wang, S.; Gao, J.; Shi, Z. Improved-UWB/LiDAR-SLAM Tightly Coupled Positioning System with NLOS Identification Using a LiDAR Point Cloud in GNSS-Denied Environments. Remote Sens. 2022, 14, 1380. [Google Scholar] [CrossRef]
  8. Cong, L.; Zhuang, W. Nonline-of-sight error mitigation in mobile location. IEEE Trans. Wirel. Commun. 2005, 4, 560–573. [Google Scholar] [CrossRef]
  9. Sen, S.; Nehorai, A. Slow-time multi-frequency radar for target detection in multipath scenarios. In Proceedings of the ICASSP, IEEE International Conference on Acoustics, Speech and Signal Processing, Dallas, TX, USA, 14–19 March 2010; pp. 2582–2585. [Google Scholar] [CrossRef]
  10. Sen, S.; Nehorai, A. Sparsity-based multi-target tracking using OFDM radar. IEEE Trans. Signal Process. 2011, 59, 1902–1906. [Google Scholar] [CrossRef]
  11. Sen, S.; Nehorai, A. Adaptive OFDM radar for target detection in multipath scenarios. IEEE Trans. Signal Process. 2011, 59, 78–90. [Google Scholar] [CrossRef]
  12. Sen, S.; Tang, G.; Nehorai, A. Designing OFDM radar waveform for target detection using multi-objective optimization. In Advances in Heuristic Signal Processing and Applications; Springer: Berlin/Heidelberg, Germany, 2013; pp. 35–61. [Google Scholar] [CrossRef]
  13. Romeo, K.; Bar-Shalom, Y.; Willett, P. Fusion of multipath data with ML-PMHT for very low SNR track detection in an OTHR. J. Adv. Inf. Fusion 2015, 10, 113–124. [Google Scholar]
  14. Romeo, K.; Bar-Shalom, Y.; Willett, P. Low SNR track detection with OTHR based on a refraction model. In Proceedings of the 2016 IEEE Radar Conference (RadarConf 2016), Philadelphia, PA, USA, 2–6 May 2016; pp. 2–5. [Google Scholar] [CrossRef]
  15. Lan, H.; Liang, Y.; Pan, Q.; Yang, F.; Guan, C. An EM algorithm for multipath state estimation in OTHR target tracking. IEEE Trans. Signal Process. 2014, 62, 2814–2826. [Google Scholar] [CrossRef]
  16. Yang, F.; Wang, Y.; Liang, Y.; Pan, Q. A multipath Gaussian mixture PHD filter algorithm for OTHR multi-target tracking. In Proceedings of the 32nd Chinese Control Conference (CCC), Xi’an, China, 26–28 July 2013; pp. 4607–4612. [Google Scholar]
  17. Pulford, G.W.; Evans, R.J. A multipath data association tracker for over-the-horizon radar. IEEE Trans. Aerosp. Electron. Syst. 1998, 34, 1165–1183. [Google Scholar] [CrossRef]
  18. Zhang, Y.; Xia, T. In-Wall Clutter Suppression Based on Low-Rank and Sparse Representation for Through-the-Wall Radar. IEEE Geosci. Remote Sens. Lett. 2016, 13, 671–675. [Google Scholar] [CrossRef]
  19. Qu, L.; Fang, Z.; Yang, T.; Sun, Y.; Zhang, L. Sparse Recovery Method for Estimation of Wall Parameters in Through-the-Wall Radar. In Proceedings of the IGARSS 2019—2019 IEEE International Geoscience and Remote Sensing Symposium, Yokohama, Japan, 28 July–2 August 2019; pp. 3558–3561. [Google Scholar] [CrossRef]
  20. Yektakhah, B.; Sarabandi, K. A Method for Detection of Flat Walls in Through-the-Wall SAR Imaging. IEEE Geosci. Remote Sens. Lett. 2021, 18, 2102–2106. [Google Scholar] [CrossRef]
  21. Yong Kang, O.; Long, C. A Robust Indoor Mobile Localization Algorithm for Wireless Sensor Network in Mixed LOS/NLOS Environments. J. Sens. 2020, 2020, 8854389. [Google Scholar] [CrossRef]
  22. Al-Qudsi, B.; Joram, N.; El-Shennawy, M.; Ellinger, F. Scalable indoor positioning system with multi-band FMCW. IET Radar Sonar Navig. 2018, 12, 46–55. [Google Scholar] [CrossRef]
  23. Setlur, P.; Smith, G.E.; Ahmad, F.; Amin, M.G. Target localization with a single-antenna monostatic radar via multipath exploitation. Radar Sens. Technol. XV 2011, 8021, 80210J. [Google Scholar] [CrossRef]
  24. Setlur, P.; Devroye, N. Bayesian and Cramér-Rao bounds for single sensor target localization via multipath exploitation. In Proceedings of the ICASSP, IEEE International Conference on Acoustics, Speech and Signal Processing, Vancouver, BC, Canada, 26–31 May 2013; pp. 5845–5849. [Google Scholar] [CrossRef]
  25. Muqaibel, A.H.; Amin, M.G.; Ahmad, F. Target localization with a single antenna via directional multipath exploitation. Int. J. Antennas Propag. 2015, 2015, 510720. [Google Scholar] [CrossRef]
  26. Liu, C.; Xiang, H.; Li, F.; Shi, H.; Wang, W.; Gao, W.; Zhang, J.; Ning, Y. Study on GNSS-R multi-target detection and location method based on consistency checking. IET Radar Sonar Navig. 2021, 15, 605–617. [Google Scholar] [CrossRef]
  27. Kamann, A.; Held, P.; Perras, F.; Zaumseil, P.; Brandmeier, T.; Schwarz, U.T. Automotive Radar Multipath Propagation in Uncertain Environments. In Proceedings of the 2018 21st IEEE Conference on Intelligent Transportation Systems (ITSC), Maui, HI, USA, 4–7 November 2018; pp. 859–864. [Google Scholar] [CrossRef]
  28. Li, S.; Guo, S.; Chen, J.; Yang, X.; Fan, S.; Jia, C.; Cui, G.; Yang, H. Multiple Targets Localization behind L-Shaped Corner via UWB Radar. IEEE Trans. Veh. Technol. 2021, 70, 3087–3100. [Google Scholar] [CrossRef]
  29. Zhao, Q.; Cui, G.; Guo, S.; Yi, W.; Kong, L.; Yang, X. Millimeter Wave Radar Detection of Moving Targets behind a Corner. In Proceedings of the 2018 21st International Conference on Information Fusion (FUSION), Cambridge, UK, 10–13 July 2018; pp. 2042–2046. [Google Scholar] [CrossRef]
  30. Yang, X.; Member, S.; Fan, S.; Guo, S.; Li, S.; Cui, G.; Zhang, W.; Member, S.; Fan, S.; Guo, S.; et al. NLOS target localization behind an L-Shaped corner with an L-Band UWB radar. IEEE Access 2020, 8, 31270–31286. [Google Scholar] [CrossRef]
  31. Scheiner, N.; Kraus, F.; Wei, F.; Phan, B.; Mannan, F.; Appenrodt, N.; Ritter, W.; DIckmann, J.; DIetmayer, K.; Sick, B.; et al. Seeing around Street Corners: Non-Line-of-Sight Detection and Tracking In-the-Wild Using Doppler Radar. In Proceedings of the 2020 IEEE/CVF Conference on Computer Vision and Pattern Recognition (CVPR), Seattle, WA, USA, 13–19 June 2020; pp. 2065–2074. [Google Scholar] [CrossRef]
  32. Kraus, F.; Scheiner, N.; Ritter, W.; Dietmayer, K. Using Machine Learning to Detect Ghost Images in Automotive Radar. In Proceedings of the 2020 IEEE 23rd International Conference on Intelligent Transportation Systems (ITSC), Rhodes, Greece, 20–23 September 2020. [Google Scholar] [CrossRef]
  33. Chandran, S.; Jayasuriya, S. Adaptive lighting for data-driven non-line-of-sight 3D localization and object identification. In Proceedings of the 30th British Machine Vision Conference 2019, BMVC 2019, Cardiff, UK, 9–12 September 2019. [Google Scholar]
  34. Xiong, L.; Miao, H.; Ai, B.; Juhana, T.; Kurniawan, A.; Sonkki, M. Channel characteristics of high-speed railway station based on ray-tracing simulation at 5G mmWave band. Int. J. Antennas Propag. 2019, 2019, 3137583. [Google Scholar] [CrossRef] [Green Version]
  35. Eid, A.H.; Abuelenin, S.M.; Soliman, H.Y. Using Geometric Algebra for Formulating Electromagnetic Propagation Ray-Tracing Preprocessing. In Recent Advances in Engineering Mathematics and Physics; Springer: Cham, Switzerland, 2020; pp. 223–230. [Google Scholar] [CrossRef]
  36. Degen, C.; Govaers, F.; Koch, W. Emitter localization under multipath propagation using a likelihood function decomposition that is linear in target space. In Proceedings of the FUSION 2014—17th International Conference on Information Fusion, Salamanca, Spain, 7–10 July 2014; pp. 1–8. [Google Scholar]
  37. Cheraly, A.; Rabaste, O.; Pétex, J.F.F.; Phan, H.K.K.; Colin-Koeniguer, E.; Poullin, D.; Cheraly. Around-the-corner radar: Detection of a human being in non-line of sight. IET Radar Sonar Navig. 2015, 9, 660–668. [Google Scholar] [CrossRef]
  38. Johansson, T.; Andersson, Å.; Gustafsson, M.; Nilsson, S. Positioning of moving non-line-of-sight targets behind a corner. In Proceedings of the 2016 13th European Radar Conference (EuRAD), London, UK, 5–7 October 2016; pp. 181–184. [Google Scholar]
  39. Zaidi, M.; Bouazzi, I.; Usman, M.; Mohammed Shamim, M.Z.; Singh, N.; Gunjan, V.K. Cooperative Scheme ToA-RSSI and Variable Anchor Positions for Sensors Localization in 2D Environments. Complexity 2022, 2022, 5069254. [Google Scholar] [CrossRef]
  40. de Sousa, M.N.; Thomä, R.S. Enhancement of localization systems in nlos urban scenario with multipath ray tracing fingerprints and machine learning. Sensors 2018, 18, 4073. [Google Scholar] [CrossRef]
  41. Salski, B.; Czekala, P.; Cuper, J.; Kopyt, P.; Jeon, H.; Yang, W. Electromagnetic Modeling of Radiowave Propagation and Scattering From Targets in the Atmosphere With a Ray-Tracing Technique. IEEE Trans. Antennas Propag. 2021, 69, 1588–1595. [Google Scholar] [CrossRef]
  42. Remcom. Wireless EM Propagation Software-Wireless Insite. 2022. Available online: https://www.remcom.com/wireless-insite-em-propagation-software (accessed on 18 December 2022).
  43. Algeier, V.; Demissie, B.; Koch, W.; Thoma, R. Track initiation for blind mobile terminal position tracking using multipath propagation. In Proceedings of the 2008 11th International Conference on Information Fusion, Cologne, Germany, 30 June–3 July 2008; pp. 1–7. [Google Scholar]
  44. Mahler, R.P. Advances in Statistical Multisource-Multitarget Information Fusion; Artech House: London, UK, 2014. [Google Scholar]
  45. Du, H.; Fan, C.; Cao, C.; Chen, Z.; Huang, X. NLOS target localization behind an L-shaped corner based on grid matching. IET Conf. Publ. 2020, 2020, 1066–1071. [Google Scholar] [CrossRef]
Figure 1. Ray-tracing simulation examples: (a) 3D ray-tracing; (b) 2D ray-tracing.
Figure 1. Ray-tracing simulation examples: (a) 3D ray-tracing; (b) 2D ray-tracing.
Applsci 13 02032 g001
Figure 2. Framework of the proposed target localization algorithm.
Figure 2. Framework of the proposed target localization algorithm.
Applsci 13 02032 g002
Figure 3. A single-bounce path from radar R to the target T reflected at position O and the equivalent path from virtual radar R 1 to the target directly.
Figure 3. A single-bounce path from radar R to the target T reflected at position O and the equivalent path from virtual radar R 1 to the target directly.
Applsci 13 02032 g003
Figure 4. Simulation scenario setup.
Figure 4. Simulation scenario setup.
Applsci 13 02032 g004
Figure 5. Number of round-trip multipaths in the study area: (a) Reflection is limited to single-bounce; (b) reflection is limited to double-bounce.
Figure 5. Number of round-trip multipaths in the study area: (a) Reflection is limited to single-bounce; (b) reflection is limited to double-bounce.
Applsci 13 02032 g005
Figure 6. Ground truth and measurements with clutter: (a) target trajectory in the measurement space; (b) measurements versus target index.
Figure 6. Ground truth and measurements with clutter: (a) target trajectory in the measurement space; (b) measurements versus target index.
Applsci 13 02032 g006
Figure 7. Localization error of the proposed algorithm at different locations.
Figure 7. Localization error of the proposed algorithm at different locations.
Applsci 13 02032 g007
Figure 8. RMSE of localization versus STD of the measurement: (a) grid-based results; (b) NLS-based results.
Figure 8. RMSE of localization versus STD of the measurement: (a) grid-based results; (b) NLS-based results.
Applsci 13 02032 g008
Figure 9. RMSE of localization versus STD of the measurement: (a) RMSE versus distance measurement; (b) RMSE versus angle measurement.
Figure 9. RMSE of localization versus STD of the measurement: (a) RMSE versus distance measurement; (b) RMSE versus angle measurement.
Applsci 13 02032 g009
Figure 10. Comparison with the referenced algorithm in [45].
Figure 10. Comparison with the referenced algorithm in [45].
Applsci 13 02032 g010
Table 1. RMSE of simulation results.
Table 1. RMSE of simulation results.
Proposed AlgorithmReferenced Algorithm
std( τ ) = 0.5std( τ ) = 1std( τ ) = 0.5std( τ ) = 1
RMSE with no clutter (m)0.22470.32941.39696.3886
RMSE with dense clutter (m)0.23700.367626.984240.3755
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Ding, R.; Wang, Z.; Jiang, L.; Zheng, S. Radar Target Localization with Multipath Exploitation in Dense Clutter Environments. Appl. Sci. 2023, 13, 2032. https://doi.org/10.3390/app13042032

AMA Style

Ding R, Wang Z, Jiang L, Zheng S. Radar Target Localization with Multipath Exploitation in Dense Clutter Environments. Applied Sciences. 2023; 13(4):2032. https://doi.org/10.3390/app13042032

Chicago/Turabian Style

Ding, Rui, Zhuang Wang, Libing Jiang, and Shuyu Zheng. 2023. "Radar Target Localization with Multipath Exploitation in Dense Clutter Environments" Applied Sciences 13, no. 4: 2032. https://doi.org/10.3390/app13042032

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