Skip to main content
Sensors (Basel, Switzerland) logoLink to Sensors (Basel, Switzerland)
. 2024 Jul 25;24(15):4846. doi: 10.3390/s24154846

Comparison of KF-Based Vehicle Sideslip Estimation Logics with Increasing Complexity for a Passenger Car

Lorenzo Ponticelli 1,*, Mario Barbaro 1, Geraldino Mandragora 1, Gianluca Pagano 1, Gonçalo Sousa Torres 1
Editor: Arturo de la Escalera Hueso1
PMCID: PMC11315032  PMID: 39123893

Abstract

Nowadays, control is pervasive in vehicles, and a full and accurate knowledge of vehicle states is crucial to guarantee safety levels and support the development of Advanced Driver-Assistance Systems (ADASs). In this scenario, real-time monitoring of the vehicle sideslip angle becomes fundamental, and various virtual sensing techniques based on both vehicle dynamics models and data-driven methods are widely presented in the literature. Given the need for on-board embedded device solutions in autonomous vehicles, it is mandatory to find the correct balance between estimation accuracy and the computational burden required. This work mainly presents different physical KF-based methodologies and proposes both mathematical and graphical analysis to explore the effectiveness of these solutions, all employing equal tire and vehicle simplified models. For this purpose, results are compared with accurate sensor acquisition provided by the on-track campaign on passenger vehicles; moreover, to truthfully represent the possibility of using such virtual sensing techniques in real-world scenarios, the vehicle is also equipped with low-end sensors that provide information to all the employed observers.

Keywords: vehicle state estimation, vehicle dynamics, extended Kalman filter, unscented Kalman filter, sideslip angle, virtual sensing

1. Introduction

The automotive industry is continuously evolving toward an increasing level of vehicle automation in accordance with the necessity of improving passenger safety and comfort to reduce the number of road accidents. To answer this crucial social challenge, one of the priority areas involved in the research field of vehicle dynamics concerns the design and development of ADASs (Advanced Driving Assistance Systems) that optimize vehicle interaction with humans and with the external environment (road, weather conditions, tire conditions) [1,2,3,4,5,6,7,8,9,10,11].

In this scenario, on one hand, accurate knowledge of the vehicle’s instantaneous state is crucial to optimize the control logic [12,13,14,15,16,17,18]; on the other hand, some physical variables can be measured only by employing expensive high-end sensors, making it hard to ensure the large-scale availability of the designed system. In particular, the knowledge of the vehicle sideslip angle is essential in vehicle lateral dynamic applications, such as stability control and trajectory planning for autonomous vehicles [19,20]. However, its on-board measurement requires high-cost vehicle-sensors equipment. Therefore, to extend the application to a less customized scenario, virtual sensing techniques are adopted to allow the estimation of the sideslip angle only employing low-end sensors, which are suitable for mass-production vehicles [21,22,23,24,25,26,27,28,29,30].

Three main sideslip angle estimation approaches are currently available in the literature: kinematic-based, tire model-based, and data-driven approaches.

Data-driven approaches are usually designed to achieve accurate results in both linear and nonlinear vehicle operating conditions, employing AI methodologies to capture the vehicle state toward the measured available signals [31,32,33,34,35]. The main disadvantage of this approach is related to the necessity of a large and diversified dataset covering the entire vehicle operating range in order to perform the tuning of the algorithm without incurring the overfitting risk.

Instead, the kinematic estimator only includes kinematic relationships employing the real-time measurement of accelerations, yaw rate, and wheel linear velocities. In this case, the calibration routine of the tire and vehicle model is not required, and the estimation process is robust toward tire parameter variations [36,37,38,39]. However, the estimator becomes unobservable when the vehicle yaw rate approaches zero and the estimation accuracy is strongly affected by the sensors’ noise, resulting in cumulated errors due to the integration process.

The current paper focuses on the dynamic tire model-based approach, which involves the implementation of a dynamic model adopting the vehicle equilibrium equations and employing a tire model to calculate the forces acting at the ground plane, which are dependent on the instantaneous kinematic state of the vehicle [40,41,42,43,44,45,46]. Although this approach is more accurate and less corrupted by noise with respect to the previous one, it is significantly sensitive to the reliability of the identified tire parameters and to the capability of the estimator to capture the tire dynamics both in the linear and nonlinear regions [47,48,49,50].

In this scenario, the model selection plays a crucial role in optimizing the estimator design: in the current work, the 3-dof single-track model has been adopted. Although this formulation is less accurate than others discussed in the literature, which employ a multibody modeling approach [51,52,53,54,55], it requires a simpler parametrization ruotine. Moreover, since the vehicle model is integrated within an observer architecture [56,57,58,59,60], the formulation has to satisfy the observability condition: the available measurements have to uniquely define the state to optimize the correction based on the instantaneously acquired signals. Using the single-track approach makes it easier to respect this criterion also employing a minimum number of measurements, since the model equations are easily invertible.

In this regard, techniques based on the Kalman filter logic are frequently employed to build the mentioned observer architecture, including the model equations and the measurement corrections. These algorithms could be designed with differing formulations, depending on the required level of complexity. In those conditions where the vehicle dynamics could be simulated through a linear formulation, the extended Kalman filter consists of the most employed solution to accurately perform the estimation without increasing the computational cost of the estimator [61,62,63]. However, when the vehicle moves toward strongly nonlinear conditions, the estimation errors due to linearized formulation become non-negligible, leading to the necessity of employing more accurate and complex estimation logic [64,65,66].

The paper proposes qualitative and quantitative comparisons to evaluate the performance of differing Kalman filter-based methodologies, characterized by increasing complexity, to estimate the vehicle sideslip angle, with the aim of maximizing the balance between accuracy and computational cost, also accounting for the deviation of the vehicle behavior from the nonlinear range. A unique single-track model has been designed and calibrated through an identification routine based on experimental data, and the estimation process has been performed using a fixed set of on-board measurements, which are commonly available on mass-production vehicles. Compared to previous existing works [67], the analysis has been performed by dividing the experimental data in differing driving conditions to verify the improvement provided by highly nonlinear formulations in each explored vehicle operating range compared with the simplest EKF implementation.

The experimental campaign also provided accurate measurements for the validation of the estimator, allowing the comparison of the estimation results with an accurate experimental target. Moreover, since the aim is to analyze the results both in linear and nonlinear working conditions, the data collection has been carried out by exploring vehicle behavior in differing maneuvers.

The paper is structured as follows: Section 2 provides an overview of the various Kalman filter typologies available in the current state of the art, including an accurate analytical description of their respective architecture. Section 3 describes the model-based approach employed within the estimation procedure, including the mathematical formulation of the vehicle model, tire model, and measurement update equations. In Section 4, the experimental activity required for the tire model characterization and the filters’ validation is reported, both describing the vehicle-sensors equipment and specifying the signals used in the estimation logic. The results are presented in Section 5 and discussed in the conclusions in Section 6.

2. KF-Based State Estimation Techniques

Model-based estimation design deals with compromising the output’s accuracy and the level of complexity. Various kinds of observers are presented in the literature; this work is mainly based on the Kalman filter (KF) [68]. The original formulation was thought to be applied to linear systems; however, it is well known that real systems are, in general, hardly nonlinear. To better understand these kinds of filters, it is mandatory to provide the reader with some general context to this approach. In 1960, R.E. Kalman defined a recursive solution to the discrete-data linear-filtering problem. The presented approach involves the use of a set of mathematical relations that generates an estimate of the process’s state in a way that minimizes the mean of the squared error. Linear processes can be formulated in discrete-time form through process and measurement equations. The general formulation is now introduced (Equations (1) and (2)):

xk=Axk1+Buk1+Wwk1 (1)
zk=Hxk+Vvk (2)

where

  • xk is the state vector at time step k.

  • uk1 is the input vector at time step k−1.

  • A is the matrix that dynamically describes the state’s evolution.

  • B is the matrix that correlates the input and state variables, which is also known as the control matrix.

  • H is the measurement matrix.

  • W and V are the process and measurement noise matrices.

In general, xk is a column vector with N elements depending on the complexity of the system, while wk and vk represent the process and measurement noise with Q and R being the correspondent covariance matrices. The set of equations of the KF-filter is divided into time update equations and measurement update equations (Figure 1).

