]> git.mxchange.org Git - flightgear.git/blobdiff - src/Environment/environment_ctrl.cxx
Merge branch 'next' into durk-atc
[flightgear.git] / src / Environment / environment_ctrl.cxx
index aa777d288b2c5c7e496c9e2710bbe250bc22bd74..c182f06250cf250e62993e3b77f726c02e9b3992 100644 (file)
@@ -1,6 +1,7 @@
 // environment_ctrl.cxx -- manager for natural environment information.
 //
 // Written by David Megginson, started February 2002.
+// Partly rewritten by Torsten Dreyer, August 2010.
 //
 // Copyright (C) 2002  David Megginson - david@megginson.com
 //
 // along with this program; if not, write to the Free Software
 // Foundation, Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301, USA.
 //
-// $Id$
 
 #ifdef HAVE_CONFIG_H
 #  include "config.h"
 #endif
 
-#include <stdlib.h>
-#include <math.h>
 #include <algorithm>
 
-#include <simgear/debug/logstream.hxx>
-#include <simgear/structure/commands.hxx>
-#include <simgear/structure/exception.hxx>
-
-#include <Airports/simple.hxx>
 #include <Main/fg_props.hxx>
-#include <Main/util.hxx>
-
-#include "environment_mgr.hxx"
 #include "environment_ctrl.hxx"
