51#include "FGStandardAtmosphere.h"
62 :
FGAtmosphere(fdmex), StdSLpressure(StdDaySLpressure), TemperatureBias(0.0),
63 TemperatureDeltaGradient(0.0), VaporMassFraction(0.0),
64 SaturatedVaporPressure(StdDaySLpressure), StdAtmosTemperatureTable(9),
65 MaxVaporMassFraction(10)
67 Name =
"FGStandardAtmosphere";
89 StdAtmosTemperatureTable << 0.0000 << 518.67
90 << 36089.2388 << 389.97
91 << 65616.7979 << 389.97
92 << 104986.8766 << 411.57
93 << 154199.4751 << 487.17
94 << 167322.8346 << 487.17
95 << 232939.6325 << 386.37
96 << 278385.8268 << 336.5028
97 << 298556.4304 << 336.5028;
108 MaxVaporMassFraction << 0.0000 << 35000.
109 << 3280.8399 << 31000.
110 << 6561.6798 << 28000.
111 << 13123.3596 << 22000.
112 << 19685.0394 << 8900.
113 << 26246.7192 << 4700.
114 << 32808.3990 << 1300.
115 << 39370.0787 << 230.
117 << 52493.4383 << 38.;
119 unsigned int numRows = StdAtmosTemperatureTable.GetNumRows();
123 StdLapseRates = LapseRates;
128 GradientFadeoutAltitude = StdAtmosTemperatureTable(numRows, 0);
131 PressureBreakpoints.resize(numRows);
133 StdPressureBreakpoints = PressureBreakpoints;
154bool FGStandardAtmosphere::InitModel(
void)
160 GradientFadeoutAltitude = StdAtmosTemperatureTable(StdAtmosTemperatureTable.GetNumRows(), 0);
162 TemperatureDeltaGradient = 0.0;
163 TemperatureBias = 0.0;
164 LapseRates = StdLapseRates;
166 PressureBreakpoints = StdPressureBreakpoints;
168 SLpressure = StdSLpressure;
170 SLdensity = StdSLdensity;
171 SLsoundspeed = StdSLsoundspeed;
202 double BaseAlt = StdAtmosTemperatureTable(1,0);
203 unsigned int numRows = StdAtmosTemperatureTable.GetNumRows();
206 for (b=0; b < numRows-2; ++b) {
207 double testAlt = StdAtmosTemperatureTable(b+2,0);
208 if (GeoPotAlt < testAlt)
214 double deltaH = GeoPotAlt - BaseAlt;
215 double Lmb = LapseRates[b];
218 double Exp =
g0 / (Rdry*Lmb);
219 double factor = Tmb/(Tmb + Lmb*deltaH);
220 return PressureBreakpoints[b]*pow(factor, Exp);
222 return PressureBreakpoints[b]*exp(-
g0*deltaH/(Rdry*Tmb));
239 SLsoundspeed = sqrt(SHRatio*Reng*SLtemperature);
253 if (GeoPotAlt >= 0.0) {
254 T = StdAtmosTemperatureTable.
GetValue(GeoPotAlt);
256 if (GeoPotAlt <= GradientFadeoutAltitude)
257 T -= TemperatureDeltaGradient * GeoPotAlt;
262 T = StdAtmosTemperatureTable.
GetValue(0.0) + GeoPotAlt*LapseRates[0];
265 T += TemperatureBias;
267 if (GeoPotAlt <= GradientFadeoutAltitude)
268 T += TemperatureDeltaGradient * GradientFadeoutAltitude;
280 if (GeoPotAlt >= 0.0)
281 return StdAtmosTemperatureTable.
GetValue(GeoPotAlt);
283 return StdAtmosTemperatureTable.
GetValue(0.0) + GeoPotAlt*LapseRates[0];
297 double BaseAlt = StdAtmosTemperatureTable(1,0);
298 unsigned int numRows = StdAtmosTemperatureTable.GetNumRows();
301 for (b=0; b < numRows-2; ++b) {
302 double testAlt = StdAtmosTemperatureTable(b+2,0);
303 if (GeoPotAlt < testAlt)
309 double deltaH = GeoPotAlt - BaseAlt;
310 double Lmb = LapseRates[b];
313 double Exp =
g0 / (Rdry*Lmb);
314 double factor = Tmb/(Tmb + Lmb*deltaH);
315 return StdPressureBreakpoints[b]*pow(factor, Exp);
317 return StdPressureBreakpoints[b]*exp(-
g0*deltaH/(Rdry*Tmb));
336 if (GeoPotAlt <= GradientFadeoutAltitude)
337 bias -= TemperatureDeltaGradient * (GradientFadeoutAltitude - GeoPotAlt);
353 const double minStdAtmosphereTemp = StdAtmosTemperatureTable.GetMinValue();
358 if (unit == eCelsius || unit == eKelvin)
364 if (minStdAtmosphereTemp + TemperatureBias < minUniverseTemperature) {
365 double minBias = minUniverseTemperature - minStdAtmosphereTemp;
366 cerr <<
"The temperature bias " << TemperatureBias <<
" R is too low. "
367 <<
"It could result in temperatures below the absolute zero." << endl
368 <<
"Temperature bias is therefore capped to " << minBias << endl;
369 TemperatureBias = minBias;
409 const double minStdAtmosphereTemp = StdAtmosTemperatureTable.GetMinValue();
412 if (unit == eCelsius || unit == eKelvin)
415 if (deltemp <= minDeltaTemperature) {
416 cerr <<
"The temperature delta " << deltemp <<
" R is too low. "
417 <<
"It could result in temperatures below the absolute zero." << endl
418 <<
"Temperature delta is therefore capped to " << minDeltaTemperature << endl;
419 deltemp = minDeltaTemperature;
434 std::cout <<
"Altitude (ft) Temp (F) Pressure (psf) Density (sl/ft3)" << std::endl;
435 std::cout <<
"------------- -------- -------------- ----------------" << std::endl;
436 for (
int i=0; i<280000; i+=1000) {
438 std::cout << std::setw(12) << std::setprecision(2) << i
439 <<
" " << std::setw(9) << std::setprecision(2) << Temperature - 459.67
440 <<
" " << std::setw(13) << std::setprecision(4) << Pressure
441 <<
" " << std::setw(18) << std::setprecision(8) << Density
458 unsigned int numRows = StdAtmosTemperatureTable.GetNumRows();
461 for (
unsigned int bh=0; bh < numRows-1; bh++)
463 double t0 = StdAtmosTemperatureTable(bh+1,1);
464 double t1 = StdAtmosTemperatureTable(bh+2,1);
465 double h0 = StdAtmosTemperatureTable(bh+1,0);
466 double h1 = StdAtmosTemperatureTable(bh+2,0);
467 LapseRates.push_back((t1 - t0) / (h1 - h0) - TemperatureDeltaGradient);
475 PressureBreakpoints[0] = SLpress;
477 for (
unsigned int b=0; b<PressureBreakpoints.size()-1; b++) {
478 double BaseTemp = StdAtmosTemperatureTable(b+1,1);
479 double BaseAlt = StdAtmosTemperatureTable(b+1,0);
480 double UpperAlt = StdAtmosTemperatureTable(b+2,0);
481 double deltaH = UpperAlt - BaseAlt;
482 double Tmb = BaseTemp
484 + (GradientFadeoutAltitude - BaseAlt)*TemperatureDeltaGradient;
485 if (LapseRates[b] != 0.00) {
486 double Lmb = LapseRates[b];
487 double Exp =
g0 / (Rdry*Lmb);
488 double factor = Tmb/(Tmb + Lmb*deltaH);
489 PressureBreakpoints[b+1] = PressureBreakpoints[b]*pow(factor, Exp);
491 PressureBreakpoints[b+1] = PressureBreakpoints[b]*exp(-
g0*deltaH/(Rdry*Tmb));
500 TemperatureBias = TemperatureDeltaGradient = 0.0;
512 SLpressure = StdSLpressure;
521 StdDensityBreakpoints.clear();
522 for (
unsigned int i = 0; i < StdPressureBreakpoints.size(); i++)
523 StdDensityBreakpoints.push_back(StdPressureBreakpoints[i] / (Rdry * StdAtmosTemperatureTable(i + 1, 1)));
532 for (; b < StdDensityBreakpoints.size() - 2; b++) {
533 if (density >= StdDensityBreakpoints[b + 1])
538 double Tmb = StdAtmosTemperatureTable(b + 1, 1);
539 double Hb = StdAtmosTemperatureTable(b + 1, 0);
540 double Lmb = StdLapseRates[b];
541 double pb = StdDensityBreakpoints[b];
543 double density_altitude = 0.0;
547 double Exp = -1.0 / (1.0 +
g0/(Rdry*Lmb));
548 density_altitude = Hb + (Tmb / Lmb) * (pow(density / pb, Exp) - 1);
550 double Factor = -Rdry*Tmb /
g0;
551 density_altitude = Hb + Factor * log(density / pb);
563 for (; b < StdPressureBreakpoints.size() - 2; b++) {
564 if (pressure >= StdPressureBreakpoints[b + 1])
569 double Tmb = StdAtmosTemperatureTable(b + 1, 1);
570 double Hb = StdAtmosTemperatureTable(b + 1, 0);
571 double Lmb = StdLapseRates[b];
572 double Pb = StdPressureBreakpoints[b];
574 double pressure_altitude = 0.0;
578 double Exp = -Rdry*Lmb /
g0;
579 pressure_altitude = Hb + (Tmb / Lmb) * (pow(pressure / Pb, Exp) - 1);
582 double Factor = -Rdry*Tmb /
g0;
583 pressure_altitude = Hb + Factor * log(pressure / Pb);
594 return a*exp(b*temperature_degC/(c+temperature_degC));
601 if (SaturatedVaporPressure < Pressure) {
602 double VaporPressure = Pressure*VaporMassFraction / (VaporMassFraction+Rdry/Rwater);
603 if (VaporPressure > SaturatedVaporPressure)
604 VaporMassFraction = Rdry * SaturatedVaporPressure / (Rwater * (Pressure - SaturatedVaporPressure));
608 double maxFraction = 1E-6*MaxVaporMassFraction.
GetValue(GeoPotAlt);
610 if ((VaporMassFraction > maxFraction) || (VaporMassFraction < 0.0))
611 VaporMassFraction = maxFraction;
614 Reng = (VaporMassFraction*Rwater + Rdry)/(1.0 + VaporMassFraction);
624 if (dewPoint_R <= minDewPoint) {
625 cerr <<
"The dew point temperature " << dewPoint_R <<
" is lower than "
626 << minDewPoint <<
" R." << endl
627 <<
"Dew point is therefore capped to " << minDewPoint << endl;
628 dewPoint_R = minDewPoint;
635 if (finalizedDewPoint < dewPoint_R) {
636 cerr <<
"Dew point temperature has been capped to " << finalizedDewPoint
645 double dewpoint_degC;
646 double VaporPressure = Pressure*VaporMassFraction / (VaporMassFraction+Rdry/Rwater);
648 if (VaporPressure <= 0.0)
651 double x = log(VaporPressure/
a);
652 dewpoint_degC = c*x / (b - x);
664 if (VaporPressure < 0.0) {
665 cerr <<
"The vapor pressure cannot be negative." << endl
666 <<
"Vapor pressure is set to 0.0" << endl;
668 }
else if (VaporPressure >= Pressure) {
669 cerr <<
"The vapor pressure " << VaporPressure
670 <<
" PSF is higher than the ambient pressure." << endl
671 <<
"Vapor pressure is therefore capped to " << Pressure-1.0 << endl;
672 VaporPressure = Pressure - 1.0;
674 VaporMassFraction = Rdry * VaporPressure / (Rwater * (Pressure - VaporPressure));
682 double VaporPressure = Pressure*VaporMassFraction / (VaporMassFraction+Rdry/Rwater);
697 double VaporPressure = Pressure*VaporMassFraction / (VaporMassFraction+Rdry/Rwater);
698 return 100.0*VaporPressure/SaturatedVaporPressure;
706 cerr <<
"The relative humidity cannot be negative." << endl
707 <<
"Relative humidity is set to 0%" << endl;
709 }
else if (RH > 100.0) {
710 cerr <<
"The relative humidity cannot be higher than 100%." << endl
711 <<
"Relative humidity is set to 100%" << endl;
715 double VaporPressure = 0.01*RH*SaturatedVaporPressure;
723 return VaporMassFraction*1E6;
731 VaporMassFraction = frac*1E-6;
734 if (fabs(VaporMassFraction*1E6-frac)>1E-2) {
735 cerr <<
"The vapor mass fraction " << frac <<
" has been capped to "
736 << VaporMassFraction*1E6 <<
"PPM." << endl;
742void FGStandardAtmosphere::bind(
void)
746 PropertyManager->Tie(
"atmosphere/delta-T",
this, eRankine,
749 PropertyManager->Tie(
"atmosphere/SL-graded-delta-T",
this, eRankine,
752 PropertyManager->Tie(
"atmosphere/P-sl-psf",
this, ePSF,
753 (PMFi)&FGStandardAtmosphere::GetPressureSL,
755 PropertyManager->Tie(
"atmosphere/dew-point-R",
this, eRankine,
758 PropertyManager->Tie(
"atmosphere/vapor-pressure-psf",
this, ePSF,
761 PropertyManager->Tie(
"atmosphere/saturated-vapor-pressure-psf",
this, ePSF,
763 PropertyManager->Tie(
"atmosphere/RH",
this,
766 PropertyManager->Tie(
"atmosphere/vapor-fraction-ppm",
this,
790void FGStandardAtmosphere::Debug(
int from)
792 if (debug_lvl <= 0)
return;
798 if (debug_lvl & 2 ) {
799 if (from == 0) std::cout <<
"Instantiated: FGStandardAtmosphere" << std::endl;
800 if (from == 1) std::cout <<
"Destroyed: FGStandardAtmosphere" << std::endl;
802 if (debug_lvl & 4 ) {
804 if (debug_lvl & 8 ) {
806 if (debug_lvl & 16) {
808 if (debug_lvl & 128) {
810 if (debug_lvl & 64) {
Models an empty, abstract base atmosphere class.
double ConvertToRankine(double t, eTemperature unit) const
Converts to Rankine from one of several unit systems.
virtual void Calculate(double altitude)
Calculate the atmosphere for the given altitude.
double ConvertFromPSF(double t, ePressure unit=ePSF) const
Converts from PSF (pounds per square foot) to one of several unit systems.
virtual double GetPressure(void) const
Returns the pressure in psf.
eTemperature
Enums for specifying temperature units.
double ConvertFromRankine(double t, eTemperature unit) const
Converts from Rankine to one of several unit systems.
double ValidatePressure(double p, const std::string &msg, bool quiet=false) const
Check that the pressure is within plausible boundaries.
bool Run(bool Holding) override
Runs the atmosphere forces model; called by the Executive.
double ConvertToPSF(double t, ePressure unit=ePSF) const
Converts to PSF (pounds per square foot) from one of several unit systems.
ePressure
Enums for specifying pressure units.
static constexpr double g0
Sea-level acceleration of gravity - ft/s^2.
virtual double GetTemperature() const
Returns the actual, modeled temperature at the current altitude in degrees Rankine.
Encapsulates the JSBSim simulation executive.
static constexpr double CelsiusToRankine(double celsius)
Converts from degrees Celsius to degrees Rankine.
static constexpr double RankineToCelsius(double rankine)
Converts from degrees Rankine to degrees Celsius.
static constexpr double KelvinToRankine(double kelvin)
Converts from degrees Kelvin to degrees Rankine.
void CalculateStdDensityBreakpoints()
Calculate the atmospheric density breakpoints at the altitudes in the standard temperature table.
double GeometricAltitude(double geopotalt) const
Convert a geopotential altitude to a geometric altitude.
void SetVaporPressure(ePressure unit, double Pv)
Sets the partial pressure of water vapor.
virtual double GetStdPressure(double altitude) const
Returns the standard pressure at the specified altitude.
static constexpr double a
Sonntag constants based on ref [2].
double CalculateDensityAltitude(double density, double geometricAlt) override
Calculates the density altitude given any temperature or pressure bias.
double GetRelativeHumidity(void) const
Returns the relative humidity in percent.
void CalculateLapseRates()
Recalculate the lapse rate vectors when the temperature profile is altered in a way that would change...
virtual double GetTemperatureDeltaGradient(eTemperature to)
Returns the temperature gradient to be applied on top of the standard temperature gradient.
void SetRelativeHumidity(double RH)
Sets the relative humidity.
virtual double GetTemperatureBias(eTemperature to) const
Returns the temperature bias over the sea level value in degrees Rankine.
virtual double GetStdTemperature(double altitude) const
Returns the standard temperature in degrees Rankine at a specified altitude.
void Calculate(double altitude) override
Calculate the atmosphere for the given altitude.
void SetTemperature(double t, double h, eTemperature unit=eFahrenheit) override
Sets the temperature at the supplied altitude, if it is to be different than the standard temperature...
void CalculatePressureBreakpoints(double SLpress)
Calculate (or recalculate) the atmospheric pressure breakpoints at the altitudes in the standard temp...
virtual void SetTemperatureGradedDelta(double t, double h, eTemperature unit=eFahrenheit)
Sets the temperature delta value at the supplied altitude/elevation above sea level,...
void CalculateSLDensity(void)
Calculate the SL density.
virtual void ResetSLPressure()
Resets the sea level to the Standard sea level pressure, and recalculates dependent parameters so tha...
double GetVaporPressure(ePressure to) const
Returns the partial pressure of water vapor.
double GeopotentialAltitude(double geometalt) const
Convert a geometric altitude to a geopotential altitude.
virtual void PrintStandardAtmosphereTable()
Prints the U.S. Standard Atmosphere table.
virtual double GetStdDensity(double altitude) const
Returns the standard density at a specified altitude.
FGStandardAtmosphere(FGFDMExec *)
Constructor.
virtual void SetTemperatureBias(eTemperature unit, double t)
Sets the temperature bias to be added to the standard temperature at all altitudes.
double GetSaturatedVaporPressure(ePressure to) const
Returns the saturated pressure of water vapor.
double StdSLtemperature
Standard sea level conditions.
virtual ~FGStandardAtmosphere()
Destructor.
void SetPressureSL(ePressure unit, double pressure) override
Sets the sea level pressure for modeling an off-standard pressure profile.
void SetTemperatureSL(double t, eTemperature unit=eFahrenheit) override
Sets the Sea Level temperature, if it is to be different than the standard.
double CalculateVaporPressure(double temperature)
Calculate the pressure of water vapor with the Magnus formula.
void CalculateSLSoundSpeedAndDensity(void)
Calculate the SL density and sound speed.
virtual void SetSLTemperatureGradedDelta(eTemperature unit, double t)
Sets a Sea Level temperature delta that is ramped out by 86 km.
void SetVaporMassFractionPPM(double frac)
Sets the vapor mass per million of dry air mass units.
void SetDewPoint(eTemperature unit, double dewpoint)
Sets the dew point.
void ValidateVaporMassFraction(double geometricAlt)
Validate the value of the vapor mass fraction.
virtual void ResetSLTemperature()
This function resets the model to apply no bias or delta gradient to the temperature.
double GetVaporMassFractionPPM(void) const
Returns the vapor mass per million of dry air mass units (ppm).
double CalculatePressureAltitude(double pressure, double geometricAlt) override
Calculates the pressure altitude given any temperature or pressure bias.
double GetDewPoint(eTemperature to) const
Returns the dew point.
double GetValue(void) const
Get the current table value.