Figure 1.

Figure 1

The Kalman filter cycle.

In discrete KF filter logic, time update equations (Equations (3) and (4)) provide the evolution of the system a priori, and they rely only on the system model:

x^k=Ax^k1+Buk1 (3)
Pk=APk1AT+WQWT (4)

where x^k indicates the a priori estimated state at time step k, Pk1 the state covariance at time step (k−1), Pk the a priori state covariance at time step k. On the other hand, the measurement update equations (Equations (5)–(7)) allow to correct the a priori estimation based on chosen measurement, hence providing the a posteriori estimation of the state:

Kk=PkHT(HPkHT+VRVT)1 (5)
x^k=x^k+Kk(zkHx^k) (6)
Pk=(IKkH)Pk (7)

where Kk is denoted as the Kalman gain, which provides a weighting method between the actual measurement zk and their prediction Hx^k. It is worth noticing that covariance matrices P, W and V are semi-positive definite. While the basic KF filter provides a suitable solution for the estimation of linear equation systems, its applicability is generally restricted in wider scenarios. In the automotive field, vehicle dynamics models are usually strongly nonlinear, leading to the frequent adoption of the first-order extended Kalman filter (FO-EKF).

2.1. Extended Kalman Filter

For nonlinear stochastic difference equations, the equations can be rewritten as follows (Equations (8) and (9)):

xk=f(xk1,uk1,wk1) (8)
zk=h(xk,vk) (9)

The generic function f relates the state at the previous time step k−1 to the state at the current time step k. The main concept of this formulation is to linearize the system, at each time step, around the estimated state of the system at the previous time step, by employing the Jacobian matrices (Equations (10)–(13)):

Ak[ij]=f[i]x[j](x^k1,uk1,0) (10)
Wk[ij]=f[i]w[j](x^k1,uk1,0) (11)
Hk[ij]=h[i]x[j](x^k,0) (12)
Vk[ij]=h[i]v[j](x^k,0) (13)

where Ak[ij], Wk[ij], Hk[ij], and Vk[ij], are the generic element of, respectively, Ak, Wk, Hk, and Vk, on row i and column j, and fi, hi, xi, vi, and wi represent the i-th element of, respectively, f, h, x, v, and w. Therefore, the equation contains the Jacobian matrices of the partial derivatives of the process and measurement functions with respect to the state and the noise. Time update equations (Equations (14) and (15)) are now introduced to describe the evolution of the EKF:

x^k=f(x^k1,uk1,0) (14)
Pk=AkPk1AkT+WkQk1WkT (15)

and the a posteriori equations (Equations (16)–(18)) are

Kk=PkHkT(HkPkHkT+VkRkVkT)1 (16)
x^k=x^k+Kk(zkh(x^k,0)) (17)
Pk=(IKkHk)Pk (18)

Despite the efficient solution provided by the introduction of the EKF to estimate the state of a nonlinear system, some important aspects need to be underlined. They can briefly be summarized:

  • The calculation of Jacobian matrices may be computationally demanding; this problem is amplified in scenarios where partial derivatives have to be evaluated online at each time step.

  • The linearization process results in accurate estimation only when the error propagation can be well approximated by a linear model.

Many studies have been proposed in order to overcome these flaws. Some of them relate to the introduction of high-order Kalman filters or more sophisticated versions of the EKF [65,69,70,71,72].

2.2. Iterated Extended Kalman Filter

The main concept behind the iterated extended Kalman filter (I-EKF) is acting on the linearization error by reformulating the Taylor series expansion around the a posteriori state estimate [57]. The process can be iterated multiple times; however, the majority of the possible improvement is obtained after the first relinearization, as stated in the literature. For the sake of completeness, it should be mentioned that the second-order extended Kalman filter (SO-EKF) can be employed also, and its main feature involves performing a second-order Taylor expansion of process equations. The main difference between the two approaches can be found in the iteration cycle that aims at refining the measurement update equations at generic time k. The mathematical set of equations is equal to the previously introduced FO-EKF except for the adoption of a recursive update of the state estimate using the best state estimate available [57]. See Algorithm 1.

Algorithm 1 Iterated Extended Kalman Filter Algorithm
  •  1:

    x^0                          ▹ Define initial state

  •  2:

    P0                     ▹ Define initial state covariance

  •  3:

    fork=1 to T do

  •  4:

       x^k=f(x^k1,uk1,0)                ▹ a priori state estimate

  •  5:

       Pk=Ak1Pk1Ak1T+Q        ▹ a priori state estimate covariance

  •  6:

       x^k,1=x^k

  •  7:

       for i=1 to N do

  •  8:

         zk,i=h(x^k,i,uk,0)Hk,i(x^kx^k,i)   ▹ a priori measurement estimate

  •  9:

         Kk,i=PkHk,iT(Hk,iPkHk,iT+R)1             ▹ Kalman gain

  • 10:

         x^k,i+1=x^k+Kk,i(ykzk,i)        ▹ a posteriori state estimate

  • 11:

         Pk,i+1=(IKk,iHk,i)Pk      ▹ a posteriori state estimate covariance

  • 12:

       end for

  • 13:

    end for

2.3. Simply Unscented Kalman Filter

An unscented Kalman filter (UFK) provides an alternative approach to propagate state and error covariance during a nonlinear process, applying the transformation on single points rather than on a Gaussian distribution. The algorithm performs the nonlinear transformation on a set of so-called sigma points (Equations (19)–(21)), whose sample pdf well approximates the pdf of the instantaneous state estimate. The described approach ensures robustness to evaluate high-order nonlinear state evolution, also employing a reduced number of sigma points. If x is a [nx1] vector that is transformed by the nonlinear function y=f(x), the 2n sigma points are

x(i)=x¯+x˜(i)i=1,,2n (19)
x˜(i)=(nPxx)iTi=1,,n (20)
x˜(n+i)=(nPxx)iTi=1,,n (21)

where x¯ is the mean of x and Pxx is its covariance; nPxx is the matrix square root of nPxx and (nPxx)i is the i-th row of nPxx. To evaluate a matrix square root, the Cholesky factorization can be applied. Furthermore, applying the nonlinear function to each individual sigma point, the transformed entities are computed as

y(i)=f(x(i))i=1,,2n (22)

the approximated mean of y is given by

y¯=12ni=12ny(i) (23)

It has been demonstrated that the computed mean approximates the true mean and covariance of y up to the third order, whereas the linearization only matches the true mean of y up to the first order.

Pyy=12ni=12n(f(x(i))y¯)(f(x(i))y¯)T (24)

In general, it can be said that the UFKs propagate the mean and the covariance of the sigma points using systems of nonlinear equations, and the a priori state estimate is the weighted mean of them. This also applies to the predicted measurement that can be computed using all measurement equations for each propagated sigma point, and the predicted measurement vector is the weighted mean of them. Unlike EKFs, in UFKs, there is the introduction of a cross-covariance matrix. The simplest UKF, known as simply unscented Kalman filter (S-UKF), is characterized by the use of 2n sigma points and equal weights.

2.4. General Unscented Kalman Filter

The selection of sigma points and weight becomes crucial to classify different observers; in [73,74], it is shown that the same order of mean and covariance estimation accuracy can be obtained by choosing 2n+1 sigma points (Equations (25)–(28)). This type of UKF is referred as a general unscented Kalman filter (G-UKF).

x(0)=x¯ (25)
x(i)=x¯+x˜(i)i=1,,2n (26)
x˜(i)=((n+k)Pxx)iTi=1,,n (27)
x˜(n+i)=((n+k)Pxx)iTi=1,,n (28)

Another feature is the use of different weights (Equations (29) and (30)):

W(0)=kn+k (29)
W(i)=12(n+k)i=1,,2n (30)

In the weight’s definition, the introduction of the parameter k is useful to decrease high-order errors in mean and covariance propagation. Indeed, if x is normally distributed, then choosing k=3n results in a minimization of the fourth-order terms error. It is, then, possible to apply the nonlinear transformation to each sigma point (Equations (31) and (32)):

y¯=i=02nW(i)y(i) (31)
Pyy=i=02nW(i)(f(x(i))y¯)(f(x(i))y¯)T (32)

