1
0
mirror of https://bitbucket.org/librepilot/librepilot.git synced 2025-01-18 03:52:11 +01:00

OP-1317 Small optimizations of code, delete of debug variables in airspeed object and uncrustify

This commit is contained in:
Andres 2014-05-22 10:00:50 +02:00
parent 423645392b
commit a83379425c
2 changed files with 82 additions and 82 deletions

View File

@ -41,6 +41,8 @@
// Private constants
#define TWO_PI 6.283185308f
#define SQRT2 1.414213562f
#define EPS_REORIENTATION 1e-8f
#define EPS_VELOCITY 1.f
@ -53,13 +55,15 @@ struct IMUGlobals {
float v1n1, v1n2;
float v2n1, v2n2;
float v3n1, v3n2;
float Vn1,Vn2;
// storage variables for derivative calculation
float Vn1, Vn2;
// storage variables for derivative calculation
float pOld, yOld;
float v1Old, v2Old, v3Old;
};
// Private variables
static struct IMUGlobals *imu;
@ -79,50 +83,50 @@ static void Quaternion2PY(const float q0, const float q1, const float q2, const
const float q2s = q2 * q2;
const float q3s = q3 * q3;
R13 = 2.0f * (q1 * q3 - q0 * q2);
R11 = q0s + q1s - q2s - q3s;
R12 = 2.0f * (q1 * q2 + q0 * q3);
R13 = 2.0f * (q1 * q3 - q0 * q2);
R11 = q0s + q1s - q2s - q3s;
R12 = 2.0f * (q1 * q2 + q0 * q3);
*pPtr = asinf(-R13); // pitch always between -pi/2 to pi/2
const float y_=atan2f(R12, R11);
const float y_ = atan2f(R12, R11);
// use old yaw contained in y to add multiples of 2pi to have a continuous yaw if user does not want the principal argument
// else simply copy atan2 result into result
if(principalArg){
if (principalArg) {
*yPtr = y_;
}else{
const int mod=(int)((y_-*yPtr)/(2.0f*M_PI_F*0.9f));
*yPtr = y_- 2.0f*M_PI_F*mod;
} else {
// calculate needed mutliples of 2pi to avoid jumps
// take slightly less than 2pi, because the jump will never be exactly 2pi
const int mod = (int)((y_ - *yPtr) / (TWO_PI * 0.9f));
*yPtr = y_ - TWO_PI * mod;
}
}
static void PY2xB(float p, float y, float x[3])
{
const float cosp=cosf(p);
x[0]=cosp*cosf(y);
x[1]=cosp*sinf(y);
x[2]=-sinf(p);
const float cosp = cosf(p);
x[0] = cosp * cosf(y);
x[1] = cosp * sinf(y);
x[2] = -sinf(p);
}
//second order Butterworth filter with cut-off frequency ratio ff
// filter is writen in direct from 2, such that only two values wn1=w[n-1] and wn2=w[n-2] need to be stored
// second order Butterworth filter with cut-off frequency ratio ff
// Biquadratic filter in direct from 2, such that only two values wn1=w[n-1] and wn2=w[n-2] need to be stored
// function takes care of updating the values wn1 and wn2
float FilterButterWorthDF2(const float ff, float xn, float *wn1Ptr, float *wn2Ptr)
float FilterButterWorthDF2(const float ff, const float xn, float *wn1Ptr, float *wn2Ptr)
{
// TODO: we need to think about storing the filter instead of calculating it again and again
const float ita =1.0f/ tanf(M_PI_F*ff);
const float q=sqrtf(2.0f);
const float b0 = 1.0f / (1.0f + q*ita + Sq(ita));
const float b1= 2.0f*b0;
const float b2= b0;
const float a1 = 2.0f * (Sq(ita) - 1.0f) * b0;
const float a2 = -(1.0f - q*ita + Sq(ita)) * b0;
const float wn=xn + a1*(*wn1Ptr) + a2*(*wn2Ptr);
const float val=b0*wn + b1*(*wn1Ptr) + b2*(*wn2Ptr);
*wn2Ptr=*wn1Ptr;
*wn1Ptr=wn;
const float ita = 1.0f / tanf(M_PI_F * ff);
const float b0 = 1.0f / (1.0f + SQRT2 * ita + Sq(ita));
const float a1 = 2.0f * b0 * (Sq(ita) - 1.0f);
const float a2 = -b0 * (1.0f - SQRT2 * ita + Sq(ita));
const float wn = xn + a1 * (*wn1Ptr) + a2 * (*wn2Ptr);
const float val = b0 * (wn + 2.0f * (*wn1Ptr) + (*wn2Ptr));
*wn2Ptr = *wn1Ptr;
*wn1Ptr = wn;
return val;
}
@ -144,17 +148,17 @@ void imu_airspeedInitialize()
AttitudeStateGet(&attData);
// get pitch and yaw from quarternion; principal argument for yaw
Quaternion2PY(attData.q1, attData.q2, attData.q3, attData.q4, &(imu->pOld),&(imu->yOld),true);
imu->pn1 = imu->pn2 = imu->pOld;
imu->yn1 = imu->yn2 = imu->yOld;
Quaternion2PY(attData.q1, attData.q2, attData.q3, attData.q4, &(imu->pOld), &(imu->yOld), true);
imu->pn1 = imu->pn2 = imu->pOld;
imu->yn1 = imu->yn2 = imu->yOld;
imu->v1n1 = imu->v1n2 = imu->v1Old = velData.North;
imu->v2n1 = imu->v2n2 = imu->v2Old = velData.East;
imu->v3n1 = imu->v3n2 = imu->v3Old = velData.Down;
// initial guess for airspeed is modulus of groundspeed
imu->Vn1 = imu->Vn2 = sqrt(Sq(velData.North) + Sq(velData.East) + Sq(velData.Down));
imu->Vn1 = imu->Vn2 = sqrt(Sq(velData.North) + Sq(velData.East) + Sq(velData.Down));
}
/*
@ -169,75 +173,79 @@ void imu_airspeedInitialize()
*
* See OP-1317 imu_wind_estimation.pdf for details on the adaptation
* Need a low pass filter to filter out spikes in non coordinated maneuvers
* A two step Butterworth second order filter is used. In the first step fuselage vector xB
* and ground speed vector Vel are filtered. The fuselage vector is filtered through its pitch
* and yaw to keep a unit length. After building the differenced dxB and dVel are produced and
* the airspeed calculated. The calculated airspeed is filtered again with a Butterworth filter
*/
void imu_airspeedGet(AirspeedSensorData *airspeedData, AirspeedSettingsData *airspeedSettings)
{
//pre-filter frequency rate
//corresponds to a cut-off frequency of 0.04 Hz or a period of 25 sec
const float ff=0.04f * 1000.0f/airspeedSettings->SamplePeriod;
// pre-filter frequency rate
// corresponds to a cut-off frequency of 0.04 Hz or a period of 25 sec
const float ff = 0.04f * 1000.0f / airspeedSettings->SamplePeriod;
// good values for turbulent situation: cut-off 0.01 Hz or a period of 100 sec
const float ffV=0.01f * 1000.0f/airspeedSettings->SamplePeriod;
const float ffV = 0.01f * 1000.0f / airspeedSettings->SamplePeriod;
// good values for steady situation: cut-off 0.05 Hz or a period of 20 sec
// const float ffV=0.05 * 1000.0f/airspeedSettings->SamplePeriod;
float dxB[3], dVel[3];
// const float ffV=0.05 * 1000.0f/airspeedSettings->SamplePeriod;
float normVel2;
float normDiffAttitude2;
float dvdtDotdfdt;
// get values and conduct smoothing of ground speed and orientation independently of the calculation of airspeed
{ // Scoping to save memory
AttitudeStateData attData;
AttitudeStateGet(&attData);
VelocityStateData velData;
VelocityStateGet(&velData);
float p=imu->pOld, y=imu->yOld;
float xB[3], xBOld[3];
float p = imu->pOld, y = imu->yOld;
float dxB[3], xBOld[3];
// get pitch and roll Euler angles from quaternion
// do not calculate the principlal argument of yaw, i.e. use old yaw to add multiples of 2pi to have a continuous yaw
Quaternion2PY(attData.q1, attData.q2, attData.q3, attData.q4,&p,&y,false);
Quaternion2PY(attData.q1, attData.q2, attData.q3, attData.q4, &p, &y, false);
// filter pitch and roll Euler angles instead of fuselage vector to guarantee a unit length at all times
p=FilterButterWorthDF2(ff, p, &(imu->pn1), &(imu->pn2));
y=FilterButterWorthDF2(ff, y, &(imu->yn1), &(imu->yn2));
// transform pitch and yaw into fuselage vector xB
PY2xB(imu->pOld,imu->yOld,xBOld);
PY2xB(p,y,xB);
p = FilterButterWorthDF2(ff, p, &(imu->pn1), &(imu->pn2));
y = FilterButterWorthDF2(ff, y, &(imu->yn1), &(imu->yn2));
// transform pitch and yaw into fuselage vector xB and xBold
PY2xB(imu->pOld, imu->yOld, xBOld);
PY2xB(p, y, dxB);
// calculate change in fuselage vector
dxB[0]=xB[0]-xBOld[0];
dxB[1]=xB[1]-xBOld[1];
dxB[2]=xB[2]-xBOld[2];
dxB[0] -= xBOld[0];
dxB[1] -= xBOld[1];
dxB[2] -= xBOld[2];
// filter ground speed from VelocityState
const float fv1n = FilterButterWorthDF2(ff, velData.North, &(imu->v1n1), &(imu->v1n2));
const float fv2n = FilterButterWorthDF2(ff, velData.East, &(imu->v2n1), &(imu->v2n2));
const float fv3n = FilterButterWorthDF2(ff, velData.Down, &(imu->v3n1), &(imu->v3n2));
// calculate change in ground velocity
dVel[0] = fv1n - imu->v1Old;
dVel[1] = fv2n - imu->v2Old;
dVel[2] = fv3n - imu->v3Old;
const float fv2n = FilterButterWorthDF2(ff, velData.East, &(imu->v2n1), &(imu->v2n2));
const float fv3n = FilterButterWorthDF2(ff, velData.Down, &(imu->v3n1), &(imu->v3n2));
// calculate norm of ground speed
normVel2 = Sq(fv1n) + Sq(fv2n) + Sq(fv3n);
// actualise old values
imu->pOld = p; imu->yOld = y;
imu->v1Old = fv1n; imu->v2Old = fv2n; imu->v3Old = fv3n;
}
// calculate norm of orientation change
normDiffAttitude2 = Sq(dxB[0]) + Sq(dxB[1]) + Sq(dxB[2]);
// cauclate scalar product between groundspeed change and orientation change
dvdtDotdfdt = (fv1n - imu->v1Old) * dxB[0] + (fv2n - imu->v2Old) * dxB[1] + (fv3n - imu->v3Old) * dxB[2];
// Calculate the norm^2 of the difference between the two fuselage vectors
const float normDiffAttitude2 = Sq(dxB[0]) + Sq(dxB[1]) + Sq(dxB[2]);
// Calculate scalar product of difference vectors
const float dvdtDotdfdt = dVel[0] * dxB[0] + dVel[1] * dxB[1] + dVel[2] * dxB[2];
// actualise old values
imu->pOld = p;
imu->yOld = y;
imu->v1Old = fv1n;
imu->v2Old = fv2n;
imu->v3Old = fv3n;
}
// Some reorientation needed to be able to calculate airspeed, calculate only for sufficient velocity
// a negative scalar product is a clear sign that we are not really able to calculate the airspeed
// NOTE: normVel2 check against EPS_VELOCITY might make problems during hovering maneuvers in fixed wings
if (normDiffAttitude2 > EPS_REORIENTATION && normVel2 > EPS_VELOCITY && dvdtDotdfdt > 0.f) {
// Airspeed modulus: |v| = dv/dt * dxB/dt / |dxB/dt|^2
// airspeed is always REAL because normDiffAttitude2 > EPS_REORIENTATION > 0 and REAL dvdtDotdfdt
const float airspeed = dvdtDotdfdt / normDiffAttitude2;
// filter raw airspeed
const float fVn=FilterButterWorthDF2(ffV,airspeed,&(imu->Vn1),&(imu->Vn2));
const float fVn = FilterButterWorthDF2(ffV, airspeed, &(imu->Vn1), &(imu->Vn2));
airspeedData->CalibratedAirspeed = fVn;
airspeedData->SensorConnected = AIRSPEEDSENSOR_SENSORCONNECTED_TRUE;
AlarmsSet(SYSTEMALARMS_ALARM_AIRSPEED, SYSTEMALARMS_ALARM_OK);

View File

@ -7,14 +7,6 @@
<field name="DifferentialPressure" units="Pa" type="float" elements="1"/>
<field name="Temperature" units="K" type="float" elements="1"/>
<field name="CalibratedAirspeed" units="m/s" type="float" elements="1"/>
<!-- For debugin/testng purposes. Should be deleted before merge -->
<field name="f" units="" type="float" elements="3"/>
<field name="v" units="" type="float" elements="3"/>
<field name="df" units="" type="float" elements="3"/>
<field name="dv" units="" type="float" elements="3"/>
<field name="absdf" units="" type="float" elements="1"/>
<field name="dvdotdf" units="" type="float" elements="1"/>
<!-- End of debuging variables-->
<field name="TrueAirspeed" units="m/s" type="float" elements="1" defaultvalue="-1"/>
<access gcs="readwrite" flight="readwrite"/>
<telemetrygcs acked="false" updatemode="manual" period="0"/>