-
-SG_USING_STD(sort);
-
-
-\f
-////////////////////////////////////////////////////////////////////////
-// Implementation of FGEnvironmentCtrl abstract base class.
-////////////////////////////////////////////////////////////////////////
-
-FGEnvironmentCtrl::FGEnvironmentCtrl ()
-  : _environment(0),
-    _lon_deg(0),
-    _lat_deg(0),
-    _elev_ft(0)
-{
-}
-
-FGEnvironmentCtrl::~FGEnvironmentCtrl ()
-{
-}
-
-void
-FGEnvironmentCtrl::setEnvironment (FGEnvironment * environment)
-{
-  _environment = environment;
-}
-
-void
-FGEnvironmentCtrl::setLongitudeDeg (double lon_deg)
-{
-  _lon_deg = lon_deg;
-}
-
-void
-FGEnvironmentCtrl::setLatitudeDeg (double lat_deg)
-{
-  _lat_deg = lat_deg;
-}
-
-void
-FGEnvironmentCtrl::setElevationFt (double elev_ft)
-{
-  _elev_ft = elev_ft;
-}
-
-void
-FGEnvironmentCtrl::setPosition (double lon_deg, double lat_deg, double elev_ft)
-{
-  _lon_deg = lon_deg;
-  _lat_deg = lat_deg;
-  _elev_ft = elev_ft;
-}
-
-
-\f
-////////////////////////////////////////////////////////////////////////
-// Implementation of FGUserDefEnvironmentCtrl.
-////////////////////////////////////////////////////////////////////////
-
-FGUserDefEnvironmentCtrl::FGUserDefEnvironmentCtrl ()
-  : _base_wind_speed_node(0),
-    _gust_wind_speed_node(0),
-    _current_wind_speed_kt(0),
-    _delta_wind_speed_kt(0)
-{
-}
-
-FGUserDefEnvironmentCtrl::~FGUserDefEnvironmentCtrl ()
-{
-}
-
-void
-FGUserDefEnvironmentCtrl::init ()
-{
-                               // Fill in some defaults.
-  if (!fgHasNode("/environment/params/base-wind-speed-kt"))
-    fgSetDouble("/environment/params/base-wind-speed-kt",
-               fgGetDouble("/environment/wind-speed-kt"));
-  if (!fgHasNode("/environment/params/gust-wind-speed-kt"))
-    fgSetDouble("/environment/params/gust-wind-speed-kt",
-               fgGetDouble("/environment/params/base-wind-speed-kt"));
-
-  _base_wind_speed_node =
-    fgGetNode("/environment/params/base-wind-speed-kt", true);
-  _gust_wind_speed_node =
-    fgGetNode("/environment/params/gust-wind-speed-kt", true);
-
-  _current_wind_speed_kt = _base_wind_speed_node->getDoubleValue();
-  _delta_wind_speed_kt = 0.1;
-}
-
-void
-FGUserDefEnvironmentCtrl::update (double dt)
-{
-  double base_wind_speed = _base_wind_speed_node->getDoubleValue();
-  double gust_wind_speed = _gust_wind_speed_node->getDoubleValue();
-
-  if (gust_wind_speed < base_wind_speed) {
-      gust_wind_speed = base_wind_speed;
-      _gust_wind_speed_node->setDoubleValue(gust_wind_speed);
-  }
-
-  if (base_wind_speed == gust_wind_speed) {
-    _current_wind_speed_kt = base_wind_speed;
-  } else {
-    int rn = rand() % 128;
-    int sign = (_delta_wind_speed_kt < 0 ? -1 : 1);
-    double gust = _current_wind_speed_kt - base_wind_speed;
-    double incr = gust / 50;
-
-    if (rn == 0)
-      _delta_wind_speed_kt = - _delta_wind_speed_kt;
-    else if (rn < 4)
-      _delta_wind_speed_kt -= incr * sign;
-    else if (rn < 16)
-      _delta_wind_speed_kt += incr * sign;
-
-    _current_wind_speed_kt += _delta_wind_speed_kt;
-
-    if (_current_wind_speed_kt < base_wind_speed) {
-      _current_wind_speed_kt = base_wind_speed;
-      _delta_wind_speed_kt = 0.01;
-    } else if (_current_wind_speed_kt > gust_wind_speed) {
-      _current_wind_speed_kt = gust_wind_speed;
-      _delta_wind_speed_kt = -0.01;
+#include "environment.hxx"
+
+namespace Environment {
+
+/**
+ * @brief Describes an element of a LayerTable. A defined environment at a given altitude.
+*/
+struct LayerTableBucket {
+    double altitude_ft;
+    FGEnvironment environment;
+    inline bool operator< (const LayerTableBucket &b) const {
+        return (altitude_ft < b.altitude_ft);
     }
-  }
-  
-  if (_environment != 0)
-    _environment->set_wind_speed_kt(_current_wind_speed_kt);
-}
-
-
-\f
-////////////////////////////////////////////////////////////////////////
-// Implementation of FGInterpolateEnvironmentCtrl.
-////////////////////////////////////////////////////////////////////////
-
-FGInterpolateEnvironmentCtrl::FGInterpolateEnvironmentCtrl ()
-{
-}
-
-FGInterpolateEnvironmentCtrl::~FGInterpolateEnvironmentCtrl ()
-{
-    unsigned int i;
-    for (i = 0; i < _boundary_table.size(); i++)
-        delete _boundary_table[i];
-    for (i = 0; i < _aloft_table.size(); i++)
-        delete _aloft_table[i];
-}
-
-
-
-void
-FGInterpolateEnvironmentCtrl::init ()
-{
-    read_table(fgGetNode("/environment/config/boundary", true),
-               _boundary_table);
-    read_table(fgGetNode("/environment/config/aloft", true),
-               _aloft_table);
-}
-
-void
-FGInterpolateEnvironmentCtrl::reinit ()
-{
-    unsigned int i;
-    for (i = 0; i < _boundary_table.size(); i++)
-        delete _boundary_table[i];
-    for (i = 0; i < _aloft_table.size(); i++)
-        delete _aloft_table[i];
-    _boundary_table.clear();
-    _aloft_table.clear();
-    init();
-}
-
-void
-FGInterpolateEnvironmentCtrl::read_table (const SGPropertyNode * node,
-                                          vector<bucket *> &table)
-{
-    for (int i = 0; i < node->nChildren(); i++) {
-        const SGPropertyNode * child = node->getChild(i);
-        if ( strcmp(child->getName(), "entry") == 0
-            && child->getStringValue("elevation-ft", "")[0] != '\0'
-            && ( child->getDoubleValue("elevation-ft") > 0.1 || i == 0 ) )
-       {
-            bucket * b = new bucket;
+    /** 
+    * @brief LessThan predicate for bucket pointers.
+    */
+    static bool lessThan(LayerTableBucket *a, LayerTableBucket *b) {
+        return (a->altitude_ft) < (b->altitude_ft);
+    }
+};
+
+//////////////////////////////////////////////////////////////////////////////
+
+/**
+ * @brief Models a column of our atmosphere by stacking a number of environments above
+ *        each other
+ */
+class LayerTable : public std::vector<LayerTableBucket *>, public SGPropertyChangeListener
+{
+public:
+    LayerTable( SGPropertyNode_ptr rootNode ) :
+      _rootNode(rootNode) {}
+
+    ~LayerTable();
+
+    /**
+     * @brief Read the environment column from properties relative to the given root node
+     * @param environment A template environment to copy values from, not given in the configuration
+     */
+    void read( FGEnvironment * parent = NULL );
+
+    /**
+     *@brief Interpolate and write environment values for a given altitude
+     *@param altitude_ft The altitude for the desired environment
+     *@environment the destination to write the resulting environment properties to
+     */
+    void interpolate(double altitude_ft, FGEnvironment * environment);
+
+    /**
+     *@brief Bind all environments properties to property nodes and initialize the listeners
+     */
+    void Bind();
+
+    /**
+     *@brief Unbind all environments properties from property nodes and deregister listeners
+     */
+    void Unbind();
+private:
+    /**
+     * @brief Implementation of SGProertyChangeListener::valueChanged()
+     *        Takes care of consitent sea level pressure for the entire column
+     */
+    void valueChanged( SGPropertyNode * node );
+    SGPropertyNode_ptr _rootNode;
+};
+
+//////////////////////////////////////////////////////////////////////////////
+
+
+/**
+ *@brief Implementation of the LayerIterpolateController
+ */
+class LayerInterpolateControllerImplementation : public LayerInterpolateController
+{
+public:
+    LayerInterpolateControllerImplementation( SGPropertyNode_ptr rootNode );
+    
+    virtual void init ();
+    virtual void reinit ();
+    virtual void postinit();
+    virtual void bind();
+    virtual void unbind();
+    virtual void update (double delta_time_sec);
+
+private:
+    SGPropertyNode_ptr _rootNode;
+    bool _enabled;
+    double _boundary_transition;
+    SGPropertyNode_ptr _altitude_n;
+    SGPropertyNode_ptr _altitude_agl_n;
+
+    LayerTable _boundary_table;
+    LayerTable _aloft_table;
+
+    FGEnvironment _environment;
+    simgear::TiedPropertyList _tiedProperties;
+};
+
+//////////////////////////////////////////////////////////////////////////////
+
+LayerTable::~LayerTable() 
+{
+    for( iterator it = begin(); it != end(); it++ )
+        delete (*it);
+}
+
+void LayerTable::read(FGEnvironment * parent )
+{
+    double last_altitude_ft = 0.0;
+    double sort_required = false;
+    size_t i;
+
+    for (i = 0; i < (size_t)_rootNode->nChildren(); i++) {
+        const SGPropertyNode * child = _rootNode->getChild(i);
+        if ( child->getNameString() == "entry"
+         && child->getStringValue("elevation-ft", "")[0] != '\0'
+         && ( child->getDoubleValue("elevation-ft") > 0.1 || i == 0 ) )
+    {
+            LayerTableBucket * b;
+            if( i < size() ) {
+                // recycle existing bucket
+                b = at(i);
+            } else {
+                // more nodes than buckets in table, add a new one
+                b = new LayerTableBucket;
+                push_back(b);
+            }
+            if (i == 0 && parent != NULL )
+                b->environment = *parent;
             if (i > 0)
-                b->environment.copy(table[i-1]->environment);
+                b->environment = at(i-1)->environment;
+            
             b->environment.read(child);
             b->altitude_ft = b->environment.get_elevation_ft();
-            table.push_back(b);
-        }
-    }
-    sort(table.begin(), table.end());
-}
-
-void
-FGInterpolateEnvironmentCtrl::update (double delta_time_sec)
-{
-                                // FIXME
-    double altitude_ft = fgGetDouble("/position/altitude-ft");
-    double altitude_agl_ft = fgGetDouble("/position/altitude-agl-ft");
-    double boundary_transition =
-        fgGetDouble("/environment/config/boundary-transition-ft", 500);
 
-    // double ground_elevation_ft = altitude_ft - altitude_agl_ft;
-
-    int length = _boundary_table.size();
-
-    if (length > 0) {
-                                // boundary table
-        double boundary_limit = _boundary_table[length-1]->altitude_ft;
-        if (boundary_limit >= altitude_agl_ft) {
-            do_interpolate(_boundary_table, altitude_agl_ft,
-                           _environment);
-            return;
-        } else if ((boundary_limit + boundary_transition) >= altitude_agl_ft) {
-                                // both tables
-            do_interpolate(_boundary_table, altitude_agl_ft, &env1);
-            do_interpolate(_aloft_table, altitude_ft, &env2);
-            double fraction =
-                (altitude_agl_ft - boundary_limit) / boundary_transition;
-            interpolate(&env1, &env2, fraction, _environment);
-            return;
+            // check, if altitudes are in ascending order
+            if( b->altitude_ft < last_altitude_ft )
+                sort_required = true;
+            last_altitude_ft = b->altitude_ft;
         }
     }
+    // remove leftover buckets
+    while( size() > i ) {
+        LayerTableBucket * b = *(end() - 1);
+        delete b;
+        pop_back();
+    }
 
-                                // aloft table
-    do_interpolate(_aloft_table, altitude_ft, _environment);
-}
-
-void
-FGInterpolateEnvironmentCtrl::do_interpolate (vector<bucket *> &table,
-                                              double altitude_ft,
-                                              FGEnvironment * environment)
-{
-    int length = table.size();
-    if (length == 0)
-        return;
+    if( sort_required )
+        sort(begin(), end(), LayerTableBucket::lessThan);
 
-                                // Boundary conditions
-    if ((length == 1) || (table[0]->altitude_ft >= altitude_ft)) {
-        environment->copy(table[0]->environment);
-        return;
-    } else if (table[length-1]->altitude_ft <= altitude_ft) {
-        environment->copy(table[length-1]->environment);
-        return;
-    }
-        
-                                // Search the interpolation table
-    for (int i = 0; i < length - 1; i++) {
-        if ((i == length - 1) || (table[i]->altitude_ft <= altitude_ft)) {
-                FGEnvironment * env1 = &(table[i]->environment);
-                FGEnvironment * env2 = &(table[i+1]->environment);
-                double fraction;
-                if (table[i]->altitude_ft == table[i+1]->altitude_ft)
-                    fraction = 1.0;
-                else
-                    fraction =
-                        ((altitude_ft - table[i]->altitude_ft) /
-                         (table[i+1]->altitude_ft - table[i]->altitude_ft));
-                interpolate(env1, env2, fraction, environment);
-
-                return;
+    // cleanup entries with (almost)same altitude
+    for( size_type n = 1; n < size(); n++ ) {
+        if( fabs(at(n)->altitude_ft - at(n-1)->altitude_ft ) < 1 ) {
+            SG_LOG( SG_GENERAL, SG_ALERT, "Removing duplicate altitude entry in environment config for altitude " << at(n)->altitude_ft );
+            erase( begin() + n );
         }
     }
 }
 
-bool
-FGInterpolateEnvironmentCtrl::bucket::operator< (const bucket &b) const
+void LayerTable::Bind()
 {
-    return (altitude_ft < b.altitude_ft);
+    // tie all environments to ~/entry[n]/xxx
+    // register this as a changelistener of ~/entry[n]/pressure-sea-level-inhg
+    for( unsigned i = 0; i < size(); i++ ) {
+        SGPropertyNode_ptr baseNode = _rootNode->getChild("entry", i, true );
+        at(i)->environment.Tie( baseNode );
+        baseNode->getNode( "pressure-sea-level-inhg", true )->addChangeListener( this );
+    }
 }
 
-
-\f
-////////////////////////////////////////////////////////////////////////
-// Implementation of FGMetarEnvironmentCtrl.
-////////////////////////////////////////////////////////////////////////
-
-FGMetarEnvironmentCtrl::FGMetarEnvironmentCtrl ()
-    : env( new FGInterpolateEnvironmentCtrl ),
-      _icao( "" ),
-      metar_loaded( false ),
-      search_interval_sec( 60.0 ),        // 1 minute
-      same_station_interval_sec( 900.0 ), // 15 minutes
-      search_elapsed( 9999.0 ),
-      fetch_elapsed( 9999.0 ),
-      last_apt( 0 ),
-      proxy_host( fgGetNode("/sim/presets/proxy/host", true) ),
-      proxy_port( fgGetNode("/sim/presets/proxy/port", true) ),
-      proxy_auth( fgGetNode("/sim/presets/proxy/authentication", true) ),
-      metar_max_age( fgGetNode("/environment/params/metar-max-age-min", true) ),
-
-      // Interpolation constant definitions.
-      EnvironmentUpdatePeriodSec( 0.2 ),
-      MaxWindChangeKtsSec( 0.2 ),
-      MaxVisChangePercentSec( 0.05 ),
-      MaxPressureChangeInHgSec( 0.0033 ),
-      MaxCloudAltitudeChangeFtSec( 20.0 ),
-      MaxCloudThicknessChangeFtSec( 50.0 ),
-      MaxCloudInterpolationHeightFt( 5000.0 ),
-
-      _error_count( 0 ),
-      _stale_count( 0 ),
-      _dt( 0.0 ),
-      _error_dt( 0.0 )
+void LayerTable::Unbind()
 {
-#if defined(ENABLE_THREADS)
-    thread = new MetarThread(this);
-    thread->start( 1 );
-#endif // ENABLE_THREADS
+    // untie all environments to ~/entry[n]/xxx
+    // deregister this as a changelistener of ~/entry[n]/pressure-sea-level-inhg
+    for( unsigned i = 0; i < size(); i++ ) {
+        SGPropertyNode_ptr baseNode = _rootNode->getChild("entry", i, true );
+        at(i)->environment.Untie();
+        baseNode->getNode( "pressure-sea-level-inhg", true )->removeChangeListener( this );
+    }
 }
 
-FGMetarEnvironmentCtrl::~FGMetarEnvironmentCtrl ()
+void LayerTable::valueChanged( SGPropertyNode * node ) 
 {
-#if defined(ENABLE_THREADS)
-   thread_stop();
-#endif // ENABLE_THREADS
-
-   delete env;
-   env = NULL;
+    // Make sure all environments in our column use the same sea level pressure
+    double value = node->getDoubleValue();
+    for( iterator it = begin(); it != end(); it++ )
+        (*it)->environment.set_pressure_sea_level_inhg( value );
 }
 
 
-// use a "command" to set station temp at station elevation
-static void set_temp_at_altitude( float temp_degc, float altitude_ft ) {
-    SGPropertyNode args;
-    SGPropertyNode *node = args.getNode("temp-degc", 0, true);
-    node->setFloatValue( temp_degc );
-    node = args.getNode("altitude-ft", 0, true);
-    node->setFloatValue( altitude_ft );
-    globals->get_commands()->execute("set-outside-air-temp-degc", &args);
-}
-
-
-static void set_dewpoint_at_altitude( float dewpoint_degc, float altitude_ft ) {
-    SGPropertyNode args;
-    SGPropertyNode *node = args.getNode("dewpoint-degc", 0, true);
-    node->setFloatValue( dewpoint_degc );
-    node = args.getNode("altitude-ft", 0, true);
-    node->setFloatValue( altitude_ft );
-    globals->get_commands()->execute("set-dewpoint-temp-degc", &args);
-}
-
-
-void
-FGMetarEnvironmentCtrl::update_env_config ()
+void LayerTable::interpolate( double altitude_ft, FGEnvironment * result )
 {
-    double dir_from;
-    double dir_to;
-    double speed;
-    double gust;
-    double vis;
-    double pressure;
-    double temp;
-    double dewpoint;
-
-    if (metar_loaded) {
-        // Generate interpolated values between the METAR and the current
-        // configuration.
-
-        // Pick up the METAR wind values and convert them into a vector.
-        double metar[2];
-        double metar_speed = fgGetDouble("/environment/metar/base-wind-speed-kt");
-        double metar_heading = fgGetDouble("/environment/metar/base-wind-range-from");
-
-        metar[0] = metar_speed * sin((metar_heading / 180.0) * M_PI);
-        metar[1] = metar_speed * cos((metar_heading / 180.0) * M_PI);
-
-        // Convert the current wind values and convert them into a vector
-        double current[2];
-        double current_speed =
-                fgGetDouble("/environment/config/boundary/entry/wind-speed-kt");
-        double current_heading = fgGetDouble(
-                "/environment/config/boundary/entry/wind-from-heading-deg");
-
-        current[0] = current_speed * sin((current_heading / 180.0) * M_PI);
-        current[1] = current_speed * cos((current_heading / 180.0) * M_PI);
-
-        // Determine the maximum component-wise value that the wind can change.
-        // First we determine the fraction in the X and Y component, then
-        // factor by the maximum wind change.
-        double x = fabs(current[0] - metar[0]);
-        double y = fabs(current[1] - metar[1]);
-        double dx = x / (x + y);
-        double dy = 1 - dx;
-
-        double maxdx = dx * MaxWindChangeKtsSec;
-        double maxdy = dy * MaxWindChangeKtsSec;
-
-        // Interpolate each component separately.
-        current[0] = interpolate_val(current[0], metar[0], maxdx);
-        current[1] = interpolate_val(current[1], metar[1], maxdy);
-
-        // Now convert back to polar coordinates.
-        if ((current[0] == 0.0) && (current[1] == 0.0)) {
-            // Special case where there is no wind (otherwise atan2 barfs)
-            speed = 0.0;
-            dir_from = current_heading;
-
-        } else {
-            // Some real wind to convert back from. Work out the speed
-            // and direction value in degrees.
-            speed = sqrt((current[0] * current[0]) + (current[1] * current[1]));
-            dir_from = (atan2(current[0], current[1]) * 180.0 / M_PI);
-
-            // Normalize the direction.
-            if (dir_from < 0.0)
-                dir_from += 360.0;
-
-            SG_LOG( SG_GENERAL, SG_DEBUG, "Wind : " << dir_from << "@" << speed);
-        }
-
-        // Now handle the visibility. We convert both visibility values
-        // to X-values, then interpolate from there, then back to real values.
-        // The length_scale is fixed to 1000m, so the visibility changes by
-        // by MaxVisChangePercentSec or 1000m X MaxVisChangePercentSec,
-        // whichever is more.
-        double currentvis =
-                fgGetDouble("/environment/config/boundary/entry/visibility-m");
-        double metarvis = fgGetDouble("/environment/metar/min-visibility-m");
-        double currentxval = log(1000.0 + currentvis);
-        double metarxval = log(1000.0 + metarvis);
-
-        currentxval = interpolate_val(currentxval, metarxval, MaxVisChangePercentSec);
-
-        // Now convert back from an X-value to a straightforward visibility.
-        vis = exp(currentxval) - 1000.0;
-
-        pressure = interpolate_prop(
-                "/environment/config/boundary/entry/pressure-sea-level-inhg",
-                "/environment/metar/pressure-inhg",
-                MaxPressureChangeInHgSec);
-
-        dir_to   = fgGetDouble("/environment/metar/base-wind-range-to");
-        gust     = fgGetDouble("/environment/metar/gust-wind-speed-kt");
-        temp     = fgGetDouble("/environment/metar/temperature-degc");
-        dewpoint = fgGetDouble("/environment/metar/dewpoint-degc");
-
-        // Set the cloud layers by interpolating over the METAR versions.
-        SGPropertyNode * clouds = fgGetNode("/environment/metar/clouds");
-
-        vector<SGPropertyNode_ptr> layers = clouds->getChildren("layer");
-        vector<SGPropertyNode_ptr>::const_iterator layer;
-        vector<SGPropertyNode_ptr>::const_iterator layers_end = layers.end();
-
-        const char *cl = "/environment/clouds/layer[%i]";
-        double aircraft_alt = fgGetDouble("/position/altitude-ft");
-        char s[128];
-        int i;
-
-        for (i = 0, layer = layers.begin(); layer != layers_end; ++layer, i++) {
-            double currentval;
-            double requiredval;
-
-            // In the case of clouds, we want to avoid writing if nothing has
-            // changed, as these properties are tied to the renderer and will
-            // cause the clouds to be updated, reseting the texture locations.
-
-            // We don't interpolate the coverage values as no-matter how we
-            // do it, it will be quite a sudden change of texture. Better to
-            // have a single change than four or five.
-            snprintf(s, 128, cl, i);
-            strncat(s, "/coverage", 128);
-            const char* coverage = (*layer)->getStringValue("coverage", "clear");
-            if (strncmp(fgGetString(s), coverage, 128) != 0)
-                fgSetString(s, coverage);
-
-            snprintf(s, 128, cl, i);
-            strncat(s, "/elevation-ft", 128);
-            double current_alt = fgGetDouble(s);
-            double required_alt = (*layer)->getDoubleValue("elevation-ft");
-
-            if (current_alt < -9000 || required_alt < -9000
-                    || fabs(aircraft_alt - required_alt) > MaxCloudInterpolationHeightFt) {
-                // We don't interpolate any values that are too high above us,
-                // or too far below us to be visible. Nor do we interpolate
-                // values to or from -9999, which is used as a placeholder
-                // when there isn't actually a cloud layer present.
-                snprintf(s, 128, cl, i);
-                strncat(s, "/elevation-ft", 128);
-                if (current_alt != required_alt)
-                    fgSetDouble(s, required_alt);
-
-                snprintf(s, 128, cl, i);
-                strncat(s, "/thickness-ft", 128);
-                if (fgGetDouble(s) != (*layer)->getDoubleValue("thickness-ft"))
-                    fgSetDouble(s, (*layer)->getDoubleValue("thickness-ft"));
-
-            } else {
-                // Interpolate the other values in the usual way
-                if (current_alt != required_alt) {
-                    current_alt = interpolate_val(current_alt,
-                                                  required_alt,
-                                                  MaxCloudAltitudeChangeFtSec);
-                    fgSetDouble(s, current_alt);
-                }
-
-                snprintf(s, 128, cl, i);
-                strncat(s, "/thickness-ft", 128);
-                currentval = fgGetDouble(s);
-                requiredval = (*layer)->getDoubleValue("thickness-ft");
-
-                if (currentval != requiredval) {
-                    currentval = interpolate_val(currentval,
-                                                 requiredval,
-                                                 MaxCloudThicknessChangeFtSec);
-                    fgSetDouble(s, currentval);
-                }
-            }
-        }
-
-    } else {
-        // We haven't already loaded a METAR, so apply it immediately.
-        dir_from = fgGetDouble("/environment/metar/base-wind-range-from");
-        dir_to   = fgGetDouble("/environment/metar/base-wind-range-to");
-        speed    = fgGetDouble("/environment/metar/base-wind-speed-kt");
-        gust     = fgGetDouble("/environment/metar/gust-wind-speed-kt");
-        vis      = fgGetDouble("/environment/metar/min-visibility-m");
-        pressure = fgGetDouble("/environment/metar/pressure-inhg");
-        temp     = fgGetDouble("/environment/metar/temperature-degc");
-        dewpoint = fgGetDouble("/environment/metar/dewpoint-degc");
-
-        // Set the cloud layers by copying over the METAR versions.
-        SGPropertyNode * clouds = fgGetNode("/environment/metar/clouds");
-
-        vector<SGPropertyNode_ptr> layers = clouds->getChildren("layer");
-        vector<SGPropertyNode_ptr>::const_iterator layer;
-        vector<SGPropertyNode_ptr>::const_iterator layers_end = layers.end();
-
-        const char *cl = "/environment/clouds/layer[%i]";
-        char s[128];
-        int i;
-
-        for (i = 0, layer = layers.begin(); layer != layers_end; ++layer, i++) {
-            snprintf(s, 128, cl, i);
-            strncat(s, "/coverage", 128);
-            fgSetString(s, (*layer)->getStringValue("coverage", "clear"));
-
-            snprintf(s, 128, cl, i);
-            strncat(s, "/elevation-ft", 128);
-            fgSetDouble(s, (*layer)->getDoubleValue("elevation-ft"));
-
-            snprintf(s, 128, cl, i);
-            strncat(s, "/thickness-ft", 128);
-            fgSetDouble(s, (*layer)->getDoubleValue("thickness-ft"));
-
-            snprintf(s, 128, cl, i);
-            strncat(s, "/span-m", 128);
-            fgSetDouble(s, 40000.0);
-        }
-    }
+    int length = size();
+    if (length == 0)
+        return;
 
-    fgSetupWind(dir_from, dir_to, speed, gust);
-    fgDefaultWeatherValue("visibility-m", vis);
-    set_temp_at_altitude(temp, station_elevation_ft);
-    set_dewpoint_at_altitude(dewpoint, station_elevation_ft);
-    fgDefaultWeatherValue("pressure-sea-level-inhg", pressure);
+    // Boundary conditions
+    if ((length == 1) || (at(0)->altitude_ft >= altitude_ft)) {
+        *result = at(0)->environment; // below bottom of table
+        return;
+    } else if (at(length-1)->altitude_ft <= altitude_ft) {
+        *result = at(length-1)->environment; // above top of table
+        return;
+    } 
 
-    // We've now successfully loaded a METAR into the configuration
-    metar_loaded = true;
+    // Search the interpolation table
+    int layer;
+    for ( layer = 1; // can't be below bottom layer, handled above
+          layer < length && at(layer)->altitude_ft <= altitude_ft;
+          layer++);
+    FGEnvironment & env1 = (at(layer-1)->environment);
+    FGEnvironment & env2 = (at(layer)->environment);
+    // two layers of same altitude were sorted out in read_table
+    double fraction = ((altitude_ft - at(layer-1)->altitude_ft) /
+                      (at(layer)->altitude_ft - at(layer-1)->altitude_ft));
+    env1.interpolate(env2, fraction, result);
 }
 
-double FGMetarEnvironmentCtrl::interpolate_prop(const char * currentname,
-                                                const char * requiredname,
-                                                double dt)
-{
-    double currentval = fgGetDouble(currentname);
-    double requiredval = fgGetDouble(requiredname);
-    return interpolate_val(currentval, requiredval, dt);
-}
+//////////////////////////////////////////////////////////////////////////////
 
-double FGMetarEnvironmentCtrl::interpolate_val(double currentval,
-                                               double requiredval,
-                                               double dt)
+LayerInterpolateControllerImplementation::LayerInterpolateControllerImplementation( SGPropertyNode_ptr rootNode ) :
+  _rootNode( rootNode ),
+  _enabled(true),
+  _boundary_transition(0.0),
+  _altitude_n( fgGetNode("/position/altitude-ft", true)),
+  _altitude_agl_n( fgGetNode("/position/altitude-agl-ft", true)),
+  _boundary_table( rootNode->getNode("boundary", true ) ),
+  _aloft_table( rootNode->getNode("aloft", true ) )
 {
-    double dval = EnvironmentUpdatePeriodSec * dt;
-
-    if (fabs(currentval - requiredval) < dval) return requiredval;
-    if (currentval < requiredval) return (currentval + dval);
-    if (currentval > requiredval) return (currentval - dval);
-    return requiredval;
 }
 
-void
-FGMetarEnvironmentCtrl::init ()
+void LayerInterpolateControllerImplementation::init ()
 {
-    const SGPropertyNode *longitude
-        = fgGetNode( "/position/longitude-deg", true );
-    const SGPropertyNode *latitude
-        = fgGetNode( "/position/latitude-deg", true );
-
-    metar_loaded = false;
-    bool found_metar = false;
-    long max_age = metar_max_age->getLongValue();
-    // Don't check max age during init so that we don't loop over a lot
-    // of airports metar if there is a problem.
-    // The update() calls will find a correct metar if things went wrong here
-    metar_max_age->setLongValue(0);
-
-    while ( !found_metar && (_error_count < 3) ) {
-        const FGAirport* a = globals->get_airports()
-                   ->search( longitude->getDoubleValue(),
-                             latitude->getDoubleValue(),
-                             true );
-        if ( a ) {  
-            FGMetarResult result = fetch_data( a->getId() );
-            if ( result.m != NULL ) {
-                SG_LOG( SG_GENERAL, SG_INFO, "closest station w/ metar = "
-                        << a->getId());
-                last_apt = a;
-                _icao = a->getId();
-                search_elapsed = 0.0;
-                fetch_elapsed = 0.0;
-                update_metar_properties( result.m );
-                update_env_config();
-                env->init();
-                found_metar = true;
-            } else {
-                // mark as no metar so it doesn't show up in subsequent
-                // searches.
-                SG_LOG( SG_GENERAL, SG_INFO, "no metar at metar = "
-                        << a->getId() );
-                globals->get_airports()->no_metar( a->getId() );
-            }
-        }
-    }
-    metar_max_age->setLongValue(max_age);
+    _boundary_table.read();
+    // pass in a pointer to the environment of the last bondary layer as
+    // a starting point
+    _aloft_table.read(&(*(_boundary_table.end()-1))->environment);
 }
 
-void
-FGMetarEnvironmentCtrl::reinit ()
+void LayerInterpolateControllerImplementation::reinit ()
 {
-    _error_count = 0;
-    _error_dt = 0.0;
-
-#if 0
-    update_env_config();
-#endif
-
-    env->reinit();
+    _boundary_table.Unbind();
+    _aloft_table.Unbind();
+    init();
+    postinit();
 }
 
-void
-FGMetarEnvironmentCtrl::update(double delta_time_sec)
+void LayerInterpolateControllerImplementation::postinit()
 {
-
-    _dt += delta_time_sec;
-    if (_error_count >= 3)
-       return;
-
-    FGMetarResult result;
-
-    static const SGPropertyNode *longitude
-        = fgGetNode( "/position/longitude-deg", true );
-    static const SGPropertyNode *latitude
-        = fgGetNode( "/position/latitude-deg", true );
-    search_elapsed += delta_time_sec;
-    fetch_elapsed += delta_time_sec;
-    interpolate_elapsed += delta_time_sec;
-
-    // if time for a new search request, push it onto the request
-    // queue
-    if ( search_elapsed > search_interval_sec ) {
-        const FGAirport* a = globals->get_airports()
-                   ->search( longitude->getDoubleValue(),
-                             latitude->getDoubleValue(),
-                             true );
-        if ( a ) {
-            if ( !last_apt || last_apt->getId() != a->getId()
-                 || fetch_elapsed > same_station_interval_sec )
-            {
-                SG_LOG( SG_GENERAL, SG_INFO, "closest station w/ metar = "
-                        << a->getId());
-                request_queue.push( a->getId() );
-                last_apt = a;
-                _icao = a->getId();
-                search_elapsed = 0.0;
-                fetch_elapsed = 0.0;
-            } else {
-                search_elapsed = 0.0;
-                SG_LOG( SG_GENERAL, SG_INFO, "same station, waiting = "
-                        << same_station_interval_sec - fetch_elapsed );
-            }
-        } else {
-            SG_LOG( SG_GENERAL, SG_WARN,
-                    "Unable to find any airports with metar" );
-        }
-    } else if ( interpolate_elapsed > EnvironmentUpdatePeriodSec ) {
-        // Interpolate the current configuration closer to the actual METAR
-        update_env_config();
-        env->reinit();
-        interpolate_elapsed = 0.0;
-    }
-
-#if !defined(ENABLE_THREADS)
-    // No loader thread running so manually fetch the data
-    string id = "";
-    while ( !request_queue.empty() ) {
-        id = request_queue.front();
-        request_queue.pop();
-    }
-
-    if ( !id.empty() ) {
-        SG_LOG( SG_GENERAL, SG_INFO, "inline fetching = " << id );
-        result = fetch_data( id );
-        result_queue.push( result );
-    }
-#endif // ENABLE_THREADS
-
-    // process any results from the loader.
-    while ( !result_queue.empty() ) {
-        result = result_queue.front();
-        result_queue.pop();
-        if ( result.m != NULL ) {
-            update_metar_properties( result.m );
-            delete result.m;
-            update_env_config();
-            env->reinit();
-        } else {
-            // mark as no metar so it doesn't show up in subsequent
-            // searches, and signal an immediate re-search.
-            SG_LOG( SG_GENERAL, SG_WARN,
-                    "no metar at station = " << result.icao );
-            globals->get_airports()->no_metar( result.icao );
-            search_elapsed = 9999.0;
-        }
-    }
-
-    env->update(delta_time_sec);
+    // we get here after 1. bind() and 2. init() was called by fg_init
+    _boundary_table.Bind();
+    _aloft_table.Bind();
 }
 
-
-void
-FGMetarEnvironmentCtrl::setEnvironment (FGEnvironment * environment)
+void LayerInterpolateControllerImplementation::bind()
 {
-    env->setEnvironment(environment);
+    // don't bind the layer tables here, because they have not been read in yet.
+    _environment.Tie( _rootNode->getNode( "interpolated", true ) );
+    _tiedProperties.Tie( _rootNode->getNode("enabled", true), &_enabled );
+    _tiedProperties.Tie( _rootNode->getNode("boundary-transition-ft", true ), &_boundary_transition );
 }
 
-FGMetarResult
-FGMetarEnvironmentCtrl::fetch_data( const string &icao )
+void LayerInterpolateControllerImplementation::unbind()
 {
-    FGMetarResult result;
-    result.icao = icao;
-
-    // if the last error was more than three seconds ago,
-    // then pretent nothing happened.
-    if (_error_dt < 3) {
-        _error_dt += _dt;
-
-    } else {
-        _error_dt = 0.0;
-        _error_count = 0;
-    }
-
-    // fetch station elevation if exists
-    const FGAirport* a = globals->get_airports()->search( icao );
-    if ( a ) {
-        station_elevation_ft = a->getElevation();
-    }
-
-    // fetch current metar data
-    try {
-        string host = proxy_host->getStringValue();
-        string auth = proxy_auth->getStringValue();
-        string port = proxy_port->getStringValue();
-        result.m = new FGMetar( icao, host, port, auth);
-
-        long max_age = metar_max_age->getLongValue();
-        long age = result.m->getAge_min();
-        if (max_age &&  age > max_age) {
-            SG_LOG( SG_GENERAL, SG_WARN, "METAR data too old (" << age << " min).");
-            delete result.m;
-            result.m = NULL;
-
-            if (++_stale_count > 10) {
-                _error_count = 1000;
-                throw sg_io_exception("More than 10 stale METAR messages in a row."
-                        " Check your system time!");
-            }
-        } else
-            _stale_count = 0;
-
-    } catch (const sg_io_exception& e) {
-        SG_LOG( SG_GENERAL, SG_WARN, "Error fetching live weather data: "
-                << e.getFormattedMessage().c_str() );
-#if defined(ENABLE_THREADS)
-        if (_error_count++ >= 3) {
-           SG_LOG( SG_GENERAL, SG_WARN, "Stop fetching data permanently.");
-           thread_stop();
-        }
-#endif
-
-        result.m = NULL;
-    }
-
-    _dt = 0;
-
-    return result;
+    _boundary_table.Unbind();
+    _aloft_table.Unbind();
+    _tiedProperties.Untie();
+    _environment.Untie();
 }
 
-
-void
-FGMetarEnvironmentCtrl::update_metar_properties( const FGMetar *m )
+void LayerInterpolateControllerImplementation::update (double delta_time_sec)
 {
-    int i;
-    double d;
-    char s[128];
-
-    fgSetString("/environment/metar/real-metar", m->getData());
-       // don't update with real weather when we use a custom weather scenario
-       const char *current_scenario = fgGetString("/environment/weather-scenario", "METAR");
-       if( strcmp(current_scenario, "METAR") && strcmp(current_scenario, "none"))
-               return;
-    fgSetString("/environment/metar/last-metar", m->getData());
-    fgSetString("/environment/metar/station-id", m->getId());
-    fgSetDouble("/environment/metar/min-visibility-m",
-                m->getMinVisibility().getVisibility_m() );
-    fgSetDouble("/environment/metar/max-visibility-m",
-                m->getMaxVisibility().getVisibility_m() );
-
-    const SGMetarVisibility *dirvis = m->getDirVisibility();
-    for (i = 0; i < 8; i++, dirvis++) {
-        const char *min = "/environment/metar/visibility[%d]/min-m";
-        const char *max = "/environment/metar/visibility[%d]/max-m";
-
-        d = dirvis->getVisibility_m();
-
-        snprintf(s, 128, min, i);
-        fgSetDouble(s, d);
-        snprintf(s, 128, max, i);
-        fgSetDouble(s, d);
-    }
-
-    fgSetInt("/environment/metar/base-wind-range-from",
-             m->getWindRangeFrom() );
-    fgSetInt("/environment/metar/base-wind-range-to",
-             m->getWindRangeTo() );
-    fgSetDouble("/environment/metar/base-wind-speed-kt",
-                m->getWindSpeed_kt() );
-    fgSetDouble("/environment/metar/gust-wind-speed-kt",
-                m->getGustSpeed_kt() );
-    fgSetDouble("/environment/metar/temperature-degc",
-                m->getTemperature_C() );
-    fgSetDouble("/environment/metar/dewpoint-degc",
-                m->getDewpoint_C() );
-    fgSetDouble("/environment/metar/rel-humidity-norm",
-                m->getRelHumidity() );
-    fgSetDouble("/environment/metar/pressure-inhg",
-                m->getPressure_inHg() );
-
-    vector<SGMetarCloud> cv = m->getClouds();
-    vector<SGMetarCloud>::const_iterator cloud;
-
-    const char *cl = "/environment/metar/clouds/layer[%i]";
-    for (i = 0, cloud = cv.begin(); cloud != cv.end(); cloud++, i++) {
-        const char *coverage_string[5] = 
-            { "clear", "few", "scattered", "broken", "overcast" };
-        const double thickness[5] = { 0, 65, 600,750, 1000};
-        int q;
-
-        snprintf(s, 128, cl, i);
-        strncat(s, "/coverage", 128);
-        q = cloud->getCoverage();
-        fgSetString(s, coverage_string[q] );
-
-        snprintf(s, 128, cl, i);
-        strncat(s, "/elevation-ft", 128);
-        fgSetDouble(s, cloud->getAltitude_ft() + station_elevation_ft);
-
-        snprintf(s, 128, cl, i);
-        strncat(s, "/thickness-ft", 128);
-        fgSetDouble(s, thickness[q]);
-
-        snprintf(s, 128, cl, i);
-        strncat(s, "/span-m", 128);
-        fgSetDouble(s, 40000.0);
-    }
-
-    for (; i < FGEnvironmentMgr::MAX_CLOUD_LAYERS; i++) {
-        snprintf(s, 128, cl, i);
-        strncat(s, "/coverage", 128);
-        fgSetString(s, "clear");
+    if( !_enabled || delta_time_sec <= SGLimitsd::min() )
+        return;
 
-        snprintf(s, 128, cl, i);
-        strncat(s, "/elevation-ft", 128);
-        fgSetDouble(s, -9999);
+    double altitude_ft = _altitude_n->getDoubleValue();
+    double altitude_agl_ft = _altitude_agl_n->getDoubleValue();
 
-        snprintf(s, 128, cl, i);
-        strncat(s, "/thickness-ft", 128);
-        fgSetDouble(s, 0);
+    // avoid div by zero later on and init with a default value if not given
+    if( _boundary_transition <= SGLimitsd::min() )
+        _boundary_transition = 500;
 
-        snprintf(s, 128, cl, i);
-        strncat(s, "/span-m", 128);
-        fgSetDouble(s, 40000.0);
-    }
+    int length = _boundary_table.size();
 
-    fgSetDouble("/environment/metar/rain-norm", m->getRain());
-    fgSetDouble("/environment/metar/hail-norm", m->getHail());
-    fgSetDouble("/environment/metar/snow-norm", m->getSnow());
-    fgSetBool("/environment/metar/snow-cover", m->getSnowCover());
+    if (length > 0) {
+        // If a boundary table is defined, get the top of the boundary layer
+        double boundary_limit = _boundary_table[length-1]->altitude_ft;
+        if (boundary_limit >= altitude_agl_ft) {
+            // If current altitude is below top of boundary layer, interpolate
+            // only in boundary layer
+            _boundary_table.interpolate(altitude_agl_ft, &_environment);
+            return;
+        } else if ((boundary_limit + _boundary_transition) >= altitude_agl_ft) {
+            // If current altitude is above top of boundary layer and within the 
+            // transition altitude, interpolate boundary and aloft layers
+            FGEnvironment env1, env2;
+            _boundary_table.interpolate( altitude_agl_ft, &env1);
+            _aloft_table.interpolate(altitude_ft, &env2);
+            double fraction = (altitude_agl_ft - boundary_limit) / _boundary_transition;
+            env1.interpolate(env2, fraction, &_environment);
+            return;
+        }
+    } 
+    // If no boundary layer is defined or altitude is above top boundary-layer plus boundary-transition
+    // altitude, use only the aloft table
+    _aloft_table.interpolate( altitude_ft, &_environment);
 }
 
+//////////////////////////////////////////////////////////////////////////////
 
-#if defined(ENABLE_THREADS)
-void
-FGMetarEnvironmentCtrl::thread_stop()
-{
-    request_queue.push( string() );    // ask thread to terminate
-    thread->join();
-}
-
-void
-FGMetarEnvironmentCtrl::MetarThread::run()
+LayerInterpolateController * LayerInterpolateController::createInstance( SGPropertyNode_ptr rootNode )
 {
-    while ( true )
-    {
-        string icao = fetcher->request_queue.pop();
-        if (icao.empty())
-            return;
-        SG_LOG( SG_GENERAL, SG_INFO, "Thread: fetch metar data = " << icao );
-        FGMetarResult result = fetcher->fetch_data( icao );
-        fetcher->result_queue.push( result );
-    }
+    return new LayerInterpolateControllerImplementation( rootNode );
 }
-#endif // ENABLE_THREADS
 
+//////////////////////////////////////////////////////////////////////////////
 
-// end of environment_ctrl.cxx
+} // namespace