It is worth noticing that the S-UKF formulation can easily be obtained by choosing k=0, resulting in 2n sigma points and equal weights. Furthermore, it should be mentioned that other variations of the same algorithm can be found in the literature; the key concept is modeling the distribution of sigma points around the mean state value, employing parameters (α, k), while the introduction of the β value relates to the definition of weights of the transformed points.

2.5. Simplex Unscented Kalman Filter

Another set of sigma points and weight factors can be introduced; therefore, choosing n+1 sigma points for x (x has n elements) results in the minimum number of sigma points which gives the same order of estimation accuracy. This observer aims to reduce computational burden by acting on the number of sigma points without losing performance. The algorithm presented in [74] deals with n+2 sigma points, but the number can be reduced to n+1 by choosing one weight to be zero. Although this filter can be helpful for high dimension problems, it is shown that the ratio of W(n) to W(1) is 2n2 (same for σin), resulting in numerical problems as the dimension of the state increases.

2.6. Spherical Unscented Kalman Filter

The proposed UKF aims to rearrange the sigma points of the S-UKF to obtain better numerical stability. The filter is referred as a spherical unscented Kalman filter (SPHE-UKF), and its main features are the equal weight factors and the ratio formulation (Equation (33)):

nn(n+1)W(i)/1n(n+1)W(1)=n (33)

In general, all UFKs have a great advantage, as they do not require Jacobian or Hessian computation, but the main obstacle is the state covariance matrices that must be positive semidefinite to obtain real matrices after Cholesky decomposition. Furthermore, sigma points’ evaluation is required at each time step, leading to computational cost.

3. State Estimation Architecture

3.1. Model Equations

Vehicle modeling evaluates three groups of equations: kinematic (congruence) equations, equilibrium equations, and tire constitutive equations. The definition of the set of equations depends on the vehicle model adopted. The commonly used vehicle models are the double-track and the single-track models, which differ from each other in the assumptions underlying the model. The advantage of using one or the other depends on the results needed and the kind of precision requested. Generally, the single-track model is enough to describe a vehicle’s behavior, but due to the main assumption that consists of neglecting the roll motion, it is impossible to describe the vertical dynamics. Regarding this paper, since in the following discussions in-plane dynamics is described, the single-track assumptions allow us to evaluate all the vehicle equations needed. The single-track model consists of only one wheel per axle. The Ackermann coefficient is set equal to zero. If the static toe is null, due to this hypothesis, the steering angles of the front wheels are the same, so the wheels are characterized by parallel steering. Considering δ1 as the front axle steering angle (Equations (34) and (35)),

δ11=δ12=δ1 (34)
δ21=δ22=δ2 (35)

where δ11 and δ12 are the steering angles of the left and right front tires in a double-track model, and δ21 and δ22 are related to the rear tires.

Considering Figure 2, it is possible to extrapolate the kinematics equations (Equations (36)–(39)):

Vx1=ucos(δ1)+(v+ra1)sin(δ1) (36)
Vy1=(v+ra1)cos(δ1)usin(δ1) (37)
Vx2=u (38)
Vy2=(vra2) (39)

where x indicates the longitudinal axis of the vehicle and y indicates the lateral axis so that Vx and Vy represent the longitudinal and lateral velocities. u, v, and r are, respectively, the longitudinal, the lateral, and the yaw velocities (rate) at the center of gravity. Finally, a1 and a2 are, respectively, the front and rear wheelbase. Condensing two wheels per axle into a single one, coherently with the hypothesis of the single-track vehicle model, leads to the following equations (Equations (40) and (41)) to calculate tire slip angles and slip ratios, which are provided as input to the tire model, which is going to be described:

αj=arctanVyjVxj (40)
kj=VxjωjRrjVxj (41)

Figure 2.

Figure 2

Single-track vehicle model basic scheme.

Substituting the terms of the slips equations (Equations (42)–(45)) with the ones evaluated with the kinematics equations,

α1=arctan(v+ra1)cosδ1usin(δ1)ucos(δ1)+(v+ra1)sin(δ1) (42)
k1=ω1Rr1ucos(δ1)+(v+ra1)sin(δ1)ucos(δ1)+(v+ra1)sin(δ1) (43)
α2=arctan(vra2)u (44)
k2=ω2Rr2uu (45)

Finally, the equilibrium equations can be written as follows (Equations (46)–(48)), indicating the longitudinal and lateral velocities derivative as u˙ and v˙ and the yaw rate derivative as r˙:

m(u˙vr)=X (46)
m(v˙+ur)=Y (47)
Jzr˙=N (48)

where

X=Fx1cos(δ1)Fy1sin(δ1)+Fx2 (49)
Y=Fy1cos(δ1)Fx1sin(δ1)+Fy2 (50)
N=Fy1a1cos(δ1)Fx1a1sin(δ1)+Fy2a2 (51)

In the previous equations (Equations (49)–(51)), Fxj, with j = 1,2, represents the longitudinal forces on each axle, Fyj, with j = 1, 2, represents the lateral forces on each axle, X and Y represent the net forces, respectively, on the longitudinal and lateral direction, and N represents the net momentum around the z-axis. Vehicle quantities are described in Table 1.

Table 1.

Vehicle quantities.

Quantity Name Symbol Units
Vehicle mass m kg
Inertia moment around z-axis Jz kgm2
Steering angle δj rad
Front wheelbase a1 m
Rear wheelbase a2 m
Longitudinal CoG speed u m/s
Longitudinal CoG acceleration u˙ m/s2
Lateral CoG speed v m/s
Lateral CoG acceleration v˙ m/s2
Vehicle yaw rate r rad/s
Vehicle yaw acceleration r˙ rad/s2
Lateral slip angle αj rad
Longitudinal slip ratio kj -
Axle longitudinal force Fxj N
Axle lateral force Fyj N
Net longitudinal force X N
Net lateral force Y N
Net momentum around z axis N N
Axle angular velocity ωj rad/s
Rolling radius Rrj m

Forces appearing at the equilibrium equations are calculated by a simplified Pacejka Magic Formula (MF) tire model [48,49,75,76]. This formulation takes into account only macroparameters, and it has been preferred among other more computationally demanding models [77,78,79,80], which require a high-cost and complex experimental routine to identify the parameters [81,82,83,84,85,86,87,88]. On the other hand, it has been preferred to other simplified approaches, which do not reproduce the nonlinear tire behavior at high slip values [48,89].

F0=Dsin(Carctan[BxsE(Bxsarctan(Bxs))])+Sv (52)

where

xs=Xs+Sh (53)

The formulation (Equations (52) and (53)) is the same for the calculation of longitudinal and lateral forces, while the independent variable Xs, respectively, identifies the tire slip ratio or slip angle, which have been previously mentioned. The described formulation refers to pure condition F0. The parameters are now introduced:

  • B: stiffness factor;

  • C: shape factor;

  • D: peak value;

  • E: curvature factor;

  • Sv, Sh: shifts from Cartesian axes center.

Furthermore, a vertical load dependence (Equation (54)) is adopted for the peak value:

D=D(Fz)=μFz (54)

The MF is also suitable for combined slip cases where the introduction of the Hill function (G) is needed (Equations (55)–(57)):

G=cos(Ccarctan[BcxcEc(Bcxcarctan(Bcxc))])cos(Ccarctan[BcSHcEc(BcSHcarctan(BcSHc))]) (55)

where

xc=Xc+SHc (56)

The combined tire force is then evaluated as

Fc=F0G (57)

It can be noticed that the two independent variables Xs and Xc assume the value of the tire slip angle and slip ratio if employed in lateral force evaluation, while their values are exchanged in longitudinal force formulation.

3.2. Filter Design

A common structure is adopted in designing the different model-based observers. The general structure of state variable vector is

xK=[uk,vk,rk]T (58)

The sideslip angle is then evaluated as β=arctan(vu).

3.3. Measurement Equations

Measurement equations are needed to evaluate the estimate zk at time step k knowing the a priori state estimate and the additional input values uk. In general, they can be written as

zk=h(x^k,uk)+vk (59)

For this work, a set of five measurements was chosen, and the criteria were taking advantage of low-end sensors such as encoders for sensing the wheel speed and IMU for accelerations. The acquired signal vector is now presented:

yk=[ω1,1kENCODER,ω1,2kENCODER,rkIMU,axkIMU,aykIMU] (60)

The estimated measurement vector will then be

zk=[ω1,1k,ω1,2k,rk,axk,ayk] (61)

h functions are able to estimate yk using typical vehicle dynamics equations. The yaw rate is defined as both the state and measurement variable; therefore, the h() function will be an identity.

axk=X/m (62)
ayk=Y/m (63)
rk=rk (64)
ω11k=Vx11k/Rr1 (65)
ω12k=Vx12k/Rr1 (66)

Since the wheel angular velocities are available at the vehicle corners, the wheel linear velocities Vx11kVx12k appearing at the previous equations (Equations (62)–(66)) have to be obtained by translating the vehicle velocities from the center of gravity to the hub locations coherently with a double-track formulation [90]. Moreover, they have to be rotated to account for the wheel steering angle. In addition, for the filter to properly work, input signals need to be defined. For this application, the steering wheel angle, wheels’ rotational velocity and longitudinal acceleration are used.

3.4. QR Calibration

During the description of KF-based filters’ variables such as process noise and measurement noise, respectively, w and v were introduced. It can be said that the process noise represents the discrepancy between the target state value and the model’s a priori estimate; on the other hand, the measurement noise is generally related to the employed sensor’s accuracy. The previously introduced variables w and v are considered mutually independent, white and normally distributed (Equations (67) and (68)):

p(w)N(0,Q) (67)
p(v)N(0,R) (68)

It can be said that model errors are more systematic than measurement errors. Q and R are defined as process and measurement noise covariance matrices, whose definition is fundamental to reach the best possible accuracy and robustness of the estimation. Their definition is often a hard task. Because sensor errors are likely to be uncorrelated, R will result in a diagonal matrix, while for Q, manual tuning is practically impossible. In this work, Q and R are determined through the so-called “Maximizing the Joint Likelihood’’ algorithm [91], which is based on an offline calculation of the errors made by the model to update the state, starting from the target state defined at the previous instant (Equations (69) and (70)). The target state xk has been provided by the S-motion readings, and the errors’ covariance has been calculated on the entire data collection (N is the number of samples).

Q=1Ni=1N(xkf(xk1,uk1))(xkf(xk1,uk1))T (69)
R=1Ni=1N(ykh(xk))(ykh(xk))T (70)

This procedure ensures an objective comparison between the examined filters, because the Q and R matrices have been calculated through a deterministic method and their values are only related to the model and sensor accuracy with respect to the target data.

4. Experimental Campaign

To collect the required data for calibration and validation of the proposed filters, a testing procedure was conducted with a test vehicle. Initially, all the relevant vehicle parameters were collected as presented in Table 2.

Table 2.

Vehicle parameters.

Parameter Name Value Units
Vehicle Mass 1197.5 kg
Unsprung Mass 200 kg
Wheelbase 2.31 m
Front Wheelbase 1.088 m
Front Track Width 1.495 m
Rear Track Width 1.505 m
CG Height 0.489 m
Front Roll Center Height 0.0767 m
Rear Roll Center Height 0.2084 m
Z Inertia Moment 950 kgm2
Nominal Steer Ratio 14.2 -

The required vehicle signals were collected by utilizing a set of low and high-end sensors. The required measurements for the estimator filters were obtained through common affordable vehicle sensors such as an inertial measurement unit (IMU) and provided by the standard controller area network (CAN). On the other hand, an optical sensor was also installed to obtain reliable measurements of the vehicle’s longitudinal and lateral speeds, which are both crucial to the accurate calculation of the actual sideslip angle. The complete list of signals and respective sensors used for this study is presented in Table 3.

Table 3.

Vehicle sensors and respective accuracy.

Signal Device Accuracy/Sensitivity
Longitudinal Velocity S-Motion [92] <±0.2%
Lateral Velocity Range: up to 400 km/h
Longitudinal Acceleration OxTS 3000 [93] Bias stability: 2 μg
Lateral Acceleration Range: ±10 g
Vertical Acceleration Bias stability: 2/h
Yaw Rate Range: ±100/s
Steer Angle Steering Wheel Sensor
(CAN [94])
Resolution: 0.1
Range: ±780
Wheel Speeds (FL, FR, RL, RR) Wheel Speed Encoder
(CAN [94])
Timing accuracy: 2%
Range: 0 to 2500 Hz

To characterize the tire–road interaction, a specific testing procedure known as TRICK [95] was conducted. The driver was instructed to employ four different driving styles (Gentleman, Pure Interaction, Max Performance and Sliding), which attempt to stress the tires in different conditions, as presented in Table 4. The obtained data, along with the previously mentioned vehicle parameters, were then fed into an inverse model to calculate the relevant tire kinematic and dynamic quantities such as slips and forces (Figure 3).

Table 4.

Driving styles’ description.

Driving Style Description Goal
Gentleman Driving at a relatively high pace around the track Characterize pure and combined linear tire range
Max Performance Driving as fast as possible around the track Characterize pure and combined peak tire performance
Pure Interaction Avoiding combined tire–road interaction by separate use of throttle/brake and steering Characterize the tire’s pure interaction curves
Sliding Forcing the tire to work in the frictional region Characterize the “over the peak’’ region of the interaction curves

Figure 3.

Figure 3

Tire model calibration results.

The tire model-fitting process followed a classic approach that can be split into different phases. Initially, a preprocessing routine was applied to remove outliers and collect the relevant samples for the calibration procedure. A reference nominal load was selected for the fitting process and was then used as a reference to start calibrating the force–slip curves in pure lateral and longitudinal conditions. The admissible values of slip ratio and slip angle were limited to a small range for the lateral and longitudinal models, respectively, to exclude any combined interaction from the fitting process. Once the fitting at nominal vertical loads was satisfactory, the load dependency characteristic was calibrated by selecting vertical load ranges below and above the nominal condition. As a simplified Magic Formula was employed for the estimators’ tire model, no other dependencies such as camber, pressure or temperature were taken into account. The final step of the calibration procedure focused on identifying the combined interaction, fitting the force–slip curve for combined values of slip angle and slip ratio.

5. Results

In this section, a comparative analysis of different filters is introduced. To underline specific features, different runs were properly chosen. They involve both short and long acquisition in terms of time and different conditions of lateral excitation, which are reached through combining the previously introduced driving styles (Table 5). All the simulations were performed using the MATLAB R2023b environment on a PC employing WINDOWS 11 with a 13th Gen Intel(R) Core(TM) i7-1370P @1.90 GHz (Santa Clara, CA, USA).

Table 5.

Breakdown of each run.

Run Driving Styles N. Lap Duration [s]
1 Gentleman 1 120
2 Gentleman 1 80
3 Gentleman 2 250
4 Pure Interaction 1 300
Sliding Lap 2
Max Performance 1
5 Gentleman 1 250
Sliding Lap 2
Gentleman 1
6 Gentleman 1 300
Max Performance 1
Gentleman 1

To provide the reader with more accurate details on the different runs, some major input signals are described in Figure 4.

Figure 4.

Figure 4

Figure 4

Figure 4

Speed and steering input signals: (a) run 1, (b) run 2, (c) run 3, (d) run 4, (e) run 5, (f) run 6.

The first three runs are initially analyzed, and the performance of the six observers is almost the same as they explore relatively reduced levels of β values (Figure 5, Figure 6 and Figure 7).

Figure 5.

Figure 5

Comparison of all the observers, run 1.

Figure 6.

Figure 6

Comparison of all the observers, run 2.

Figure 7.

Figure 7

Comparison of all the observers, run 3.

In particular, considering run 1 (equal consideration can be made for run 2 and run 3), the two EKFs show the same level of accuracy, and the same result can be observed when comparing UKFs (Figure 8 and Figure 9).

Figure 8.

Figure 8

Comparison of EKFs, run 1.

Figure 9.

Figure 9

Comparison of UKFs, run 1.

Moreover, the last three runs are discussed; they exploit an increasing number of laps and driving styles, exploring both high and low levels of lateral excitement (Figure 10 and Figure 11). Considering, for instance, run six, as its results can be generalized for the other two, a comparative analysis shows that

  • The two EKFs perform equally (Figure 12);

  • S-UKF and G-UKF show comparable results (Figure 13);

  • SIMP-UKF and SPHE-UKF have almost the same estimation accuracy (Figure 14);

  • In general, SIMP/SPHE-UFKs perform the best out of all the observers; while S-UKF and G-UKF are more precise than the two EKFs (Figure 15 and Figure 16).

Figure 10.

Figure 10

Comparison of all the observers, run 4.

Figure 11.

Figure 11

Comparison of all the observers, run 5.

Figure 12.

Figure 12

Comparison of EKFs, run 6.

Figure 13.

Figure 13

Comparison of S-UKF vs. G-UKF, run 6.

Figure 14.

Figure 14

Comparison of SIMP-UKF vs. SPHE-UKF, run 6.

Figure 15.

Figure 15

Comparison of EKF vs. SIMP-UKF, run 6.

Figure 16.

Figure 16

Comparison of all the observers, run 6.

It is worth noticing how the performance of the different observers changes as the run explores the various levels of lateral excitation. Indeed, for lower values of sideslip angle, the performances are comparable, while on the other hand, the estimation error of the EKFs tends to increase. This can be due to the highly nonlinear conditions reached during those specific runs, which results in the worse performance shown by the two EKF filters.

To provide the reader with a more general overview of the estimation accuracy reached through the simulations, the root mean square error (RMSE) of the estimated sideslip angle has been evaluated, and it is used as a term of comparison (Table 6, Figure 17).

Table 6.

RMSE comparison between all the observers.

RUN
RMSE 1 2 3 4 5 6
FO-EFK 0.007 0.01 0.01 0.20 0.05 0.15
I-EKF 0.007 0.01 0.01 0.17 0.05 0.14
S-UKF 0.006 0.01 0.01 0.07 0.035 0.06
G-UKF 0.006 0.01 0.01 0.14 0.035 0.04
SIMP-UKF 0.007 0.01 0.009 0.01 0.030 0.02
SPHE-UKF 0.007 0.01 0.01 0.01 0.030 0.02

Figure 17.

Figure 17

Visual representation of RMSE comparison between all the observers on each run.

Furthermore, a comparison analysis of the computational time needed for the different filters to work is presented. Each observer has been executed multiple times for each run to obtain the execution time average values reported in Table 7. To summarize the results of this analysis, the mean computational time has been calculated for each filter, and it has been reported in the last column of Table 7. When comparing the two EKFs, it is obvious that more iterations lead to additional time needed (I-EKF). SIMP-UKF and SPHE-UKF are the fastest among the other UFKs, and this is due to the lower number of sigma points. Indeed, it can be said that the G-UFK is slower than the S-UKF, because not only does it have a larger number of sigma points, but also different weights are applied to them.

Table 7.

Comparison of time taken for each observer on the different runs.

Mean Computational Time (Single Run) [s]
Observer 1 2 3 4 5 6 Average Computational Time [s]
FO-EKF 2.8 2.5 6.5 7.7 6.8 8.1 5.8
I-EKF 7.2 6.4 13.2 15 13.5 15.5 11.8
S-UKF 7.6 7.4 15.1 17 15.5 17.3 13.3
G-UKF 10.2 9.6 20 23.5 19.3 23 17.6
SIMP-UKF 7.4 6.3 13.4 16.4 13.4 15.9 12.1
SPHE-UKF 7.4 6.4 13.4 16.4 13.6 16.5 12.3

6. Conclusions

In the current article, a qualitative and quantitative comparison has been carried out on the estimation results of KF-based state observers with variable accuracy and complexity to perform real-time estimation of the vehicle sideslip angle. Since a dynamic approach has been performed, employing a Magic Formula tire model, the calibration procedure required an outdoor experimental campaign to identify the parameters during the pure and combined interaction. The performed on-track experimental campaign also provided the on-board measurements acquired to validate the estimation algorithm, including the low-end sensors useful within the analytical estimation process and the accurate high-end sensors’ signals that provide the optimal target for the results’ comparison.

Differing maneuvers have been performed to investigate the performance of the filters in a wide operating domain and to verify the errors due to linearization when the vehicle works in critical driving conditions and its dynamics become strongly nonlinear. To account for the necessity of employing the algorithm in on-board scenarios, also the computational cost of the differing filters has been evaluated by comparing the respective computational time taken to perform a simulation of the online estimation.

As shown in the Results, within the linear working range, characterized by small sideslip angle values and negligible high-order transient dynamics, the improvements provided by high-complexity solutions compared with the simple FO-EKF are not sensitive enough to justify their employment. However, on the other hand, nonlinear conditions with higher values of sideslip angle lead to increasing estimation error when a linear formulation is applied to propagate error covariance and a Gaussian distribution around the previous state estimate is supposed. This occurs also when the estimator employs a redundant iterative procedure that increases the computational effort (I-EKF).

The UKF-based observer showed great accuracy also in this range, demonstrating their suitability in all the explored operating conditions; furthermore, for this estimation architecture, most detailed formulations do not ensure increasing accuracy, as evidenced by the comparisons with the experimental target. This justifies the employment of the version of the UKF, SIMP-UKF, which provides the optimal balance in terms of computational effort and estimation robustness.

Based on these results, further developments will include the development of a hybrid observer to optimize the estimation performance, which would employ an EKF formulation, switching on the nonlinear UKF implementation toward nonlinear vehicle driving situations. However, to avoid a too complex formulation, the dynamic-based EKF could be integrated into a fuzzy-logic architecture, working in feedback with a kinematic estimator, which is more accurate in nonlinear conditions and during transient maneuvers. In the end, to extend this study to a less customized context, the sensitivity analysis will be carried out by employing experimental data acquired on-board different vehicles.

Author Contributions

Conceptualization, L.P. and M.B.; methodology, M.B. and G.P.; software, G.S.T. and L.P.; validation, G.P. and G.S.T.; resources, G.P. and G.M.; data curation, G.S.T. and G.M.; writing—original draft preparation, M.B. and G.P.; writing—review and editing, L.P. and G.S.T.; visualization, G.M. and L.P.; supervision, M.B. and G.M.; project administration, L.P. and M.B. All authors have read and agreed to the published version of the manuscript.

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

Data presented in this study are available on request from the corresponding author.

Conflicts of Interest

The authors declare no conflicts of interest.

Funding Statement

This research received no external funding.

Footnotes

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.

References

  • 1.Ziebinski A., Cupek R., Grzechca D., Chruszczyk L. Proceedings of the AIP Conference Proceedings. Volume 1906 AIP Publishing; College Park, MD, USA: 2017. Review of Advanced Driver Assistance Systems (ADAS) [Google Scholar]
  • 2.Ahangarnejad A.H., Radmehr A., Ahmadian M. A review of vehicle active safety control methods: From antilock brakes to semiautonomy. J. Vib. Control. 2021;27:1683–1712. doi: 10.1177/1077546320948656. [DOI] [Google Scholar]
  • 3.Niola V., Spirto M., Savino S., Cosenza C. Vibrational analysis to detect cavitation phenomena in a directional spool valve. Int. J. Mech. Control. 2021;22:11–16. [Google Scholar]
  • 4.Calabrese A., Gandelli E., Quaglini V., Strano S., Terzo M., Tordela C. Monitoring of hysteretic friction degradation of curved surface sliders through a nonlinear constrained estimator. Eng. Struct. 2021;226:111371. doi: 10.1016/j.engstruct.2020.111371. [DOI] [Google Scholar]
  • 5.Shladover S.E. Review of the state of development of advanced vehicle control systems (AVCS) Veh. Syst. Dyn. 1995;24:551–595. doi: 10.1080/00423119508969108. [DOI] [Google Scholar]
  • 6.Esposito D., Savino S., Andreozzi E., Cosenza C., Niola V., Bifulco P. The “Federica” Hand. Bioengineering. 2021;8:128. doi: 10.3390/bioengineering8090128. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Jumaa B.A., Abdulhassan A.M., Abdulhassan A.M. Advanced driver assistance system (ADAS): A review of systems and technologies. Int. J. Adv. Res. Comput. Eng. Technol. 2019;8:231–234. [Google Scholar]
  • 8.Cosenza C., Nicolella A., Esposito D., Niola V., Savino S. Mechanical system control by RGB-D device. Machines. 2020;9:3. doi: 10.3390/machines9010003. [DOI] [Google Scholar]
  • 9.Kukkala V.K., Tunnell J., Pasricha S., Bradley T. Advanced driver-assistance systems: A path toward autonomous vehicles. IEEE Consum. Electron. Mag. 2018;7:18–25. doi: 10.1109/MCE.2018.2828440. [DOI] [Google Scholar]
  • 10.Chan C.Y. Advancements, prospects, and impacts of automated driving systems. Int. J. Transp. Sci. Technol. 2017;6:208–216. doi: 10.1016/j.ijtst.2017.07.008. [DOI] [Google Scholar]
  • 11.Jiménez F., Naranjo J.E., Anaya J.J., García F., Ponz A., Armingol J.M. Advanced driver assistance system for road environments to improve safety and efficiency. Transp. Res. Procedia. 2016;14:2245–2254. doi: 10.1016/j.trpro.2016.05.240. [DOI] [Google Scholar]
  • 12.Singh K.B., Taheri S. Integrated state and parameter estimation for vehicle dynamics control. Int. J. Veh. Perform. 2019;5:329–376. doi: 10.1504/IJVP.2019.104082. [DOI] [Google Scholar]
  • 13.Katriniok A., Maschuw J.P., Christen F., Eckstein L., Abel D. Optimal Vehicle Dynamics Control for Combined Longitudinal and Lateral Autonomous Vehicle Guidance; Proceedings of the 2013 European Control Conference (ECC); Zurich, Switzerland. 17–19 July 2013; pp. 974–979. [Google Scholar]
  • 14.Gandelli E., Lomiento G., Quaglini V., Strano S., Terzo M., Tordela C. Estimation of the instantaneous friction coefficients of sliding isolators subjected to bi-directional orbits through a nonlinear state observer. Eng. Struct. 2021;249:113374. doi: 10.1016/j.engstruct.2021.113374. [DOI] [Google Scholar]
  • 15.Corno M., Panzani G., Savaresi S.M. Single-track vehicle dynamics control: State of the art and perspective. IEEE/Asme Trans. Mechatronics. 2015;20:1521–1532. doi: 10.1109/TMECH.2014.2382717. [DOI] [Google Scholar]
  • 16.Kaiser I., Strano S., Terzo M., Tordela C. Anti-yaw damping monitoring of railway secondary suspension through a nonlinear constrained approach integrated with a randomly variable wheel-rail interaction. Mech. Syst. Signal Process. 2021;146:107040. doi: 10.1016/j.ymssp.2020.107040. [DOI] [Google Scholar]
  • 17.Falcone P., Tufo M., Borrelli F., Asgari J., Tseng H.E. A Linear Time Varying Model Predictive Control Approach to the Integrated Vehicle Dynamics Control Problem in Autonomous Systems; Proceedings of the 2007 46th IEEE Conference on Decision and Control; New Orleans, LA, USA. 12–14 December 2007; pp. 2980–2985. [Google Scholar]
  • 18.Kun D., Kaijun L., Qunsheng X. Application of Unscented Kalman Filter for the State Estimation of Anti-Lock Braking System; Proceedings of the 2006 IEEE International Conference on Vehicular Electronics and Safety; Shanghai, China. 13–15 December 2006; pp. 130–133. [Google Scholar]
  • 19.Li B., Du H., Li W., Zhang Y. Side-slip angle estimation based lateral dynamics control for omni-directional vehicles with optimal steering angle and traction/brake torque distribution. Mechatronics. 2015;30:348–362. doi: 10.1016/j.mechatronics.2014.12.001. [DOI] [Google Scholar]
  • 20.Chung T., Yi K. Side slip angle based control threshold of vehicle stability control system. J. Mech. Sci. Technol. 2005;19:985–992. doi: 10.1007/BF02919181. [DOI] [Google Scholar]
  • 21.Farrell J.A., Roysdon P.F. Advanced vehicle state estimation: A tutorial and comparative study. IFAC-PapersOnLine. 2017;50:15971–15976. doi: 10.1016/j.ifacol.2017.08.1751. [DOI] [Google Scholar]
  • 22.Bersani M., Vignati M., Mentasti S., Arrigoni S., Cheli F. Vehicle State Estimation Based on Kalman Filters; Proceedings of the 2019 AEIT International Conference of Electrical and Electronic Technologies for Automotive (AEIT AUTOMOTIVE); Turin, Italy. 2–4 July 2019; pp. 1–6. [Google Scholar]
  • 23.Calabrese A., Quaglini V., Strano S., Terzo M. Online estimation of the friction coefficient in sliding isolators. Struct. Control. Health Monit. 2020;27:e2459. doi: 10.1002/stc.2459. [DOI] [Google Scholar]
  • 24.Calabrese A., Losanno D., Barjani A., Spizzuoco M., Strano S. Effects of the long-term aging of glass-fiber reinforced bearings (FRBs) on the seismic response of a base-isolated residential building. Eng. Struct. 2020;221:110735. doi: 10.1016/j.engstruct.2020.110735. [DOI] [Google Scholar]
  • 25.Guo H., Cao D., Chen H., Lv C., Wang H., Yang S. Vehicle dynamic state estimation: State of the art schemes and perspectives. IEEE/CAA J. Autom. Sin. 2018;5:418–431. doi: 10.1109/JAS.2017.7510811. [DOI] [Google Scholar]
  • 26.Liu W., Xia X., Xiong L., Lu Y., Gao L., Yu Z. Automated vehicle sideslip angle estimation considering signal measurement characteristic. IEEE Sensors J. 2021;21:21675–21687. doi: 10.1109/JSEN.2021.3059050. [DOI] [Google Scholar]
  • 27.Strano S., Terzo M., Tordela C. Output-only estimation of lateral wheel-rail contact forces and track irregularities. Veh. Syst. Dyn. 2023:1–29. doi: 10.1080/00423114.2023.2292651. [DOI] [Google Scholar]
  • 28.Park G. Vehicle sideslip angle estimation based on interacting multiple model Kalman filter using low-cost sensor fusion. IEEE Trans. Veh. Technol. 2022;71:6088–6099. doi: 10.1109/TVT.2022.3161460. [DOI] [Google Scholar]
  • 29.Esposito D., Savino S., Cosenza C., Andreozzi E., Gargiulo G.D., Polley C., Cesarelli G., D’Addio G., Bifulco P. Evaluation of grip force and energy efficiency of the “Federica” hand. Machines. 2021;9:25. doi: 10.3390/machines9020025. [DOI] [Google Scholar]
  • 30.Xia X., Hang P., Xu N., Huang Y., Xiong L., Yu Z. Advancing estimation accuracy of sideslip angle by fusing vehicle kinematics and dynamics information with fuzzy logic. IEEE Trans. Veh. Technol. 2021;70:6577–6590. doi: 10.1109/TVT.2021.3086095. [DOI] [Google Scholar]
  • 31.González L.P., Sánchez S.S., Garcia-Guzman J., Boada M.J.L., Boada B.L. Simultaneous estimation of vehicle roll and sideslip angles through a deep learning approach. Sensors. 2020;20:3679. doi: 10.3390/s20133679. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 32.Bertipaglia A., de Mol D., Alirezaei M., Happee R., Shyrokau B. Model-Based vs Data-Driven Estimation of Vehicle Sideslip Angle and Benefits of Tyre Force Measurements. arXiv. 20222206.15119 [Google Scholar]
  • 33.Nguyen C.M., Nguyen A.T., Delprat S. Neural-network-based fuzzy observer with data-driven uncertainty identification for vehicle dynamics estimation under extreme driving conditions: Theory and experimental results. IEEE Trans. Veh. Technol. 2023;72:8686–8696. doi: 10.1109/TVT.2023.3249832. [DOI] [Google Scholar]
  • 34.Zhou C., Yu L., Li Y., Song J. Robust sideslip angle observer of commercial vehicles based on cornering stiffness estimation using neural network. Proc. Inst. Mech. Eng. Part J. Automob. Eng. 2023;237:224–243. doi: 10.1177/09544070211072401. [DOI] [Google Scholar]
  • 35.Zhang C., Feng Y., Wang J., Gao P., Qin P. Vehicle Sideslip Angle Estimation Based on Radial Basis Neural Network and Unscented Kalman Filter Algorithm. Actuators. 2023;12:371. doi: 10.3390/act12100371. [DOI] [Google Scholar]
  • 36.Farrelly J., Wellstead P. Estimation of Vehicle Lateral Velocity; Proceedings of the 1996 IEEE International Conference on Control Applications Held Together with IEEE International Symposium on Intelligent Control; Dearborn, MI, USA. 15 September–18 November 1996; pp. 552–557. [Google Scholar]
  • 37.De Pascali L., Biral F., Cocetti M., Zaccarian L., Tarbouriech S. A Kinematic Observer with Adaptive Dead-Zone for Vehicles Lateral Velocity Estimation; Proceedings of the 2018 IEEE 15th International Workshop on Advanced Motion Control (AMC); Tokyo, Japan. 9–11 March 2018; pp. 511–516. [Google Scholar]
  • 38.Selmanaj D., Corno M., Panzani G., Savaresi S.M. Vehicle sideslip estimation: A kinematic based approach. Control. Eng. Pract. 2017;67:1–12. doi: 10.1016/j.conengprac.2017.06.013. [DOI] [Google Scholar]
  • 39.Kang C.M., Lee S.H., Chung C.C. Vehicle Lateral Motion Estimation with Its Dynamic and Kinematic Models Based Interacting Multiple Model Filter; Proceedings of the 2016 IEEE 55th Conference on Decision and Control (CDC); Las Vegas, NV, USA. 12–14 December 2016; pp. 2449–2454. [Google Scholar]
  • 40.Singh K.B. Vehicle sideslip angle estimation based on tire model adaptation. Electronics. 2019;8:199. doi: 10.3390/electronics8020199. [DOI] [Google Scholar]
  • 41.Mosconi L., Farroni F., Sakhnevych A., Timpone F., Gerbino F.S. Adaptive vehicle dynamics state estimator for onboard automotive applications and performance analysis. Veh. Syst. Dyn. 2023;61:3244–3268. doi: 10.1080/00423114.2022.2158567. [DOI] [Google Scholar]
  • 42.Baffet G., Charara A., Lechner D. Estimation of vehicle sideslip, tire force and wheel cornering stiffness. Control. Eng. Pract. 2009;17:1255–1264. doi: 10.1016/j.conengprac.2009.05.005. [DOI] [Google Scholar]
  • 43.Tian Y., Lian Y., Tian C., Sun Z., Liu K. Sideslip Angle and Tire Cornering Stiffness Estimations for Four-in-Wheel-Motor-Driven Electric Vehicles; Proceedings of the 2019 Chinese Control Conference (CCC); Guangzhou, China. 27–30 July 2019; pp. 2418–2423. [Google Scholar]
  • 44.Esposito C., Cosenza C., Gerbino S., Martorelli M., Franciosa P. Virtual shimming simulation for smart assembly of aircraft skin panels based on a physics-driven digital twin. Int. J. Interact. Des. Manuf. 2022;16:753–763. doi: 10.1007/s12008-022-00875-4. [DOI] [Google Scholar]
  • 45.Zhang B., Du H., Lam J., Zhang N., Li W. A novel observer design for simultaneous estimation of vehicle steering angle and sideslip angle. IEEE Trans. Ind. Electron. 2016;63:4357–4366. doi: 10.1109/TIE.2016.2544244. [DOI] [Google Scholar]
  • 46.Oh J.J., Choi S.B. Vehicle velocity observer design using 6-D IMU and multiple-observer approach. IEEE Trans. Intell. Transp. Syst. 2012;13:1865–1879. doi: 10.1109/TITS.2012.2204984. [DOI] [Google Scholar]
  • 47.Belrzaeg M., Ahmed A.A., Almabrouk A.Q., Khaleel M.M., Ahmed A.A., Almukhtar M. Vehicle dynamics and tire models: An overview. World J. Adv. Res. Rev. 2021;12:331–348. doi: 10.30574/wjarr.2021.12.1.0524. [DOI] [Google Scholar]
  • 48.Bhoraskar A., Sakthivel P. A Review and a Comparison of Dugoff and Modified Dugoff Formula with Magic Formula; Proceedings of the 2017 International Conference on Nascent Technologies in Engineering (ICNTE); Vashi, India. 27–28 January 2017; pp. 1–4. [Google Scholar]
  • 49.Pacejka H.B., Bakker E. The magic formula tyre model. Veh. Syst. Dyn. 1992;21:1–18. doi: 10.1080/00423119208969994. [DOI] [Google Scholar]
  • 50.Pacejka H. Tire and Vehicle Dynamics. Elsevier; Amsterdam, The Netherlands: 2005. [Google Scholar]
  • 51.Sanjurjo E., Dopico D., Luaces A., Naya M.Á. State and force observers based on multibody models and the indirect Kalman filter. Mech. Syst. Signal Process. 2018;106:210–228. doi: 10.1016/j.ymssp.2017.12.041. [DOI] [Google Scholar]
  • 52.Cuadrado J., Dopico D., Perez J.A., Pastorino R. Automotive observers based on multibody models and the extended Kalman filter. Multibody Syst. Dyn. 2012;27:3–19. doi: 10.1007/s11044-011-9251-1. [DOI] [Google Scholar]
  • 53.Rodríguez A.J., Sanjurjo E., Pastorino R., Naya M.Á. State, parameter and input observers based on multibody models and Kalman filters for vehicle dynamics. Mech. Syst. Signal Process. 2021;155:107544. doi: 10.1016/j.ymssp.2020.107544. [DOI] [Google Scholar]
  • 54.Kuslits M. Vehicle Dynamics State Estimation Method Featuring Spatial Multibody Model and Extended Kalman Filter; Proceedings of the ECCOMAS Thematic Conference on Multibody Dynamics; Lisbon, Portugal. 24–28 July 2023. [Google Scholar]
  • 55.Naets F., Pastorino R., Cuadrado J., Desmet W. Online state and input force estimation for multibody models employing extended Kalman filtering. Multibody Syst. Dyn. 2014;32:317–336. doi: 10.1007/s11044-013-9381-8. [DOI] [Google Scholar]
  • 56.Antonov S., Fehn A., Kugi A. Unscented Kalman filter for vehicle state estimation. Veh. Syst. Dyn. 2011;49:1497–1520. doi: 10.1080/00423114.2010.527994. [DOI] [Google Scholar]
  • 57.Simon D. Optimal State Estimation: Kalman, H Infinity, and Nonlinear Approaches. John Wiley & Sons; Hoboken, NJ, USA: 2006. [Google Scholar]
  • 58.Kaiser I., Strano S., Terzo M., Tordela C. Estimation of the railway equivalent conicity under different contact adhesion levels and with no wheelset sensorization. Veh. Syst. Dyn. 2023;61:19–37. doi: 10.1080/00423114.2022.2038383. [DOI] [Google Scholar]
  • 59.Best M.C., Gordon T., Dixon P. An extended adaptive Kalman filter for real-time state estimation of vehicle handling dynamics. Veh. Syst. Dyn. 2000;34:57–75. [Google Scholar]
  • 60.Zhu T., Zheng H. Application of Unscented Kalman Filter to Vehicle State Estimation; Proceedings of the 2008 ISECS International Colloquium on Computing, Communication, Control, and Management; Guangzhou, China. 3–4 August 2008; pp. 135–139. [Google Scholar]
  • 61.Liu W., He H., Sun F. Vehicle state estimation based on minimum model error criterion combining with extended Kalman filter. J. Frankl. Inst. 2016;353:834–856. doi: 10.1016/j.jfranklin.2016.01.005. [DOI] [Google Scholar]
  • 62.Wenzel T.A., Burnham K., Blundell M., Williams R. Dual extended Kalman filter for vehicle state and parameter estimation. Veh. Syst. Dyn. 2006;44:153–171. doi: 10.1080/00423110500385949. [DOI] [Google Scholar]
  • 63.Naets F., van Aalst S., Boulkroune B., El Ghouti N., Desmet W. Design and experimental validation of a stable two-stage estimator for automotive sideslip angle and tire parameters. IEEE Trans. Veh. Technol. 2017;66:9727–9742. doi: 10.1109/TVT.2017.2742665. [DOI] [Google Scholar]
  • 64.Doumiati M., Victorino A., Charara A., Lechner D. Unscented Kalman Filter for Real-Time Vehicle Lateral Tire Forces and Sideslip Angle Estimation; Proceedings of the 2009 IEEE Intelligent Vehicles Symposium; Xi’an, China. 3–5 June 2009; pp. 901–906. [Google Scholar]
  • 65.Wan E.A., Van Der Merwe R. The Unscented Kalman Filter for Nonlinear Estimation; Proceedings of the IEEE 2000 Adaptive Systems for Signal Processing, Communications, and Control Symposium (Cat. No. 00EX373); Lake Louise, AB, Canada. 4 October 2000; pp. 153–158. [Google Scholar]
  • 66.Wang Y., Sun S., Li L. Adaptively robust unscented Kalman filter for tracking a maneuvering vehicle. J. Guid. Control. Dyn. 2014;37:1696–1701. doi: 10.2514/1.G000257. [DOI] [Google Scholar]
  • 67.D’Inverno M., Arricale V.M., Zanardi A., Frazzoli E., Sakhnevych A., Timpone F. A Benchmark Study on the Model-Based Estimation of the Go-Kart Side-Slip Angle; Proceedings of the Journal of Physics: Conference Series; Virtual. 6–9 September 2021; p. 012156. [Google Scholar]
  • 68.Welch G., Bishop G. An Introduction to the Kalman Filter. University of North Carolina at Chapel Hill; Chapel Hill, NC, USA: 1995. Technical Report 95-041. [Google Scholar]
  • 69.Terejanu G.A. Unscented Kalman Filter Tutorial. University at Buffalo; Buffalo, NY, USA: 2011. [Google Scholar]
  • 70.Bell B.M., Cathey F.W. The iterated Kalman filter update as a Gauss-Newton method. IEEE Trans. Autom. Control. 1993;38:294–297. doi: 10.1109/9.250476. [DOI] [Google Scholar]
  • 71.Huang D.Z., Schneider T., Stuart A.M. Iterated Kalman methodology for inverse problems. J. Comput. Phys. 2022;463:111262. doi: 10.1016/j.jcp.2022.111262. [DOI] [Google Scholar]
  • 72.Tang X., Zhao X., Zhang X. The Square-Root Spherical Simplex Unscented Kalman Filter for State and Parameter Estimation; Proceedings of the 2008 9th International Conference on Signal Processing; Beijing, China. 26–29 October 2008; pp. 260–263. [Google Scholar]
  • 73.Julier S., Uhlmann J. Unscented filtering and nonlinear estimation. Proc. IEEE. 2004;92:401–422. doi: 10.1109/JPROC.2003.823141. [DOI] [Google Scholar]
  • 74.Julier S. The Spherical Simplex Unscented Transformation; Proceedings of the 2003 American Control Conference; Denver, CO, USA. 4–6 June 2003; pp. 2430–2434. [DOI] [Google Scholar]
  • 75.Jonson A., Olsson E. Master’s Thesis. Chalmers University of Technology; Göteborg, Sweden: 2016. A Methodology for Identification of Magic Formula Tire Model Parameters from In-Vehicle Measurements. [Google Scholar]
  • 76.Kuiper E., Van Oosten J. The PAC2002 advanced handling tire model. Veh. Syst. Dyn. 2007;45:153–167. doi: 10.1080/00423110701773893. [DOI] [Google Scholar]
  • 77.Sakhnevych A., Genovese A. Tyre wear model: A fusion of rubber viscoelasticity, road roughness, and thermodynamic state. Wear. 2024;542:205291. doi: 10.1016/j.wear.2024.205291. [DOI] [Google Scholar]
  • 78.Zegelaar P.W.A. The Dynamic Response of Tyres to Brake Torque Variations and Road Unevennesses. 1998. [(accessed on 21 July 2024)]. Available online: https://www.researchgate.net/publication/27341630.
  • 79.Schmeitz A., Besselink I., Jansen S. Tno mf-swift. Veh. Syst. Dyn. 2007;45:121–137. doi: 10.1080/00423110701725208. [DOI] [Google Scholar]
  • 80.Xu N., Guo K., Zhang X., Karimi H.R. An analytical tire model with flexible carcass for combined slips. Math. Probl. Eng. 2014;2014:397538. doi: 10.1155/2014/397538. [DOI] [Google Scholar]
  • 81.Schmeitz A., Versteden W. Structure and parameterization of mf-swift, a magic formula-based rigid ring tire model. Tire Sci. Technol. 2009;37:142–164. doi: 10.2346/1.3138768. [DOI] [Google Scholar]
  • 82.Gallrein A., Bäcker M. CDTire: A tire model for comfort and durability applications. Veh. Syst. Dyn. 2007;45:69–77. doi: 10.1080/00423110801931771. [DOI] [Google Scholar]
  • 83.Petrone P., Giordano G., Vezzoli E., Pensa A., Castaldo G., Graziano V., Sirano F., Capasso E., Quaremba G., Vona A., et al. Preservation of neurons in an AD 79 vitrified human brain. PLoS ONE. 2020;15:e0240017. doi: 10.1371/journal.pone.0240017. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 84.Sakhnevych A. Multiphysical MF-based tyre modelling and parametrisation for vehicle setup and control strategies optimisation. Veh. Syst. Dyn. 2022;60:3462–3483. doi: 10.1080/00423114.2021.1977833. [DOI] [Google Scholar]
  • 85.Sakhnevych A., Genovese A., Maiorano A., Timpone F., Farroni F. An ultrasound method for characterization of viscoelastic properties in frequency domain at small deformations. Proc. Inst. Mech. Eng. Part J. Mech. Eng. Sci. 2021;235:7180–7191. doi: 10.1177/09544062211005789. [DOI] [Google Scholar]
  • 86.Yoo H., Oh J., Chung W.J., Han H.W., Kim J.T., Park Y.J., Park Y. Measurement of stiffness and damping coefficient of rubber tractor tires using dynamic cleat test based on point contact model. Int. J. Agric. Biol. Eng. 2021;14:157–164. doi: 10.25165/j.ijabe.20211401.5799. [DOI] [Google Scholar]
  • 87.Cosenza C., Niola V., Savino S. A simplified model of a multi-jointed mechanical finger calibrated with experimental data by vision system. Proc. Inst. Mech. Eng. Part J. -Multi-Body Dyn. 2021;235:164–175. doi: 10.1177/1464419320955115. [DOI] [Google Scholar]
  • 88.Schmeitz A., Teerhuis A. Robustness and applicability of a model-based tire state estimator for an intelligent tire. Tire Sci. Technol. 2018;46:105–126. doi: 10.2346/tire.18.460204. [DOI] [Google Scholar]
  • 89.Liu G., Ren H., Chen S., Wang W. The 3-DoF Bicycle Model with the Simplified Piecewise Linear Tire Model; Proceedings of the 2013 International Conference on Mechatronic Sciences, Electric Engineering and Computer (MEC); Shengyang, China. 20–22 December 2013; pp. 3530–3534. [Google Scholar]
  • 90.Guiggiani M. The Science of Vehicle Dynamics. Springer International Publishing AG; Berlin/Heidelberg, Germany: 2018. [Google Scholar]
  • 91.Abbeel P., Coates A., Montemerlo M., Ng A.Y., Thrun S. Discriminative Training of Kalman Filters; Proceedings of the Robotics: Science and Systems; Cambridge, MA, USA. 8–11 June 2005; p. 1. [Google Scholar]
  • 92.Kistler Group . 2055A. Non-Contact Optical Sensors Correvit S-Motion, Kistler Group; Winterthur, Switzerland: 2024. [Google Scholar]
  • 93.Oxford Technical Solutions RT3000 v3. [(accessed on 21 July 2024)]. Available online: https://www.oxts.com/products/rt3000-v3/
  • 94.DeweSoft DEWE-43A. [(accessed on 21 July 2024)]. Available online: https://dewesoft.com/products/dewe-43/tech-specs.
  • 95.Farroni F., Mosconi L., Sakhnevych A., Timpone F. Proceedings of the XXIV AIMETA Conference 2019 24. Springer; Berlin, Germany: 2020. Trick Real Time. A Tool for the Real-Time Onboard Tire Performance Evaluation; pp. 1020–1032. [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Data Availability Statement

Data presented in this study are available on request from the corresponding author.


Articles from Sensors (Basel, Switzerland) are provided here courtesy of Multidisciplinary Digital Publishing Institute (MDPI)

RESOURCES