Skip to content
Snippets Groups Projects
Commit 06492c67 authored by Luc Maisonobe's avatar Luc Maisonobe
Browse files

Merge branch 'issue-517' into release-9.3

parents e50af9aa cb1eb853
Branches
No related tags found
No related merge requests found
Showing
with 731 additions and 2779 deletions
......@@ -221,7 +221,8 @@ public enum OrekitMessages implements Localizable {
CORRUPTED_FILE("file {0} is corrupted"),
VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_LOADED("Vienna coefficients ah or aw or zh or zw could not be loaded from {0}"),
VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE("Vienna coefficients ah or aw or zh or zw not available for date {0}"),
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE("file {0} does not contain Vienna coefficients ah, aw, zh or zw");
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE("file {0} does not contain Vienna coefficients ah, aw, zh or zw"),
IRREGULAR_OR_INCOMPLETE_GRID("irregular or incomplete grid in file {0}");
// CHECKSTYLE: resume JavadocVariable check
......
......@@ -20,9 +20,14 @@ import java.io.BufferedReader;
import java.io.IOException;
import java.io.InputStream;
import java.io.InputStreamReader;
import java.nio.charset.StandardCharsets;
import java.text.ParseException;
import java.util.ArrayList;
import java.util.List;
import java.util.SortedSet;
import java.util.TreeSet;
import java.util.concurrent.atomic.AtomicReference;
import java.util.function.ToDoubleFunction;
import org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction;
import org.hipparchus.util.FastMath;
......@@ -42,8 +47,9 @@ import org.orekit.utils.Constants;
* and a<sub>w</sub> coefficients used for the {@link ViennaOneModel Vienna 1} model.
* <p>
* The requisite coefficients for the computation of the weather parameters are provided by the
* Department of Geodesy and Geoinformation of the Vienna University. They are based on a 5° x 5°
* external grid file "gpt2_5.grd" available at: <a href="http://vmf.geo.tuwien.ac.at/codes/"> link</a>
* Department of Geodesy and Geoinformation of the Vienna University. They are based on an
* external grid file like "gpt2_1.grd" (1° x 1°) or "gpt2_5.grd" (5° x 5°) available at:
* <a href="http://vmf.geo.tuwien.ac.at/codes/"> link</a>
* </p>
* <p>
* A bilinear interpolation is performed in order to obtained the correct values of the weather parameters.
......@@ -69,10 +75,10 @@ import org.orekit.utils.Constants;
* @author Bryan Cazabonne
*
*/
public class GlobalPressureTemperature2Model implements DataLoader, WeatherModel {
public class GlobalPressureTemperature2Model implements WeatherModel {
/** Default supported files name pattern. */
public static final String DEFAULT_SUPPORTED_NAMES = "gpt2_5.grd";
public static final String DEFAULT_SUPPORTED_NAMES = "gpt2_\\d+.grd";
/** Standard gravity constant [m/s²]. */
private static final double G = Constants.G0_STANDARD_GRAVITY;
......@@ -80,8 +86,23 @@ public class GlobalPressureTemperature2Model implements DataLoader, WeatherModel
/** Ideal gas constant for dry air [J/kg/K]. */
private static final double R = 287.0;
/** Regular expression for supported file name. */
private String supportedNames;
/** Conversion factor from degrees to mill arcseconds. */
private static final int DEG_TO_MAS = 3600000;
/** Shared lazily loaded grid. */
private static final AtomicReference<Grid> SHARED_GRID = new AtomicReference<>(null);
/** South-West grid entry. */
private final GridEntry southWest;
/** South-East grid entry. */
private final GridEntry southEast;
/** North-West grid entry. */
private final GridEntry northWest;
/** North-East grid entry. */
private final GridEntry northEast;
/** The hydrostatic and wet a coefficients loaded. */
private double[] coefficientsA;
......@@ -110,27 +131,41 @@ public class GlobalPressureTemperature2Model implements DataLoader, WeatherModel
/** Current date. */
private AbsoluteDate date;
/** Day of year. */
private int dayOfYear;
/** Constructor with supported names given by user.
* @param supportedNames supported names
* @param latitude geodetic latitude of the station, in radians
* @param longitude longitude geodetic latitude of the station, in radians
* @param longitude longitude geodetic longitude of the station, in radians
* @param geoid level surface of the gravity potential of a body
*/
public GlobalPressureTemperature2Model(final String supportedNames, final double latitude,
final double longitude, final Geoid geoid) {
this.coefficientsA = null;
this.temperature = Double.NaN;
this.pressure = Double.NaN;
this.e0 = Double.NaN;
this.supportedNames = supportedNames;
this.geoid = geoid;
this.latitude = latitude;
// Normalize longitude between 0 and 2π
this.longitude = MathUtils.normalizeAngle(longitude, FastMath.PI);
this.coefficientsA = null;
this.temperature = Double.NaN;
this.pressure = Double.NaN;
this.e0 = Double.NaN;
this.geoid = geoid;
this.latitude = latitude;
// get the lazily loaded shared grid
Grid grid = SHARED_GRID.get();
if (grid == null) {
// this is the first instance we create, we need to load the grid data
final Parser parser = new Parser();
DataProvidersManager.getInstance().feed(supportedNames, parser);
SHARED_GRID.compareAndSet(null, parser.grid);
grid = parser.grid;
}
// Normalize longitude according to the grid
this.longitude = MathUtils.normalizeAngle(longitude, grid.entries[0][0].longitude + FastMath.PI);
final int southIndex = grid.getSouthIndex(this.latitude);
final int westIndex = grid.getWestIndex(this.longitude);
this.southWest = grid.entries[southIndex ][westIndex ];
this.southEast = grid.entries[southIndex ][westIndex + 1];
this.northWest = grid.entries[southIndex + 1][westIndex ];
this.northEast = grid.entries[southIndex + 1][westIndex + 1];
}
/** Constructor with default supported names.
......@@ -174,196 +209,334 @@ public class GlobalPressureTemperature2Model implements DataLoader, WeatherModel
return e0;
}
/** Returns the supported names of the loader.
* @return the supported names
*/
public String getSupportedNames() {
return supportedNames;
}
@Override
public void weatherParameters(final double stationHeight, final AbsoluteDate currentDate) {
this.date = currentDate;
this.dayOfYear = currentDate.getComponents(TimeScalesFactory.getUTC()).getDate().getDayOfYear();
this.height = stationHeight;
DataProvidersManager.getInstance().feed(supportedNames, this);
final int dayOfYear = currentDate.getComponents(TimeScalesFactory.getUTC()).getDate().getDayOfYear();
// ah and aw coefficients
coefficientsA = new double[] {
interpolate(e -> evaluate(dayOfYear, e.ah)) * 0.001,
interpolate(e -> evaluate(dayOfYear, e.aw)) * 0.001
};
// Corrected height (can be negative)
final double undu = geoid.getUndulation(latitude, longitude, date);
final double correctedheight = height - undu - interpolate(e -> e.hS);
// Temperature gradient [K/m]
final double dTdH = interpolate(e -> evaluate(dayOfYear, e.dT)) * 0.001;
// Specific humidity
final double qv = interpolate(e -> evaluate(dayOfYear, e.qv0)) * 0.001;
// For the computation of the temperature and the pressure, we use
// the standard ICAO atmosphere formulas.
// Temperature [K]
final double t0 = interpolate(e -> evaluate(dayOfYear, e.temperature0));
this.temperature = t0 + dTdH * correctedheight;
// Pressure [hPa]
final double p0 = interpolate(e -> evaluate(dayOfYear, e.pressure0));
final double exponent = G / (dTdH * R);
this.pressure = p0 * FastMath.pow(1 - (dTdH / t0) * correctedheight, exponent) * 0.01;
// Water vapor pressure [hPa]
this.e0 = qv * pressure / (0.622 + 0.378 * qv);
}
@Override
public boolean stillAcceptsData() {
return true;
/** Interpolate a grid function.
* @param gridGetter getter for the grid function
* @return interpolated function"
*/
private double interpolate(final ToDoubleFunction<GridEntry> gridGetter) {
// cell surrounding the point
final double[] xVal = new double[] {
southWest.longitude, southEast.longitude
};
final double[] yVal = new double[] {
southWest.latitude, northWest.latitude
};
// evaluate grid points at specified day
final double[][] fval = new double[][] {
{
gridGetter.applyAsDouble(southWest),
gridGetter.applyAsDouble(northWest)
}, {
gridGetter.applyAsDouble(southEast),
gridGetter.applyAsDouble(northEast)
}
};
// perform interpolation in the grid
return new BilinearInterpolatingFunction(xVal, yVal, fval).value(longitude, latitude);
}
@Override
public void loadData(final InputStream input, final String name)
throws IOException, ParseException {
// Open stream and parse data
final BufferedReader br = new BufferedReader(new InputStreamReader(input, "UTF-8"));
int lineNumber = 0;
final String splitter = "\\s+";
// Initialize Lists
// Latitudes [rad]
final List<Double> latitudes = new ArrayList<>();
// Longitudes [rad]
final List<Double> longitudes = new ArrayList<>();
// Orthometric grid height [m]
final List<Double> hS = new ArrayList<>();
// Hydrostatic coefficient a
final List<Double> ah = new ArrayList<>();
// Wet coefficient a
final List<Double> aw = new ArrayList<>();
// Temperature [K]
final List<Double> temperature0 = new ArrayList<>();
// Temperature gradient [K/m]
final List<Double> dT = new ArrayList<>();
// Pressure [Pa]
final List<Double> pressure0 = new ArrayList<>();
// Specific humidity [kg/kg]
final List<Double> qv0 = new ArrayList<>();
for (String line = br.readLine(); line != null; line = br.readLine()) {
++lineNumber;
line = line.trim();
try {
// Fill ah, aw, temp, pres, humidity lists
if (line.length() > 0 && !line.startsWith("%")) {
final String[] values_line = line.split(splitter);
hS.add(Double.valueOf(values_line[23]));
fillArray(pressure0, values_line, 2, 3, 4, 5, 6);
fillArray(temperature0, values_line, 7, 8, 9, 10, 11);
fillArray(qv0, values_line, 12, 13, 14, 15, 16);
fillArray(dT, values_line, 17, 18, 19, 20, 21);
fillArray(ah, values_line, 24, 25, 26, 27, 28);
fillArray(aw, values_line, 29, 30, 31, 32, 33);
}
/** Evaluate a model for some day.
* @param dayOfYear day to evaluate
* @param model model array
* @return model value at specified day
*/
private double evaluate(final int dayOfYear, final double[] model) {
final double coef = (dayOfYear / 365.25) * 2 * FastMath.PI;
final SinCos sc1 = FastMath.sinCos(coef);
final SinCos sc2 = FastMath.sinCos(2.0 * coef);
return model[0] +
model[1] * sc1.cos() + model[2] * sc1.sin() +
model[3] * sc2.cos() + model[4] * sc2.sin();
}
/** Parser for GPT2 grid files. */
private static class Parser implements DataLoader {
/** Grid entries. */
private Grid grid;
@Override
public boolean stillAcceptsData() {
return grid == null;
}
@Override
public void loadData(final InputStream input, final String name)
throws IOException, ParseException {
final SortedSet<Integer> latSample = new TreeSet<>();
final SortedSet<Integer> lonSample = new TreeSet<>();
final List<GridEntry> entries = new ArrayList<>();
// Open stream and parse data
int lineNumber = 0;
String line = null;
try (InputStreamReader isr = new InputStreamReader(input, StandardCharsets.UTF_8);
BufferedReader br = new BufferedReader(isr)) {
final String splitter = "\\s+";
for (line = br.readLine(); line != null; line = br.readLine()) {
++lineNumber;
line = line.trim();
// read grid data
if (line.length() > 0 && !line.startsWith("%")) {
final GridEntry entry = new GridEntry(line.split(splitter));
latSample.add(entry.latKey);
lonSample.add(entry.lonKey);
entries.add(entry);
}
}
} catch (NumberFormatException nfe) {
throw new OrekitException(OrekitMessages.UNABLE_TO_PARSE_LINE_IN_FILE,
lineNumber, name, line);
}
}
// Close the stream after reading
input.close();
// organize entries in a grid that wraps arouns Earth in longitude
grid = new Grid(latSample, lonSample, entries, name);
// Latitudes list
for (double lat = -87.5; lat <= 87.5; lat = lat + 5.0) {
latitudes.add(FastMath.toRadians(lat));
}
// Longitude list
for (double lon = 2.5; lon <= 357.5; lon = lon + 5.0) {
longitudes.add(FastMath.toRadians(lon));
}
}
final int dimLat = latitudes.size();
final int dimLon = longitudes.size();
/** Container for complete grid. */
private static class Grid {
/** Latitude sample. */
private final SortedSet<Integer> latitudeSample;
/** Longitude sample. */
private final SortedSet<Integer> longitudeSample;
/** Grid entries. */
private final GridEntry[][] entries;
/** Simple constructor.
* @param latitudeSample latitude sample
* @param longitudeSample longitude sample
* @param loadedEntries loaded entries, organized as a simple list
* @param name file name
*/
Grid(final SortedSet<Integer> latitudeSample, final SortedSet<Integer> longitudeSample,
final List<GridEntry> loadedEntries, final String name) {
final int nA = latitudeSample.size();
final int nO = longitudeSample.size() + 1; // we add one here for wrapping the grid
this.entries = new GridEntry[nA][nO];
this.latitudeSample = latitudeSample;
this.longitudeSample = longitudeSample;
// organize entries in the regular grid
for (final GridEntry entry : loadedEntries) {
final int latitudeIndex = latitudeSample.headSet(entry.latKey + 1).size() - 1;
final int longitudeIndex = longitudeSample.headSet(entry.lonKey + 1).size() - 1;
entries[latitudeIndex][longitudeIndex] = entry;
}
// Change List to double[]
final double[] xVal = new double[dimLat];
for (int i = 0; i < dimLat; i++) {
xVal[i] = latitudes.get(i);
}
// finalize the grid
for (final GridEntry[] row : entries) {
// Change List to double[]
final double[] yVal = new double[dimLon];
for (int j = 0; j < dimLon; j++) {
yVal[j] = longitudes.get(j);
}
// check for missing entries
for (int longitudeIndex = 0; longitudeIndex < nO - 1; ++longitudeIndex) {
if (row[longitudeIndex] == null) {
throw new OrekitException(OrekitMessages.IRREGULAR_OR_INCOMPLETE_GRID, name);
}
}
// wrap the grid around the Earth in longitude
row[nO - 1] = new GridEntry(row[0].latitude, row[0].latKey,
row[0].longitude + 2 * FastMath.PI,
row[0].lonKey + DEG_TO_MAS * 360,
row[0].hS, row[0].pressure0, row[0].temperature0,
row[0].qv0, row[0].dT, row[0].ah, row[0].aw);
final double[][] fvalPressure0 = new double[dimLat][dimLon];
final double[][] fvalTemperature0 = new double[dimLat][dimLon];
final double[][] fvalqv0 = new double[dimLat][dimLon];
final double[][] fvaldT = new double[dimLat][dimLon];
final double[][] fvalHS = new double[dimLat][dimLon];
final double[][] fvalAH = new double[dimLat][dimLon];
final double[][] fvalAW = new double[dimLat][dimLon];
int index = dimLon * dimLat;
for (int x = 0; x < dimLat; x++) {
for (int y = dimLon - 1; y >= 0; y--) {
index = index - 1;
fvalPressure0[x][y] = pressure0.get(index);
fvalTemperature0[x][y] = temperature0.get(index);
fvalqv0[x][y] = qv0.get(index);
fvaldT[x][y] = dT.get(index);
fvalHS[x][y] = hS.get(index);
fvalAH[x][y] = ah.get(index);
fvalAW[x][y] = aw.get(index);
}
}
// Build Bilinear Interpolation Functions
final BilinearInterpolatingFunction functionPressure0 = new BilinearInterpolatingFunction(xVal, yVal, fvalPressure0);
final BilinearInterpolatingFunction functionTemperature0 = new BilinearInterpolatingFunction(xVal, yVal, fvalTemperature0);
final BilinearInterpolatingFunction functionqv0 = new BilinearInterpolatingFunction(xVal, yVal, fvalqv0);
final BilinearInterpolatingFunction functiondT = new BilinearInterpolatingFunction(xVal, yVal, fvaldT);
final BilinearInterpolatingFunction functionHS = new BilinearInterpolatingFunction(xVal, yVal, fvalHS);
final BilinearInterpolatingFunction functionAH = new BilinearInterpolatingFunction(xVal, yVal, fvalAH);
final BilinearInterpolatingFunction functionAW = new BilinearInterpolatingFunction(xVal, yVal, fvalAW);
/** Get index of South entries in the grid.
* @param latitude latitude to locate (radians)
* @return index of South entries in the grid
*/
public int getSouthIndex(final double latitude) {
// ah and aw coefficients
coefficientsA = new double[2];
coefficientsA[0] = functionAH.value(latitude, longitude) * 0.001;
coefficientsA[1] = functionAW.value(latitude, longitude) * 0.001;
final int latKey = (int) FastMath.rint(FastMath.toDegrees(latitude) * DEG_TO_MAS);
final int index = latitudeSample.headSet(latKey + 1).size() - 1;
// Corrected height (can be negative)
final double undu = geoid.getUndulation(latitude, longitude, date);
final double correctedheight = height - undu - functionHS.value(latitude, longitude);
// make sure we have at least one point remaining on North by clipping to size - 2
return FastMath.min(index, latitudeSample.size() - 2);
// Temperature gradient [K/m]
final double dTdH = functiondT.value(latitude, longitude) * 0.001;
}
// Specific humidity
final double qv = functionqv0.value(latitude, longitude) * 0.001;
/** Get index of West entries in the grid.
* @param longitude longitude to locate (radians)
* @return index of West entries in the grid
*/
public int getWestIndex(final double longitude) {
// For the computation of the temperature and the pressure, we use
// the standard ICAO atmosphere formulas.
final int lonKey = (int) FastMath.rint(FastMath.toDegrees(longitude) * DEG_TO_MAS);
final int index = longitudeSample.headSet(lonKey + 1).size() - 1;
// Temperature [K]
final double t0 = functionTemperature0.value(latitude, longitude);
this.temperature = t0 + dTdH * correctedheight;
// we don't do clipping in longitude because we have added a row to wrap around the Earth
return index;
// Pressure [hPa]
final double p0 = functionPressure0.value(latitude, longitude);
final double exponent = G / (dTdH * R);
this.pressure = p0 * FastMath.pow(1 - (dTdH / t0) * correctedheight, exponent) * 0.01;
}
// Water vapor pressure [hPa]
this.e0 = qv * pressure / (0.622 + 0.378 * qv);
}
/** Fill the arrays containing the weather coefficients.
* @param array array to fill
* @param values string array containing the values
* @param indexA0 index of coefficient A0 for this parameter
* @param indexA1 index of coefficient A1 for this parameter
* @param indexB1 index of coefficient B1 for this parameter
* @param indexA2 index of coefficient A2 for this parameter
* @param indexB2 index of coefficient B2 for this parameter
*/
private void fillArray(final List<Double> array, final String[] values,
final int indexA0, final int indexA1, final int indexB1,
final int indexA2, final int indexB2) {
// Parse coefficients
final double a0 = Double.parseDouble(values[indexA0]);
final double a1 = Double.parseDouble(values[indexA1]);
final double b1 = Double.parseDouble(values[indexB1]);
final double a2 = Double.parseDouble(values[indexA2]);
final double b2 = Double.parseDouble(values[indexB2]);
// Temporal factors
final double coef = (dayOfYear / 365.25) * 2 * FastMath.PI;
final SinCos sc1 = FastMath.sinCos(coef);
final SinCos sc2 = FastMath.sinCos(2.0 * coef);
/** Container for grid entries. */
private static class GridEntry {
/** Latitude (radian). */
private final double latitude;
/** Latitude key (mas). */
private final int latKey;
/** Longitude (radian). */
private final double longitude;
/** Longitude key (mas). */
private final int lonKey;
/** Height correction. */
private final double hS;
/** Pressure model. */
private final double[] pressure0;
/** Temperature model. */
private final double[] temperature0;
/** Specific humidity model. */
private final double[] qv0;
/** Temperature gradient model. */
private final double[] dT;
/** ah coefficient model. */
private final double[] ah;
/** aw coefficient model. */
private final double[] aw;
/** Build an entry from a parsed line.
* @param fields line fields
*/
GridEntry(final String[] fields) {
final double latDegree = Double.parseDouble(fields[0]);
final double lonDegree = Double.parseDouble(fields[1]);
latitude = FastMath.toRadians(latDegree);
longitude = FastMath.toRadians(lonDegree);
latKey = (int) FastMath.rint(latDegree * DEG_TO_MAS);
lonKey = (int) FastMath.rint(lonDegree * DEG_TO_MAS);
hS = Double.valueOf(fields[23]);
pressure0 = createModel(fields, 2);
temperature0 = createModel(fields, 7);
qv0 = createModel(fields, 12);
dT = createModel(fields, 17);
ah = createModel(fields, 24);
aw = createModel(fields, 29);
}
/** Build an entry from its components.
* @param latitude latitude (radian)
* @param latKey latitude key (mas)
* @param longitude longitude (radian)
* @param lonKey longitude key (mas)
* @param hS height correction
* @param pressure0 pressure model
* @param temperature0 temperature model
* @param qv0 specific humidity model
* @param dT temperature gradient model
* @param ah ah coefficient model
* @param aw aw coefficient model
*/
GridEntry(final double latitude, final int latKey, final double longitude, final int lonKey,
final double hS, final double[] pressure0, final double[] temperature0,
final double[] qv0, final double[] dT, final double[] ah, final double[] aw) {
this.latitude = latitude;
this.latKey = latKey;
this.longitude = longitude;
this.lonKey = lonKey;
this.hS = hS;
this.pressure0 = pressure0.clone();
this.temperature0 = temperature0.clone();
this.qv0 = qv0.clone();
this.dT = dT.clone();
this.ah = ah.clone();
this.aw = aw.clone();
}
/** Create a time model array.
* @param fields line fields
* @param first index of the first component of the model
* @return time model array
*/
private double[] createModel(final String[] fields, final int first) {
return new double[] {
Double.parseDouble(fields[first ]),
Double.parseDouble(fields[first + 1]),
Double.parseDouble(fields[first + 2]),
Double.parseDouble(fields[first + 3]),
Double.parseDouble(fields[first + 4])
};
}
final double value = a0 + a1 * sc1.cos() + b1 * sc1.sin() + a2 * sc2.cos() + b2 * sc2.sin();
array.add(value);
}
}
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = <MISSING TRANSLATION>
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = <MISSING TRANSLATION>
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = <MISSING TRANSLATION>
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = <MISSING TRANSLATION>
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = <MISSING TRANSLATION>
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = <MISSING TRANSLATION>
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = <MISSING TRANSLATION>
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = <MISSING TRANSLATION>
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = <MISSING TRANSLATION>
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = Vienna coefficients ah or
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = file {0} does not contain Vienna coefficients ah, aw, zh or zw
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = irregular or incomplete grid in file {0}
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = <MISSING TRANSLATION>
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = <MISSING TRANSLATION>
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = <MISSING TRANSLATION>
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = les coefficients du modèl
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = {0} ne contiant pas de coefficients du modèle de Vienne ah, aw, zh ou zw
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = grille incomplète ou irrégulière dans le fichier {0}
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = <MISSING TRANSLATION>
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = <MISSING TRANSLATION>
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = <MISSING TRANSLATION>
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = <MISSING TRANSLATION>
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = <MISSING TRANSLATION>
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = <MISSING TRANSLATION>
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = <MISSING TRANSLATION>
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = <MISSING TRANSLATION>
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = <MISSING TRANSLATION>
......@@ -510,3 +510,6 @@ VIENNA_ACOEF_OR_ZENITH_DELAY_NOT_AVAILABLE_FOR_DATE = <MISSING TRANSLATION>
# file {0} does not contain Vienna coefficients ah, aw, zh or zw
NO_VIENNA_ACOEF_OR_ZENITH_DELAY_IN_FILE = <MISSING TRANSLATION>
# irregular or incomplete grid in file {0}
IRREGULAR_OR_INCOMPLETE_GRID = <MISSING TRANSLATION>
......@@ -23,6 +23,7 @@ import java.util.ArrayList;
import java.util.List;
import java.util.Map;
import java.util.SortedSet;
import java.util.concurrent.atomic.AtomicReference;
import org.junit.Assert;
import org.orekit.bodies.CelestialBodyFactory;
......@@ -32,6 +33,7 @@ import org.orekit.frames.EOPEntry;
import org.orekit.frames.EOPHistoryLoader;
import org.orekit.frames.FramesFactory;
import org.orekit.frames.ITRFVersion;
import org.orekit.models.earth.GlobalPressureTemperature2Model;
import org.orekit.orbits.FieldCartesianOrbit;
import org.orekit.orbits.FieldCircularOrbit;
import org.orekit.orbits.FieldEquinoctialOrbit;
......@@ -79,6 +81,7 @@ public class Utils {
clearFactoryMaps(c);
}
}
clearAtomicReference(GlobalPressureTemperature2Model.class);
FramesFactory.clearEOPHistoryLoaders();
FramesFactory.setEOPContinuityThreshold(5 * Constants.JULIAN_DAY);
TimeScalesFactory.clearUTCTAIOffsetsLoaders();
......@@ -87,6 +90,7 @@ public class Utils {
DataProvidersManager.getInstance().clearProviders();
DataProvidersManager.getInstance().clearFilters();
DataProvidersManager.getInstance().clearLoadedDataNames();
}
public static void setDataRoot(String root) {
......@@ -125,7 +129,7 @@ public class Utils {
try {
for (Field field : factoryClass.getDeclaredFields()) {
if (Modifier.isStatic(field.getModifiers()) &&
cachedFieldsClass.isAssignableFrom(field.getType())) {
cachedFieldsClass.isAssignableFrom(field.getType())) {
field.setAccessible(true);
field.set(null, null);
}
......@@ -135,6 +139,20 @@ public class Utils {
}
}
private static void clearAtomicReference(Class<?> factoryClass) {
try {
for (Field field : factoryClass.getDeclaredFields()) {
if (Modifier.isStatic(field.getModifiers()) &&
AtomicReference.class.isAssignableFrom(field.getType())) {
field.setAccessible(true);
((AtomicReference<?>) field.get(null)).set(null);
}
}
} catch (IllegalAccessException iae) {
Assert.fail(iae.getMessage());
}
}
public static List<EOPEntry> buildEOPList(IERSConventions conventions, ITRFVersion version,
double[][] data) {
IERSConventions.NutationCorrectionConverter converter =
......
......@@ -31,7 +31,7 @@ public class OrekitMessagesTest {
@Test
public void testMessageNumber() {
Assert.assertEquals(171, OrekitMessages.values().length);
Assert.assertEquals(172, OrekitMessages.values().length);
}
@Test
......
......@@ -61,7 +61,8 @@ public class GlobalPressureTemperature2ModelTest {
final AbsoluteDate date = AbsoluteDate.createMJDDate(56141, 0.0, TimeScalesFactory.getUTC());
final Geoid geoid = new Geoid(GravityFieldFactory.getNormalizedProvider(12, 12),
ReferenceEllipsoid.getWgs84(FramesFactory.getITRF(IERSConventions.IERS_2010, true)));
final GlobalPressureTemperature2Model model = new GlobalPressureTemperature2Model(latitude, longitude, geoid);
final GlobalPressureTemperature2Model model =
new GlobalPressureTemperature2Model("gpt2_5_extract.grd", latitude, longitude, geoid);
model.weatherParameters(height, date);
......@@ -156,20 +157,15 @@ public class GlobalPressureTemperature2ModelTest {
final double latitude = FastMath.toRadians(14.0);
final double longitude = FastMath.toRadians(67.5);
final double height = 0.0;
// Date is not used here
final AbsoluteDate date = AbsoluteDate.J2000_EPOCH;
final Geoid geoid = new Geoid(GravityFieldFactory.getNormalizedProvider(12, 12),
ReferenceEllipsoid.getWgs84(FramesFactory.getITRF(IERSConventions.IERS_2010, true)));
final String fileName = "corrupted-bad-data-gpt2_5.grd";
final GlobalPressureTemperature2Model model = new GlobalPressureTemperature2Model(fileName, latitude, longitude, geoid);
try {
model.weatherParameters(height, date);
new GlobalPressureTemperature2Model(fileName, latitude, longitude, geoid);
Assert.fail("An exception should have been thrown");
} catch (OrekitException oe) {
Assert.assertEquals(OrekitMessages.UNABLE_TO_PARSE_LINE_IN_FILE, oe.getSpecifier());
Assert.assertEquals(6, ((Integer) oe.getParts()[0]).intValue());
......@@ -177,4 +173,29 @@ public class GlobalPressureTemperature2ModelTest {
}
}
@Test
public void testCorruptedIrregularGrid() {
Utils.setDataRoot("regular-data:potential:gpt2-grid");
GravityFieldFactory.addPotentialCoefficientsReader(new GRGSFormatReader("grim4s4_gr", true));
final double latitude = FastMath.toRadians(14.0);
final double longitude = FastMath.toRadians(68.5);
// Date is not used here
final Geoid geoid = new Geoid(GravityFieldFactory.getNormalizedProvider(12, 12),
ReferenceEllipsoid.getWgs84(FramesFactory.getITRF(IERSConventions.IERS_2010, true)));
final String fileName = "corrupted-irregular-grid-gpt2_5.grd";
try {
new GlobalPressureTemperature2Model(fileName, latitude, longitude, geoid);
Assert.fail("An exception should have been thrown");
} catch (OrekitException oe) {
Assert.assertEquals(OrekitMessages.IRREGULAR_OR_INCOMPLETE_GRID, oe.getSpecifier());
Assert.assertTrue(((String) oe.getParts()[0]).endsWith(fileName));
}
}
}
% This is not an original GPT2 grid, it has been edited for test purposes and should not be used except for test
% lat lon p:a0 A1 B1 A2 B2 T:a0 A1 B1 A2 B2 Q:a0 A1 B1 A2 B2 dT:a0 A1 B1 A2 B2 undu Hs h:a0 A1 B1 A2 B2 w:a0 A1 B1 A2 B2
17.5 67.5 100913 30 -28 9 -14 283.4 -9.1 -2.9 -0.0 0.3 6.02 -2.61 -1.33 0.29 0.32 -4.6 1.0 -0.3 -0.1 -0.0 41.28 52.71 1.2352 -0.0211 -0.0108 0.0008 0.0009 0.5583 -0.0126 -0.0125 0.0040 0.0012
17.5 72.5 100434 46 -48 -8 -16 282.7 -10.0 -3.0 0.0 0.2 5.88 -2.85 -1.38 0.39 0.36 -4.3 1.1 -0.2 -0.2 0.1 34.11 93.18 1.2344 -0.0225 -0.0111 0.0010 0.0007 0.5578 -0.0120 -0.0115 0.0049 0.0017
12.5 67.4999 89942 -161 -172 56 16 281.0 -8.4 -3.1 0.1 0.1 5.13 -2.91 -1.20 0.34 0.34 -6.5 0.6 -0.2 0.2 -0.1 47.30 1024.64 1.2395 -0.0209 -0.0110 0.0010 0.0008 0.5243 -0.0055 -0.0101 0.0041 0.0011
12.5 72.5 99762 183 -97 41 -6 284.8 -10.5 -2.7 -0.3 0.1 6.21 -3.28 -1.34 0.41 0.22 -5.4 1.6 -0.0 0.0 0.1 44.86 160.75 1.2406 -0.0219 -0.0106 0.0008 0.0005 0.5649 -0.0088 -0.0096 0.0044 0.0026
% This is not an original GPT2 grid, it has been edited for test purposes and should not be used except for test
% lat lon p:a0 A1 B1 A2 B2 T:a0 A1 B1 A2 B2 Q:a0 A1 B1 A2 B2 dT:a0 A1 B1 A2 B2 undu Hs h:a0 A1 B1 A2 B2 w:a0 A1 B1 A2 B2
82.5 7.5 101260 -239 308 -169 -108 261.7 -10.6 -5.2 2.7 0.3 1.88 -1.45 -0.64 0.49 0.28 -0.0 3.9 1.4 -1.0 1.4 29.80 -0.00 1.1924 -0.0322 -0.0125 0.0052 0.0034 0.5710 -0.0023 0.0030 -0.0018 0.0029
82.5 22.5 101209 -249 315 -141 -97 262.5 -9.8 -5.5 2.7 0.2 1.95 -1.39 -0.70 0.47 0.28 -0.8 3.2 1.9 -1.3 1.6 25.99 -0.00 1.1923 -0.0321 -0.0126 0.0052 0.0034 0.5672 -0.0062 0.0034 -0.0009 0.0032
82.5 37.5 101198 -203 328 -118 -95 262.5 -9.8 -5.7 2.5 0.3 1.93 -1.38 -0.72 0.45 0.29 -1.3 2.9 2.1 -1.0 1.6 20.77 -0.00 1.1918 -0.0324 -0.0128 0.0052 0.0035 0.5668 -0.0063 0.0035 -0.0008 0.0032
82.5 52.5 101202 -129 343 -93 -88 262.4 -9.8 -5.7 2.3 0.4 1.91 -1.38 -0.72 0.42 0.31 -1.9 2.3 1.8 -0.9 1.6 17.04 -0.00 1.1912 -0.0329 -0.0129 0.0052 0.0037 0.5673 -0.0060 0.0043 0.0008 0.0033
82.5 67.5 101230 -27 368 -70 -72 261.6 -10.7 -6.2 2.1 0.3 1.83 -1.44 -0.76 0.41 0.32 -1.1 3.4 2.6 -1.0 2.0 12.16 -0.00 1.1905 -0.0336 -0.0130 0.0051 0.0038 0.5703 -0.0041 0.0074 0.0018 0.0051
82.5 82.5 101270 82 392 -57 -55 261.2 -11.3 -6.3 1.8 0.3 1.79 -1.50 -0.77 0.40 0.34 -0.8 4.0 2.6 -0.4 1.9 8.58 -0.00 1.1899 -0.0342 -0.0130 0.0050 0.0038 0.5729 -0.0014 0.0095 0.0025 0.0059
82.5 97.5 101329 185 420 -61 -40 260.7 -11.9 -6.3 1.6 0.1 1.76 -1.55 -0.76 0.40 0.33 -0.3 5.0 2.8 -0.1 1.9 6.42 -0.00 1.1894 -0.0347 -0.0130 0.0049 0.0036 0.5748 0.0016 0.0112 0.0028 0.0065
82.5 112.5 101393 273 445 -81 -37 260.4 -12.4 -6.4 1.6 0.0 1.74 -1.59 -0.76 0.40 0.32 -0.1 5.2 3.3 -0.2 2.0 6.03 -0.00 1.1893 -0.0349 -0.0129 0.0048 0.0034 0.5763 0.0037 0.0119 0.0039 0.0064
82.5 127.5 101461 336 460 -116 -48 260.5 -12.4 -6.3 1.5 0.1 1.73 -1.60 -0.75 0.40 0.31 -0.3 5.1 3.1 -0.2 1.8 4.83 -0.00 1.1894 -0.0349 -0.0127 0.0047 0.0032 0.5772 0.0053 0.0110 0.0037 0.0058
82.5 142.5 101531 376 471 -149 -65 260.4 -12.6 -6.2 1.4 0.0 1.73 -1.62 -0.74 0.39 0.29 -0.1 5.4 3.1 0.1 1.7 7.02 0.00 1.1898 -0.0347 -0.0126 0.0047 0.0030 0.5787 0.0074 0.0101 0.0035 0.0056
82.5 157.5 101599 393 477 -182 -84 260.3 -12.7 -6.2 1.5 -0.0 1.72 -1.63 -0.73 0.40 0.29 0.2 5.5 3.1 0.0 1.7 3.81 0.00 1.1902 -0.0346 -0.0124 0.0047 0.0030 0.5812 0.0081 0.0100 0.0037 0.0056
82.5 172.5 101664 387 480 -208 -107 260.2 -12.7 -6.2 1.6 0.0 1.71 -1.63 -0.73 0.41 0.29 0.5 5.3 3.1 -0.1 1.6 4.40 0.00 1.1906 -0.0344 -0.0123 0.0048 0.0030 0.5831 0.0088 0.0106 0.0040 0.0052
82.5 -172.5 101719 361 471 -220 -134 260.0 -12.9 -6.2 1.7 0.1 1.69 -1.64 -0.72 0.43 0.30 1.0 5.4 3.1 0.0 1.4 5.02 0.00 1.1907 -0.0344 -0.0122 0.0049 0.0030 0.5840 0.0095 0.0111 0.0037 0.0047
82.5 -157.5 101751 314 444 -226 -158 259.6 -13.1 -6.2 1.9 0.0 1.66 -1.65 -0.70 0.45 0.32 1.5 5.8 2.7 -0.1 1.4 5.29 0.00 1.1905 -0.0345 -0.0122 0.0050 0.0029 0.5844 0.0100 0.0113 0.0034 0.0040
82.5 -142.5 101749 254 409 -227 -176 259.1 -13.4 -6.3 2.0 0.0 1.62 -1.65 -0.69 0.47 0.33 1.9 5.8 2.6 -0.2 1.5 4.69 0.00 1.1902 -0.0346 -0.0123 0.0050 0.0029 0.5851 0.0110 0.0102 0.0027 0.0033
82.5 -127.5 101709 193 382 -225 -183 258.9 -13.6 -6.4 2.1 0.1 1.61 -1.65 -0.70 0.48 0.34 1.9 5.7 2.4 0.0 1.3 5.35 0.00 1.1897 -0.0347 -0.0125 0.0050 0.0029 0.5849 0.0117 0.0092 0.0018 0.0028
82.5 -112.5 101652 136 368 -223 -178 258.4 -14.0 -6.7 2.3 0.1 1.59 -1.67 -0.71 0.49 0.36 2.3 6.1 2.4 -0.1 1.3 6.59 0.00 1.1892 -0.0349 -0.0128 0.0050 0.0030 0.5847 0.0130 0.0107 0.0003 0.0026
82.5 -97.5 101600 99 361 -232 -166 257.8 -14.5 -6.9 2.6 0.3 1.56 -1.69 -0.71 0.54 0.39 4.0 6.3 1.8 -0.4 1.3 11.67 -0.00 1.1888 -0.0353 -0.0131 0.0051 0.0031 0.5861 0.0148 0.0122 -0.0010 0.0036
82.5 -82.5 99050 -81 258 -220 -167 261.1 -13.2 -6.2 2.6 1.0 1.34 -1.58 -0.65 0.61 0.49 -4.5 0.6 -0.0 0.4 0.3 17.64 188.83 1.1891 -0.0355 -0.0130 0.0052 0.0033 0.5868 0.0208 0.0126 -0.0033 0.0012
82.5 -67.5 92840 -376 108 -149 -128 258.9 -13.0 -6.0 2.8 1.2 1.43 -1.52 -0.65 0.58 0.47 0.6 2.6 1.6 -0.4 0.3 20.20 681.12 1.1898 -0.0352 -0.0126 0.0052 0.0036 0.5490 0.0095 0.0071 -0.0012 0.0009
82.5 -52.5 100915 4 312 -252 -156 259.8 -14.5 -6.4 3.4 0.9 1.38 -1.60 -0.56 0.63 0.39 1.1 2.9 0.4 -1.2 0.7 20.43 48.17 1.1896 -0.0356 -0.0132 0.0055 0.0035 0.5980 0.0257 0.0115 -0.0028 0.0041
82.5 -37.5 90881 -488 62 -120 -103 260.1 -12.2 -5.0 3.0 1.4 1.26 -1.31 -0.50 0.51 0.35 -2.4 2.4 1.1 0.1 0.1 29.76 844.30 1.1910 -0.0345 -0.0122 0.0053 0.0037 0.5483 0.0121 0.0052 -0.0031 0.0012
82.5 -22.5 101250 -34 332 -257 -148 260.7 -13.3 -5.8 3.4 1.0 1.45 -1.62 -0.54 0.66 0.36 -4.1 0.4 0.7 -0.8 0.3 28.54 19.42 1.1908 -0.0345 -0.0129 0.0056 0.0036 0.5972 0.0218 0.0091 -0.0055 0.0025
82.5 -7.5 101382 -142 323 -212 -129 260.2 -12.1 -5.3 2.7 0.5 1.72 -1.56 -0.60 0.52 0.32 1.2 3.4 0.9 -0.5 1.5 29.74 -0.00 1.1917 -0.0332 -0.0127 0.0054 0.0035 0.5806 0.0074 0.0052 -0.0033 0.0029
67.5 7.5 100811 -511 83 -19 -49 279.3 -3.4 -2.5 0.2 0.8 4.84 -1.37 -1.03 0.17 0.48 -7.7 -1.6 -0.3 0.5 0.1 42.63 0.00 1.2163 -0.0233 -0.0107 0.0016 0.0024 0.5424 -0.0260 -0.0133 0.0031 0.0034
67.5 22.5 97486 -333 54 -41 -22 275.0 -10.7 -3.7 1.2 0.5 3.88 -2.39 -1.28 0.47 0.65 -3.8 4.0 0.2 0.5 0.3 27.29 287.37 1.2139 -0.0278 -0.0121 0.0025 0.0021 0.5404 -0.0120 -0.0081 0.0023 0.0028
67.5 37.5 98191 -322 75 -1 -9 273.8 -9.8 -4.4 1.1 0.4 3.74 -2.18 -1.38 0.40 0.60 -4.8 2.7 0.7 0.4 0.7 16.14 232.51 1.2117 -0.0294 -0.0129 0.0030 0.0020 0.5443 -0.0165 -0.0058 0.0044 0.0027
67.5 52.5 100337 -98 156 15 6 271.9 -11.8 -5.9 0.8 0.2 3.50 -2.46 -1.51 0.41 0.65 -3.1 4.1 1.7 0.8 1.1 2.81 61.95 1.2091 -0.0315 -0.0136 0.0035 0.0021 0.5578 -0.0111 -0.0021 0.0067 0.0048
67.5 67.5 99392 68 181 40 21 268.4 -14.2 -6.9 0.9 0.9 3.02 -2.67 -1.40 0.56 0.71 -1.6 6.4 2.3 1.4 0.8 -6.67 142.69 1.2057 -0.0337 -0.0142 0.0041 0.0025 0.5616 0.0006 0.0030 0.0068 0.0020
67.5 82.5 100480 411 194 89 30 266.7 -17.7 -7.3 0.9 1.4 2.97 -2.93 -1.36 0.66 0.80 0.2 7.8 2.8 2.0 0.4 -15.39 59.97 1.2032 -0.0366 -0.0146 0.0046 0.0031 0.5671 0.0089 0.0015 0.0099 0.0018
67.5 97.5 92001 85 -10 120 67 264.1 -17.9 -6.3 1.5 1.2 2.60 -2.92 -1.13 0.81 0.77 -1.5 7.9 1.6 2.3 0.7 -17.15 763.19 1.2004 -0.0393 -0.0147 0.0055 0.0036 0.5364 0.0131 -0.0014 0.0081 0.0049
67.5 112.5 96927 410 83 81 75 264.7 -20.9 -5.9 0.8 0.9 2.60 -2.99 -1.16 0.80 0.84 -0.5 9.4 1.0 3.7 1.1 -14.17 358.33 1.1999 -0.0413 -0.0145 0.0059 0.0038 0.5612 0.0136 0.0004 0.0137 0.0054
67.5 127.5 88256 -162 -101 71 75 262.9 -18.3 -5.1 2.0 1.2 2.36 -2.79 -0.96 0.89 0.77 -0.8 8.2 0.8 1.7 0.5 -7.23 1084.25 1.2002 -0.0411 -0.0137 0.0063 0.0041 0.5212 0.0073 -0.0026 0.0093 0.0048
67.5 142.5 97004 438 124 -19 52 265.3 -20.6 -5.9 1.5 0.5 2.52 -3.14 -1.04 0.96 0.78 -1.7 6.3 0.7 1.2 0.2 2.48 358.01 1.2020 -0.0407 -0.0135 0.0056 0.0033 0.5726 0.0241 0.0017 0.0109 0.0071
67.5 157.5 98639 507 207 -17 56 265.2 -21.5 -6.2 0.2 -0.2 2.52 -2.89 -1.09 0.66 0.68 1.9 12.1 1.9 4.9 1.7 6.34 226.33 1.2042 -0.0376 -0.0129 0.0048 0.0032 0.5751 0.0172 0.0046 0.0109 0.0086
67.5 172.5 95382 64 176 -40 20 265.7 -16.4 -6.2 1.6 0.6 2.64 -2.77 -1.14 0.72 0.63 -0.8 8.2 2.6 1.9 2.0 6.74 486.17 1.2060 -0.0329 -0.0119 0.0049 0.0041 0.5533 0.0103 0.0086 0.0048 0.0095
67.5 -172.5 101325 42 390 -17 50 267.6 -12.0 -8.1 0.5 -0.6 2.75 -2.11 -1.32 0.35 0.44 -2.6 -0.8 3.0 2.3 1.8 2.05 -0.00 1.2077 -0.0298 -0.0118 0.0046 0.0037 0.5729 -0.0013 0.0129 0.0078 0.0118
67.5 -157.5 95027 -324 197 15 76 269.1 -14.6 -4.7 2.1 0.7 2.99 -2.86 -1.08 0.84 0.61 -2.7 4.9 0.9 0.4 0.3 5.63 496.39 1.2106 -0.0285 -0.0101 0.0052 0.0035 0.5449 0.0057 0.0020 0.0041 0.0046
67.5 -142.5 95374 -155 228 -11 88 268.8 -17.2 -4.7 2.0 0.2 2.89 -3.00 -1.06 0.82 0.59 -1.8 6.5 0.7 1.7 0.6 7.47 481.73 1.2114 -0.0293 -0.0105 0.0053 0.0028 0.5538 0.0169 0.0025 0.0050 0.0051
67.5 -127.5 97957 9 318 -33 59 267.2 -17.3 -6.8 1.9 0.2 2.67 -2.68 -1.18 0.62 0.60 0.5 8.9 2.6 1.9 1.4 -5.79 284.22 1.2097 -0.0299 -0.0120 0.0048 0.0024 0.5685 0.0176 0.0063 0.0049 0.0069
67.5 -112.5 99347 37 348 -71 -33 266.0 -14.7 -7.3 1.4 1.3 2.36 -2.34 -1.21 0.49 0.69 -4.0 1.0 1.1 0.7 -0.1 -24.21 180.21 1.2054 -0.0310 -0.0133 0.0038 0.0028 0.5752 0.0169 0.0097 0.0049 0.0048
67.5 -97.5 101033 104 409 -145 -83 262.4 -17.7 -9.4 0.9 0.4 2.21 -2.33 -1.29 0.50 0.75 0.1 7.6 3.1 2.3 2.1 -34.87 37.36 1.2014 -0.0329 -0.0147 0.0026 0.0026 0.5845 0.0171 0.0147 0.0014 0.0063
67.5 -82.5 98675 -156 286 -178 -78 263.4 -14.7 -8.3 0.9 0.3 2.15 -2.06 -1.19 0.41 0.54 -0.5 4.4 2.2 1.4 1.9 -26.50 195.61 1.2005 -0.0331 -0.0147 0.0019 0.0022 0.5707 0.0087 0.0128 0.0013 0.0073
67.5 -67.5 91791 -528 42 -152 -90 263.4 -12.2 -7.0 1.3 0.4 2.09 -1.89 -1.05 0.45 0.52 -0.3 3.1 3.3 0.0 0.9 0.69 749.61 1.2019 -0.0319 -0.0132 0.0017 0.0018 0.5426 0.0025 0.0095 -0.0029 0.0043
67.5 -52.5 97432 -491 103 -147 -121 270.6 -9.5 -5.1 2.0 0.1 2.63 -1.97 -0.87 0.52 0.35 -4.2 2.0 0.4 -0.2 0.6 28.08 276.78 1.2069 -0.0286 -0.0117 0.0024 0.0014 0.5574 -0.0027 0.0028 -0.0019 0.0032
67.5 -37.5 72078 -984 -199 48 -56 259.3 -7.8 -2.9 1.6 0.8 1.35 -0.85 -0.32 0.25 0.20 -3.5 1.2 -0.1 -0.6 -0.1 53.57 2643.97 1.2071 -0.0275 -0.0102 0.0017 0.0019 0.4652 -0.0060 -0.0074 -0.0008 -0.0031
67.5 -22.5 100916 -512 142 -83 -148 274.0 -3.6 -2.9 0.6 0.7 3.67 -1.15 -0.76 0.27 0.37 -4.6 -3.6 -0.2 1.8 0.9 61.84 -0.02 1.2131 -0.0228 -0.0097 0.0021 0.0022 0.5616 -0.0176 -0.0082 -0.0016 0.0009
67.5 -7.5 100825 -532 124 -10 -81 276.7 -3.0 -2.8 0.2 0.9 4.29 -1.16 -0.93 0.15 0.42 -6.6 -1.7 0.4 0.6 -0.2 54.98 -0.00 1.2152 -0.0219 -0.0100 0.0014 0.0024 0.5482 -0.0215 -0.0108 0.0012 0.0017
52.5 7.5 101113 -10 -13 24 -7 283.7 -7.7 -2.8 -0.2 0.3 6.32 -2.39 -1.42 0.20 0.38 -5.0 1.0 -0.2 0.3 -0.1 42.83 35.28 1.2358 -0.0195 -0.0104 0.0006 0.0011 0.5568 -0.0135 -0.0121 0.0031 0.0013
52.5 22.5 99832 60 -78 -21 -20 282.1 -10.9 -3.2 -0.0 0.0 5.81 -3.14 -1.45 0.50 0.40 -5.0 1.7 -0.2 -0.3 0.2 29.59 143.43 1.2336 -0.0237 -0.0114 0.0012 0.0005 0.5564 -0.0094 -0.0103 0.0045 0.0022
52.5 37.5 99397 209 -93 -59 -46 280.8 -13.6 -3.9 0.0 -0.3 5.35 -3.45 -1.40 0.60 0.41 -4.8 1.8 0.4 0.0 0.7 12.60 184.72 1.2320 -0.0268 -0.0123 0.0015 0.0008 0.5622 -0.0049 -0.0109 0.0056 0.0029
52.5 52.5 99970 505 -61 -77 -57 279.8 -16.3 -4.5 -0.4 -0.4 4.72 -3.39 -1.15 0.56 0.37 -3.5 4.0 1.0 0.3 0.9 -4.50 148.66 1.2316 -0.0289 -0.0120 0.0010 0.0006 0.5698 0.0012 -0.0082 0.0032 0.0017
52.5 67.5 98245 635 11 -104 -70 278.3 -16.4 -4.2 -0.7 -0.7 4.21 -3.28 -0.98 0.58 0.32 -2.0 5.3 1.0 1.3 0.8 -25.30 298.82 1.2297 -0.0295 -0.0110 0.0004 -0.0001 0.5646 0.0074 -0.0073 0.0045 0.0035
52.5 82.5 99564 958 114 -106 -52 278.4 -16.6 -4.3 -0.9 -0.9 4.27 -3.63 -1.19 0.78 0.51 -3.2 3.4 0.6 1.8 0.9 -40.58 200.18 1.2276 -0.0313 -0.0110 0.0006 -0.0001 0.5703 0.0091 -0.0027 0.0064 0.0009
52.5 97.5 84614 242 -132 -72 -35 271.5 -15.6 -4.0 -0.0 0.3 3.30 -3.19 -1.06 0.77 0.61 -5.3 2.6 -0.1 1.6 0.2 -37.65 1516.58 1.2219 -0.0356 -0.0124 0.0028 0.0019 0.5107 0.0020 -0.0050 0.0094 0.0018
52.5 112.5 89324 365 -122 -35 43 272.5 -18.3 -4.4 -0.2 0.5 3.45 -3.52 -1.34 0.94 0.86 -4.5 3.7 -0.0 2.5 0.4 -23.29 1044.99 1.2198 -0.0397 -0.0135 0.0033 0.0028 0.5285 -0.0087 -0.0042 0.0094 0.0029
52.5 127.5 97719 667 -69 24 64 274.0 -21.0 -4.0 -1.5 0.5 3.93 -4.42 -1.55 1.12 1.10 -3.0 4.5 -0.2 1.4 1.0 7.96 293.46 1.2180 -0.0422 -0.0138 0.0025 0.0025 0.5650 -0.0013 -0.0061 0.0149 0.0025
52.5 142.5 99640 158 35 -4 10 273.4 -15.4 -6.6 -1.4 0.3 3.88 -3.43 -1.80 0.41 0.92 -4.3 0.3 0.7 1.9 0.1 18.53 116.21 1.2181 -0.0384 -0.0153 0.0019 0.0022 0.5626 -0.0230 -0.0029 0.0106 0.0055
52.5 157.5 95112 -576 -198 -97 -93 273.7 -9.1 -5.2 0.5 1.0 3.78 -2.28 -1.53 0.28 0.67 -5.1 -1.6 -0.3 1.4 0.1 24.73 469.56 1.2210 -0.0312 -0.0142 0.0023 0.0029 0.5385 -0.0374 -0.0054 0.0028 0.0031
52.5 172.5 100648 -677 -142 -140 -131 277.0 -3.5 -3.6 -0.5 0.8 4.31 -1.47 -1.28 -0.04 0.53 -7.5 -2.1 -0.6 0.7 0.8 1.96 6.97 1.2240 -0.0241 -0.0121 0.0017 0.0035 0.5555 -0.0436 -0.0092 0.0038 0.0042
52.5 -172.5 100726 -782 -85 -169 -66 277.6 -3.1 -3.1 -0.1 0.8 4.54 -1.34 -1.11 0.12 0.51 -7.4 -1.8 -0.4 0.8 0.7 7.31 0.00 1.2258 -0.0202 -0.0102 0.0021 0.0043 0.5584 -0.0380 -0.0077 0.0030 0.0067
52.5 -157.5 100773 -761 13 -94 86 278.8 -3.1 -3.4 -0.0 1.1 4.96 -1.39 -1.24 0.15 0.61 -7.2 -1.4 -0.0 0.8 0.4 11.07 0.00 1.2282 -0.0177 -0.0098 0.0021 0.0046 0.5607 -0.0306 -0.0083 0.0040 0.0078
52.5 -142.5 101014 -663 -15 -7 171 280.3 -2.4 -3.3 -0.1 1.0 5.46 -1.22 -1.27 0.11 0.57 -7.2 -1.0 -0.0 0.5 0.3 -1.16 0.00 1.2312 -0.0148 -0.0099 0.0019 0.0044 0.5640 -0.0218 -0.0115 0.0036 0.0078
52.5 -127.5 93713 -352 -69 6 103 278.8 -6.1 -2.8 0.5 1.2 4.70 -1.85 -1.16 0.21 0.54 -5.8 0.5 -0.3 0.3 0.2 -12.45 658.38 1.2326 -0.0169 -0.0105 0.0024 0.0042 0.5446 -0.0028 -0.0089 0.0007 0.0030
52.5 -112.5 92579 -64 -25 -6 86 279.1 -11.7 -4.1 0.2 0.5 4.27 -2.90 -1.18 0.65 0.66 -2.4 4.3 -0.2 1.4 -0.0 -20.16 753.56 1.2336 -0.0230 -0.0115 0.0023 0.0029 0.5488 0.0017 -0.0070 0.0027 0.0001
52.5 -97.5 98802 206 173 -50 64 276.1 -16.3 -6.0 -0.9 -0.5 4.43 -3.80 -1.84 0.53 0.84 -3.5 1.9 1.0 0.8 0.3 -32.73 222.14 1.2282 -0.0292 -0.0133 0.0009 0.0012 0.5755 0.0104 0.0024 0.0067 0.0047
52.5 -82.5 101196 176 253 -124 25 274.2 -15.3 -7.1 -0.9 -1.0 3.77 -3.05 -1.90 0.31 0.68 -4.4 -0.4 0.6 0.6 0.4 -43.62 20.24 1.2237 -0.0310 -0.0145 -0.0001 -0.0002 0.5914 0.0069 0.0098 0.0032 0.0067
52.5 -67.5 93782 -314 -75 -166 -94 271.9 -14.6 -6.7 -0.2 -0.9 3.63 -2.91 -1.60 0.38 0.53 -5.0 2.8 1.2 1.1 0.6 -21.65 618.60 1.2229 -0.0290 -0.0144 -0.0002 -0.0005 0.5567 0.0060 0.0028 0.0000 0.0033
52.5 -52.5 100978 -417 -88 -171 -202 275.6 -5.3 -4.8 -0.3 0.5 4.14 -1.68 -1.42 0.07 0.52 -2.8 -6.8 -1.1 1.9 0.3 17.12 0.00 1.2274 -0.0233 -0.0135 0.0003 0.0006 0.5787 -0.0150 -0.0081 -0.0018 -0.0027
52.5 -37.5 100982 -490 -174 -59 -139 281.0 -2.7 -2.7 -0.2 0.4 5.63 -1.31 -1.14 0.06 0.35 -7.4 -0.9 -0.3 0.4 0.3 52.75 0.00 1.2328 -0.0173 -0.0110 0.0006 0.0017 0.5651 -0.0208 -0.0129 0.0033 0.0025
52.5 -22.5 101206 -244 -48 22 -8 283.8 -2.0 -2.1 0.0 0.5 6.53 -1.14 -1.03 0.08 0.32 -8.2 -0.3 -0.2 0.0 0.2 61.33 0.00 1.2362 -0.0141 -0.0095 0.0007 0.0021 0.5606 -0.0187 -0.0123 0.0025 0.0031
52.5 -7.5 99974 -97 6 37 44 283.4 -4.3 -2.4 0.1 0.4 6.51 -1.57 -1.22 0.09 0.31 -6.7 0.8 -0.1 0.2 -0.1 56.87 120.83 1.2366 -0.0154 -0.0097 0.0005 0.0018 0.5517 -0.0162 -0.0132 0.0011 0.0026
37.5 7.5 101620 177 17 66 44 292.5 -5.6 -3.9 -0.0 0.5 9.28 -2.90 -2.02 -0.08 0.50 -4.8 -3.3 0.1 0.7 -0.1 42.97 0.00 1.2578 -0.0186 -0.0102 0.0013 0.0019 0.5632 -0.0209 -0.0114 -0.0021 -0.0023
37.5 22.5 95757 146 -84 -14 -82 289.3 -7.8 -4.0 0.5 0.5 7.68 -2.00 -1.79 0.01 0.16 -6.0 -0.2 0.2 -0.2 -0.2 31.66 495.02 1.2550 -0.0195 -0.0110 0.0012 0.0014 0.5316 -0.0057 -0.0032 -0.0057 -0.0075
37.5 37.5 88824 335 -69 -39 -145 287.6 -10.3 -4.9 -0.6 0.5 5.59 -1.99 -0.95 -0.14 0.30 -6.4 0.4 -0.1 0.5 0.4 31.30 1114.27 1.2560 -0.0239 -0.0133 0.0011 0.0030 0.5040 0.0083 0.0009 -0.0025 -0.0076
37.5 52.5 101535 648 87 -42 -152 291.4 -6.9 -4.7 -0.5 0.4 8.95 -3.76 -2.88 0.34 0.65 -4.4 -1.4 1.3 -0.1 -0.3 -10.95 -0.00 1.2595 -0.0235 -0.0112 -0.0001 0.0017 0.5797 -0.0241 0.0032 -0.0018 0.0016
37.5 67.5 94606 790 43 -97 -166 292.7 -12.3 -3.6 -0.9 0.2 6.25 -2.57 0.29 0.07 -0.17 -6.0 2.5 0.1 1.1 -0.0 -40.60 594.09 1.2605 -0.0257 -0.0095 -0.0003 0.0013 0.5467 -0.0017 0.0001 0.0022 -0.0027
37.5 82.5 87775 665 -89 -57 -143 289.6 -13.9 -2.7 -2.3 0.1 2.63 -1.53 -0.50 0.28 0.28 -5.0 2.3 -0.1 0.4 0.1 -53.38 1221.77 1.2610 -0.0278 -0.0090 -0.0006 0.0019 0.6026 -0.0327 -0.0057 0.0036 0.0094
37.5 97.5 60519 -401 -314 -107 -66 269.5 -10.6 -3.2 -0.5 1.0 2.27 -1.98 -0.74 0.42 0.63 -7.4 0.7 -0.2 0.4 -0.0 -48.57 4252.68 1.2508 -0.0285 -0.0112 0.0011 0.0040 0.4396 -0.0174 -0.0091 0.0021 0.0009
37.5 112.5 88423 544 -161 -113 -44 283.3 -13.0 -2.8 -1.0 -0.1 5.46 -4.58 -2.17 0.60 1.38 -5.1 0.8 -0.1 -0.1 -0.2 -17.76 1171.24 1.2513 -0.0287 -0.0105 -0.0003 0.0021 0.5435 -0.0211 -0.0035 0.0065 0.0095
37.5 127.5 98175 690 -31 -82 -34 284.2 -12.5 -4.8 -1.3 0.1 6.71 -5.31 -2.72 0.66 1.45 -5.7 0.4 -0.0 -0.0 -0.3 24.85 288.58 1.2487 -0.0284 -0.0132 -0.0011 0.0019 0.5685 -0.0313 -0.0071 0.0057 0.0182
37.5 142.5 101393 319 -16 -156 -77 287.4 -6.7 -5.6 -0.6 0.2 8.21 -4.61 -3.18 0.22 1.08 -7.0 -3.4 0.0 0.5 -0.1 27.42 0.00 1.2510 -0.0249 -0.0154 -0.0013 0.0005 0.5830 -0.0498 -0.0191 -0.0048 0.0067
37.5 157.5 101425 -120 -147 -223 -169 288.1 -5.0 -5.7 -0.9 0.4 8.79 -3.45 -3.24 -0.14 0.96 -8.5 -1.6 -0.2 0.4 0.0 1.14 0.00 1.2534 -0.0203 -0.0151 -0.0022 -0.0007 0.5882 -0.0417 -0.0165 -0.0061 -0.0052
37.5 172.5 101572 -396 -181 -269 -172 288.5 -3.8 -4.8 -0.6 0.7 8.94 -2.85 -2.79 -0.05 0.86 -8.1 -1.6 -0.0 0.6 0.1 -12.72 0.00 1.2548 -0.0169 -0.0126 -0.0019 -0.0002 0.5897 -0.0353 -0.0102 -0.0033 -0.0044
37.5 -172.5 101756 -534 -104 -257 -80 288.4 -3.4 -4.3 -0.4 1.2 8.87 -2.53 -2.46 0.04 1.05 -7.8 -1.2 0.2 0.5 0.1 -12.29 0.00 1.2549 -0.0150 -0.0103 -0.0009 0.0011 0.5887 -0.0273 -0.0070 -0.0017 -0.0037
37.5 -157.5 101958 -529 -47 -174 5 288.3 -2.9 -4.2 -0.4 1.0 8.85 -2.03 -2.24 -0.00 0.75 -7.7 -0.8 0.4 0.5 -0.1 -15.18 0.00 1.2554 -0.0128 -0.0095 -0.0003 0.0010 0.5883 -0.0215 -0.0052 0.0001 -0.0077
37.5 -142.5 102172 -371 -24 -99 -17 288.5 -1.8 -3.6 -0.2 0.6 8.64 -1.33 -1.79 0.09 0.44 -8.2 -0.5 0.3 0.4 -0.1 -30.28 0.00 1.2561 -0.0107 -0.0091 0.0003 0.0007 0.5800 -0.0139 0.0012 0.0038 -0.0078
37.5 -127.5 101969 35 93 4 -67 286.5 -1.0 -2.7 -0.1 0.3 7.87 -0.67 -1.41 0.02 0.32 -6.9 0.4 0.4 0.0 -0.0 -38.40 0.00 1.2576 -0.0123 -0.0101 0.0013 0.0017 0.5660 -0.0039 0.0048 0.0044 -0.0118
37.5 -112.5 78277 -145 -238 71 80 283.2 -11.0 -4.3 0.4 1.1 3.62 -1.14 -0.93 -0.03 0.75 -6.6 2.7 -0.1 1.1 0.0 -20.68 2190.97 1.2569 -0.0202 -0.0117 0.0023 0.0027 0.4966 -0.0166 -0.0091 0.0182 -0.0007
37.5 -97.5 96791 222 -86 59 87 288.6 -12.1 -4.0 -0.7 0.2 7.37 -5.00 -1.69 0.52 0.55 -4.6 2.6 0.0 1.2 0.0 -28.70 410.88 1.2590 -0.0212 -0.0103 0.0004 0.0009 0.5684 -0.0023 -0.0077 0.0096 0.0090
37.5 -82.5 97220 77 -93 20 18 287.5 -10.5 -3.7 -1.0 -0.3 7.69 -4.40 -1.88 0.42 0.64 -5.6 0.1 -0.4 0.1 -0.1 -32.48 388.87 1.2559 -0.0198 -0.0106 -0.0004 0.0002 0.5659 -0.0037 -0.0035 0.0104 0.0040
37.5 -67.5 101660 -45 -79 -5 -15 291.6 -5.7 -4.3 0.0 0.1 9.96 -3.65 -2.42 0.53 0.57 -9.4 -0.7 0.0 0.1 -0.2 -39.75 0.00 1.2572 -0.0162 -0.0114 0.0003 0.0002 0.5777 -0.0212 -0.0106 0.0061 0.0056
37.5 -52.5 101805 -269 -140 74 -16 292.2 -3.4 -3.9 0.1 0.7 10.52 -2.73 -2.33 0.44 0.68 -9.0 -0.7 0.1 0.4 -0.1 -9.77 0.00 1.2585 -0.0130 -0.0108 0.0006 0.0009 0.5768 -0.0225 -0.0108 0.0057 0.0028
37.5 -37.5 102034 -276 -50 131 21 292.0 -2.4 -3.3 0.1 0.8 10.31 -1.85 -2.02 0.19 0.58 -8.7 -0.3 0.2 0.2 -0.1 38.00 0.00 1.2589 -0.0108 -0.0095 0.0009 0.0015 0.5716 -0.0160 -0.0092 0.0027 0.0001
37.5 -22.5 102106 -116 12 152 49 290.9 -1.9 -2.8 -0.0 0.7 9.57 -1.37 -1.58 0.09 0.50 -8.8 -0.1 0.2 0.2 -0.0 50.71 0.00 1.2576 -0.0106 -0.0087 0.0012 0.0018 0.5615 -0.0127 -0.0079 0.0021 -0.0023
37.5 -7.5 99636 216 34 117 36 290.7 -5.7 -3.0 -0.1 0.9 8.22 -1.48 -1.33 -0.22 0.29 -5.0 -1.1 -0.6 0.9 0.6 54.00 178.43 1.2585 -0.0159 -0.0094 0.0017 0.0030 0.5469 -0.0068 -0.0109 -0.0011 -0.0020
22.5 7.5 89835 197 -64 39 20 299.3 -8.2 -1.8 -1.5 -0.5 3.46 -0.82 -0.97 -0.09 0.13 -7.1 0.9 0.2 0.3 -0.0 32.55 1043.35 1.2810 -0.0115 -0.0034 -0.0006 0.0001 0.5939 -0.0111 0.0128 -0.0014 -0.0056
22.5 22.5 95718 391 -1 55 -20 298.9 -8.2 -1.6 -1.4 -0.3 4.20 -0.74 -1.33 -0.04 0.14 -0.7 1.2 0.3 -0.4 -0.3 15.27 495.56 1.2814 -0.0114 -0.0036 -0.0004 0.0003 0.5778 -0.0019 0.0295 -0.0073 -0.0055
22.5 37.5 100866 574 147 15 -53 300.9 -4.0 -2.9 0.1 -0.0 14.62 -2.80 -2.55 -1.07 -0.04 -0.9 -7.8 0.2 -0.4 -0.8 6.47 0.00 1.2850 -0.0121 -0.0048 -0.0001 0.0009 0.5744 -0.0542 -0.0167 0.0016 0.0084
22.5 52.5 99886 985 187 -61 -136 303.7 -9.7 -2.5 -1.3 -0.5 7.48 -0.50 -1.69 0.04 0.32 -2.7 0.6 0.1 0.5 0.3 -33.13 82.37 1.2864 -0.0147 -0.0043 -0.0002 0.0006 0.5857 -0.0402 0.0188 0.0041 0.0168
22.5 67.5 100875 756 103 -67 -33 299.1 -2.7 -1.1 -0.2 -1.1 15.97 -4.65 -0.68 -1.27 -0.76 -5.7 1.9 1.4 -2.8 -0.4 -50.06 0.00 1.2827 -0.0081 -0.0020 -0.0010 -0.0017 0.5622 -0.0496 -0.0197 0.0157 0.0249
22.5 82.5 95697 718 17 -15 -30 299.7 -4.5 2.6 -2.4 -2.0 11.86 -4.85 -3.71 0.35 1.42 -5.5 1.3 0.1 0.2 0.0 -60.13 449.47 1.2827 -0.0079 -0.0006 -0.0011 -0.0023 0.5789 -0.0687 -0.0150 0.0009 0.0148
22.5 97.5 89345 387 -17 -29 -58 294.4 -1.9 1.0 -1.9 -0.1 12.65 -4.16 -2.66 0.28 -0.53 -6.1 -1.7 -1.1 0.2 -0.1 -42.81 1056.91 1.2806 -0.0068 -0.0023 -0.0007 -0.0004 0.5548 -0.0733 -0.0300 -0.0048 0.0021
22.5 112.5 99313 739 109 -3 -75 295.2 -6.0 -2.4 -1.1 -0.4 12.97 -5.77 -0.98 -0.38 0.41 -5.9 0.6 0.5 0.2 0.3 -8.41 167.74 1.2784 -0.0076 -0.0035 -0.0006 -0.0005 0.6079 -0.0429 -0.0106 -0.0031 -0.0062
22.5 127.5 101264 517 237 51 -17 298.3 -3.2 -2.1 -0.2 -0.4 15.18 -3.66 -1.77 -0.28 -0.28 -9.0 -0.3 0.2 -0.2 -0.1 32.14 -0.00 1.2789 -0.0057 -0.0033 -0.0003 -0.0006 0.6071 -0.0346 -0.0149 -0.0011 -0.0060
22.5 142.5 101326 264 217 36 -0 299.0 -2.2 -2.0 -0.0 -0.8 15.38 -2.65 -2.12 -0.36 -0.83 -9.3 -0.1 -0.0 -0.1 -0.1 45.92 -0.00 1.2793 -0.0037 -0.0031 0.0001 -0.0009 0.5979 -0.0311 -0.0196 0.0009 -0.0015
22.5 157.5 101451 111 143 -13 -19 299.0 -1.6 -1.7 0.0 -0.6 15.12 -1.90 -1.87 -0.18 -0.46 -9.3 -0.1 -0.0 -0.1 -0.0 20.60 -0.00 1.2788 -0.0023 -0.0028 0.0003 -0.0010 0.5834 -0.0359 -0.0216 0.0027 0.0070
22.5 172.5 101564 11 109 -27 -7 298.5 -1.3 -1.6 0.0 -0.1 14.48 -1.60 -1.58 -0.08 -0.10 -9.4 -0.1 0.0 -0.0 0.0 2.38 -0.00 1.2773 -0.0018 -0.0028 0.0006 -0.0005 0.5695 -0.0311 -0.0219 0.0014 0.0045
22.5 -172.5 101651 -55 106 -25 13 297.8 -1.3 -1.6 0.1 -0.1 13.86 -1.27 -1.36 -0.02 -0.15 -9.4 -0.1 0.0 -0.0 -0.0 5.64 -0.00 1.2755 -0.0022 -0.0031 0.0007 -0.0001 0.5611 -0.0176 -0.0163 -0.0016 -0.0044
22.5 -157.5 101704 -54 97 -12 -5 297.2 -0.9 -1.5 0.0 -0.2 13.62 -0.92 -1.25 -0.01 -0.21 -9.2 -0.0 0.0 -0.0 0.0 4.02 -0.00 1.2743 -0.0032 -0.0039 0.0006 0.0000 0.5504 -0.0024 -0.0061 -0.0015 -0.0040
22.5 -142.5 101870 34 128 1 -50 294.7 -0.5 -1.3 -0.1 0.0 11.55 -0.58 -1.03 0.07 0.11 -9.4 0.0 -0.0 0.0 0.0 -19.90 -0.00 1.2733 -0.0049 -0.0047 0.0006 0.0005 0.5425 -0.0013 -0.0015 0.0006 -0.0019
22.5 -127.5 101798 179 182 20 -57 292.2 -0.3 -1.8 -0.2 0.2 10.23 -0.89 -1.39 0.11 0.36 -9.3 -0.4 -0.2 0.2 0.2 -42.21 -0.00 1.2742 -0.0065 -0.0050 0.0002 0.0002 0.5527 -0.0130 -0.0050 0.0006 0.0076
22.5 -112.5 101368 233 160 76 -9 294.0 -0.3 -3.4 -0.5 0.9 12.64 -2.04 -2.27 -0.59 0.62 -4.0 -3.6 2.4 0.4 -0.8 -38.71 -0.00 1.2787 -0.0069 -0.0037 -0.0005 -0.0008 0.5929 -0.0338 -0.0017 0.0019 0.0164
22.5 -97.5 101424 314 -9 130 56 297.8 -3.9 -1.7 -0.6 -0.3 14.77 -3.53 -1.04 -0.38 -0.08 -7.7 0.4 0.5 -0.2 0.0 -18.40 3.32 1.2777 -0.0058 -0.0021 -0.0011 -0.0005 0.5903 -0.0233 -0.0184 -0.0017 0.0110
22.5 -82.5 101332 142 123 126 61 299.1 -2.5 -1.5 -0.3 -0.0 14.92 -2.60 -1.69 -0.13 0.20 -8.1 -0.1 0.2 -0.0 0.0 -19.52 19.27 1.2778 -0.0036 -0.0027 -0.0004 -0.0001 0.5829 -0.0357 -0.0280 0.0026 0.0049
22.5 -67.5 101669 1 139 134 90 299.0 -1.4 -1.7 0.0 0.0 14.92 -1.66 -1.62 -0.05 -0.04 -9.4 -0.2 0.0 0.0 -0.1 -50.80 -0.00 1.2765 -0.0029 -0.0031 0.0000 0.0002 0.5755 -0.0305 -0.0214 -0.0037 -0.0075
22.5 -52.5 101808 -77 149 128 83 298.1 -1.0 -1.7 -0.0 0.0 13.95 -1.31 -1.72 -0.21 0.07 -9.4 -0.1 -0.0 -0.0 -0.0 -35.60 -0.00 1.2750 -0.0034 -0.0034 -0.0000 0.0006 0.5639 -0.0207 -0.0223 -0.0097 -0.0095
22.5 -37.5 101875 -69 145 82 56 296.7 -0.7 -1.8 -0.2 -0.1 12.74 -0.98 -1.99 -0.21 0.02 -9.5 -0.1 -0.1 -0.0 0.0 0.50 -0.00 1.2740 -0.0052 -0.0041 0.0000 0.0009 0.5546 -0.0149 -0.0283 -0.0026 -0.0064
22.5 -22.5 101714 74 99 67 -7 294.8 -0.5 -2.0 -0.3 -0.2 12.37 -1.31 -2.22 -0.49 0.38 -8.1 -0.4 -0.3 -0.4 0.5 24.23 -0.00 1.2757 -0.0079 -0.0047 0.0002 0.0009 0.5615 -0.0299 -0.0373 0.0016 0.0035
22.5 -7.5 96968 404 55 73 -26 302.4 -8.7 -3.1 -1.3 0.8 4.62 -1.08 -1.42 -0.21 0.43 -6.3 0.1 0.0 1.1 0.3 30.61 373.24 1.2824 -0.0127 -0.0047 -0.0004 0.0010 0.6140 -0.0240 -0.0098 0.0015 -0.0016
7.5 7.5 98675 -141 -129 62 40 299.8 2.1 1.8 -0.0 -0.3 15.40 -2.45 -0.32 -1.60 -0.83 -5.8 1.4 -0.6 0.6 -0.2 22.93 207.44 1.2834 0.0023 0.0018 0.0002 -0.0004 0.6131 -0.0348 -0.0123 -0.0074 0.0046
7.5 22.5 92650 -106 -104 68 15 298.4 2.5 2.0 -0.3 -0.0 12.67 -4.36 -1.09 -1.66 -1.05 -4.5 1.7 -0.1 0.6 -0.6 -2.89 751.24 1.2848 0.0022 0.0021 -0.0003 -0.0001 0.5912 -0.0247 -0.0082 -0.0032 0.0065
7.5 37.5 81555 -55 -36 31 11 291.4 1.8 1.1 -0.5 -0.3 10.90 -1.84 0.00 -0.41 -0.08 -5.6 0.0 0.0 -0.0 -0.1 -9.16 1865.08 1.2824 0.0005 0.0010 -0.0006 -0.0005 0.5229 -0.0269 -0.0007 -0.0045 0.0036
7.5 52.5 101081 179 -6 16 49 299.7 -0.7 0.6 -0.4 -0.9 16.02 -1.01 -0.02 -0.48 -0.80 -9.3 -0.1 -0.3 -0.0 0.0 -52.34 0.00 1.2830 -0.0014 0.0006 -0.0005 -0.0002 0.5772 -0.0257 -0.0235 0.0106 -0.0116
7.5 67.5 101027 88 -13 -2 61 300.6 -0.4 0.4 -0.1 -0.2 16.65 -0.58 0.17 -0.10 -0.46 -9.4 -0.1 -0.1 0.1 -0.0 -86.05 -0.00 1.2825 -0.0005 0.0008 -0.0004 -0.0003 0.6058 -0.0230 -0.0268 0.0047 -0.0188
7.5 82.5 100897 205 35 1 52 300.9 -1.4 -0.0 -0.2 -0.2 17.11 -0.62 0.21 -0.29 -0.62 -8.9 -0.1 -0.2 0.0 -0.1 -94.84 -0.00 1.2831 -0.0016 0.0005 -0.0003 -0.0001 0.6293 -0.0170 -0.0231 0.0007 -0.0136
7.5 97.5 100919 99 -10 5 34 301.2 -0.4 0.5 -0.1 -0.0 17.21 -0.58 0.01 -0.19 -0.40 -9.2 0.1 -0.1 -0.1 -0.1 -28.31 -0.00 1.2830 -0.0008 0.0007 -0.0001 -0.0001 0.6427 -0.0206 -0.0184 -0.0022 -0.0112
7.5 112.5 100907 79 32 -4 42 300.8 -0.9 -0.0 -0.2 -0.3 17.49 -0.27 -0.07 -0.02 -0.33 -9.2 0.1 -0.0 0.0 -0.0 28.13 -0.00 1.2828 -0.0011 0.0004 -0.0004 -0.0003 0.6428 -0.0116 -0.0195 0.0080 -0.0059
7.5 127.5 100890 18 46 -12 40 300.6 -0.3 -0.3 -0.1 -0.2 17.60 -0.14 -0.18 0.02 -0.32 -9.0 0.0 -0.0 0.0 -0.0 57.90 -0.00 1.2827 -0.0005 0.0001 -0.0003 -0.0004 0.6429 -0.0130 -0.0144 0.0084 -0.0021
7.5 142.5 100880 -32 12 -15 36 300.7 0.1 0.0 -0.0 -0.2 17.46 -0.17 -0.15 0.00 -0.38 -9.2 -0.0 -0.0 -0.0 -0.0 62.45 -0.00 1.2829 0.0001 0.0004 -0.0001 -0.0002 0.6404 -0.0191 -0.0161 0.0026 -0.0056
7.5 157.5 100888 -49 10 -23 20 300.6 0.0 0.0 0.0 -0.1 17.47 -0.29 -0.23 -0.02 -0.39 -9.2 -0.1 -0.1 -0.0 -0.0 45.72 -0.00 1.2830 0.0002 0.0005 0.0001 0.0000 0.6334 -0.0220 -0.0190 -0.0018 -0.0113
7.5 172.5 100922 -53 9 -25 15 300.5 -0.1 0.0 -0.0 -0.1 17.38 -0.32 -0.25 -0.05 -0.33 -9.2 -0.0 -0.1 -0.0 -0.0 24.07 -0.00 1.2828 0.0000 0.0004 0.0002 0.0000 0.6265 -0.0208 -0.0205 -0.0035 -0.0108
7.5 -172.5 100959 -58 9 -24 10 300.0 -0.1 -0.0 -0.1 -0.1 16.98 -0.26 -0.18 0.01 -0.26 -9.3 -0.1 -0.0 0.0 -0.0 11.21 -0.00 1.2821 -0.0002 0.0001 0.0002 -0.0001 0.6266 -0.0173 -0.0167 -0.0066 -0.0108
7.5 -157.5 101003 -48 9 -14 9 299.4 -0.1 -0.0 -0.2 -0.1 16.70 -0.17 -0.10 -0.01 -0.28 -9.2 -0.1 -0.1 0.1 -0.0 12.93 -0.00 1.2813 -0.0007 -0.0001 0.0001 -0.0002 0.6256 -0.0103 -0.0129 -0.0047 -0.0075
7.5 -142.5 101054 -27 3 -11 12 298.8 -0.2 -0.0 -0.2 -0.0 16.47 -0.06 0.13 0.11 -0.32 -9.0 -0.0 -0.1 0.1 -0.1 -3.96 -0.00 1.2806 -0.0012 -0.0003 -0.0003 -0.0002 0.6265 -0.0088 -0.0088 -0.0013 -0.0056
7.5 -127.5 101085 -14 -21 -3 22 298.8 -0.4 0.2 -0.3 0.0 16.37 0.05 0.55 0.11 -0.41 -8.8 0.2 0.0 0.2 -0.3 -27.71 -0.00 1.2805 -0.0014 -0.0002 -0.0005 -0.0002 0.6266 -0.0121 -0.0063 0.0015 -0.0056
7.5 -112.5 101100 -11 -46 10 24 298.9 -0.2 0.7 -0.2 0.0 16.39 0.07 0.62 0.01 -0.35 -8.9 0.1 -0.1 0.2 -0.2 -30.61 0.00 1.2807 -0.0011 0.0003 -0.0006 -0.0001 0.6250 -0.0221 -0.0108 0.0024 -0.0054
7.5 -97.5 101088 -7 -44 23 23 299.2 0.1 0.9 -0.2 -0.1 16.73 -0.23 0.16 -0.08 -0.29 -8.9 -0.1 -0.4 0.1 -0.1 -7.98 -0.00 1.2811 -0.0003 0.0010 -0.0005 -0.0001 0.6227 -0.0297 -0.0207 0.0012 -0.0070
7.5 -82.5 101007 -30 -34 16 7 299.9 0.2 1.1 -0.1 0.4 17.57 -0.46 -0.36 0.03 -0.38 -8.0 0.0 -0.2 0.1 -0.1 12.73 -0.00 1.2817 0.0002 0.0013 -0.0002 0.0004 0.6360 -0.0257 -0.0210 -0.0026 -0.0139
7.5 -67.5 100166 -123 -26 71 55 300.3 1.2 1.5 -0.7 0.2 15.99 -1.32 -1.52 -0.08 -0.99 -6.0 -0.8 -1.1 -0.2 -0.4 -10.78 75.31 1.2827 0.0008 0.0012 -0.0007 -0.0000 0.6152 -0.0262 -0.0096 -0.0030 -0.0127
7.5 -52.5 101195 -85 39 33 65 299.9 -0.1 -0.4 -0.3 -0.2 16.23 -0.31 -0.48 0.04 -0.52 -9.3 -0.1 0.0 0.1 -0.1 -38.54 -0.00 1.2814 -0.0003 0.0000 -0.0006 -0.0003 0.6123 -0.0157 -0.0186 0.0034 -0.0114
7.5 -37.5 101244 -81 3 28 56 299.0 -0.0 -0.3 -0.0 -0.2 15.91 -0.42 -0.75 0.15 -0.56 -9.2 -0.3 -0.3 0.1 -0.1 -10.51 -0.00 1.2808 -0.0005 0.0008 -0.0006 -0.0003 0.6227 -0.0086 -0.0277 0.0032 -0.0054
7.5 -22.5 101223 -99 -39 41 46 298.8 0.3 -0.5 0.4 -0.4 15.95 -0.38 -0.69 -0.02 -0.56 -9.1 -0.3 -0.2 -0.1 0.0 16.63 -0.00 1.2814 0.0001 0.0016 -0.0007 -0.0001 0.6313 -0.0132 -0.0121 0.0014 -0.0002
7.5 -7.5 96717 -124 -99 48 27 297.9 1.7 1.4 0.1 -0.1 15.24 -1.60 -0.08 -1.32 -0.91 -5.4 0.6 -0.1 0.1 -0.0 32.13 392.57 1.2823 0.0012 0.0014 0.0002 -0.0002 0.6003 -0.0187 -0.0020 -0.0062 0.0027
-7.5 7.5 101223 -197 -171 69 49 297.3 1.7 3.0 -0.4 -0.4 14.64 1.30 1.80 -0.44 -0.55 -9.5 -0.1 -0.2 -0.1 0.1 8.51 -0.00 1.2821 -0.0001 0.0013 -0.0002 -0.0004 0.6046 0.0470 0.0085 -0.0174 -0.0016
-7.5 22.5 91286 -72 -8 56 -2 296.1 -2.2 -0.2 0.1 0.2 13.55 3.76 0.42 -1.99 -0.33 -3.9 -0.7 0.1 0.0 0.0 -5.61 887.66 1.2834 -0.0019 0.0002 -0.0000 -0.0000 0.5792 0.0385 0.0115 -0.0060 -0.0025
-7.5 37.5 96586 -296 -117 43 21 297.0 1.1 0.1 -0.2 -0.3 13.44 2.31 1.63 -0.51 -0.31 -6.8 0.4 0.5 -0.1 0.1 -22.74 420.39 1.2813 0.0010 0.0006 -0.0004 -0.0004 0.5718 0.0317 0.0307 -0.0033 -0.0033
-7.5 52.5 101170 -131 -136 30 50 299.4 0.8 1.1 -0.3 -0.4 16.25 0.84 1.02 -0.25 -0.41 -9.3 0.0 -0.0 0.0 0.0 -37.07 -0.00 1.2813 0.0001 0.0009 -0.0004 -0.0006 0.6002 0.0309 0.0181 0.0009 -0.0032
-7.5 67.5 101077 -63 -81 1 49 299.6 0.3 0.7 -0.2 -0.3 16.63 0.61 0.70 -0.15 -0.33 -9.3 0.1 -0.0 0.0 -0.0 -62.99 -0.00 1.2814 -0.0004 0.0007 -0.0003 -0.0006 0.6220 0.0193 0.0076 -0.0011 0.0018
-7.5 82.5 101027 -34 -69 3 30 299.8 0.2 0.5 -0.2 -0.2 16.82 0.19 0.53 -0.12 -0.14 -9.2 -0.0 -0.0 0.0 0.0 -80.37 -0.00 1.2816 -0.0003 0.0006 -0.0003 -0.0006 0.6301 0.0067 0.0045 0.0010 0.0037
-7.5 97.5 100989 -31 -86 -22 27 300.1 -0.2 0.5 0.1 -0.1 16.77 0.18 0.72 -0.03 -0.28 -9.3 0.1 0.0 -0.0 -0.0 -31.68 -0.00 1.2821 -0.0006 0.0004 -0.0001 -0.0004 0.6288 0.0176 0.0168 0.0018 -0.0014
-7.5 112.5 97556 -79 -55 -9 31 298.0 -0.1 -0.1 -0.3 -0.5 15.86 1.14 1.04 -0.01 -0.49 -6.8 1.0 0.7 0.1 -0.0 29.21 302.99 1.2827 -0.0007 -0.0001 -0.0003 -0.0005 0.6046 0.0343 0.0287 0.0060 -0.0018
-7.5 127.5 100964 -186 -88 -15 36 300.4 0.9 0.5 -0.1 -0.6 16.53 1.46 0.75 -0.16 -0.47 -9.4 0.1 0.1 0.0 0.0 47.00 -0.00 1.2830 0.0001 -0.0001 -0.0004 -0.0007 0.6213 0.0259 0.0272 0.0076 0.0057
-7.5 142.5 100395 -162 -78 -17 32 298.3 0.9 0.2 -0.1 -0.3 17.25 0.67 0.70 0.05 -0.44 -6.3 0.4 0.5 0.1 -0.1 75.56 49.12 1.2818 0.0007 0.0004 -0.0002 -0.0005 0.6463 0.0133 0.0158 0.0003 0.0057
-7.5 157.5 100642 -120 -57 -31 13 300.3 0.3 0.2 0.0 -0.2 17.60 0.14 0.22 0.07 -0.10 -9.3 -0.0 -0.0 0.0 0.0 66.68 18.59 1.2824 0.0003 0.0005 0.0000 -0.0003 0.6534 0.0054 0.0079 0.0003 0.0035
-7.5 172.5 100867 -106 -43 -39 6 300.7 0.2 0.0 -0.0 -0.2 17.50 0.06 0.32 0.04 -0.06 -9.3 -0.0 0.0 -0.0 0.0 39.63 -0.00 1.2828 0.0001 0.0002 0.0001 -0.0002 0.6395 0.0133 0.0126 0.0004 0.0010
-7.5 -172.5 100902 -90 -46 -33 7 300.8 0.0 0.0 -0.0 -0.2 17.16 -0.01 0.54 -0.00 -0.08 -9.3 -0.0 0.1 -0.0 0.0 20.68 -0.00 1.2829 -0.0001 -0.0001 0.0002 -0.0002 0.6154 0.0211 0.0246 0.0021 0.0002
-7.5 -157.5 100969 -70 -54 -22 14 300.5 0.0 0.2 0.0 -0.2 16.53 -0.18 0.76 -0.15 -0.10 -9.4 -0.0 0.1 -0.0 0.0 10.66 -0.00 1.2827 -0.0004 -0.0002 0.0002 -0.0004 0.5827 0.0212 0.0341 0.0010 -0.0002
-7.5 -142.5 101061 -61 -71 -10 18 300.0 0.0 0.5 -0.0 -0.2 15.86 -0.06 0.96 -0.22 -0.09 -9.5 0.0 0.1 -0.0 0.0 1.98 0.00 1.2822 -0.0008 -0.0001 0.0000 -0.0005 0.5503 0.0137 0.0339 -0.0041 0.0018
-7.5 -127.5 101169 -47 -95 4 20 299.0 -0.1 0.8 -0.1 -0.2 14.89 -0.06 1.21 -0.24 -0.12 -9.5 0.0 0.1 -0.0 0.0 -10.80 -0.00 1.2817 -0.0010 0.0001 -0.0003 -0.0006 0.5333 0.0089 0.0342 -0.0096 0.0036
-7.5 -112.5 101253 -38 -126 23 15 297.9 -0.4 1.2 -0.2 -0.2 13.90 -0.15 1.50 -0.44 -0.08 -9.5 -0.0 0.1 -0.0 0.0 -11.58 -0.00 1.2814 -0.0008 0.0004 -0.0003 -0.0004 0.5313 0.0100 0.0349 -0.0125 0.0049
-7.5 -97.5 101283 -55 -167 32 -1 296.6 -0.3 2.4 -0.2 -0.0 13.24 0.01 2.12 -0.53 0.15 -9.6 0.0 0.2 -0.1 0.0 -12.64 -0.00 1.2814 -0.0005 0.0005 -0.0001 -0.0004 0.5493 0.0116 0.0311 -0.0115 0.0072
-7.5 -82.5 101252 -103 -171 27 -18 293.7 1.8 3.6 -0.2 0.5 12.50 1.25 2.54 -0.31 0.34 -8.9 0.1 0.0 -0.2 -0.1 -0.12 0.00 1.2820 -0.0003 0.0008 -0.0002 -0.0003 0.6195 0.0131 0.0088 -0.0091 -0.0004
-7.5 -67.5 100058 -178 17 46 37 298.0 0.2 -0.6 -0.4 0.2 17.16 0.86 0.26 -0.24 -0.20 -3.8 -1.2 -0.8 0.8 0.6 18.88 87.67 1.2816 -0.0000 -0.0004 -0.0003 -0.0001 0.6340 0.0268 0.0173 -0.0048 -0.0065
-7.5 -52.5 97741 -114 32 38 27 298.2 -1.6 -1.3 0.2 0.7 15.69 1.91 0.98 -0.78 -1.16 -3.9 -2.1 -0.2 1.0 0.2 -19.35 295.12 1.2823 -0.0014 -0.0009 0.0000 0.0003 0.6072 0.0360 0.0227 -0.0062 -0.0052
-7.5 -37.5 94916 -185 -74 35 62 297.5 1.5 0.5 -0.3 -0.5 12.54 0.02 1.25 -0.04 -0.12 -8.4 0.1 0.3 -0.1 -0.2 -6.75 564.23 1.2823 0.0004 0.0002 -0.0006 -0.0007 0.5504 0.0129 0.0367 0.0019 -0.0054
-7.5 -22.5 101327 -138 -147 39 52 298.7 -0.1 1.4 -0.1 -0.1 14.86 0.37 1.24 -0.22 -0.22 -9.5 0.0 0.0 -0.0 0.0 0.21 -0.00 1.2813 -0.0002 0.0010 -0.0005 -0.0004 0.5495 0.0107 0.0211 -0.0042 -0.0029
-7.5 -7.5 101353 -166 -165 57 37 297.4 0.1 2.2 -0.2 0.0 14.13 0.74 1.47 -0.45 -0.23 -9.5 0.1 -0.0 -0.1 -0.0 15.71 -0.00 1.2815 0.0001 0.0011 -0.0004 -0.0003 0.5619 0.0314 0.0126 -0.0094 0.0005
-22.5 7.5 101723 -258 -186 44 21 291.7 1.5 2.4 0.1 0.2 10.54 0.82 1.59 -0.07 -0.01 -8.1 -1.2 -0.2 0.3 -0.4 24.73 -0.00 1.2762 0.0047 0.0026 -0.0003 0.0005 0.5253 0.0328 0.0044 -0.0137 -0.0012
-22.5 22.5 89798 -407 3 56 18 296.3 4.3 -0.4 -1.6 -0.4 8.00 3.74 1.85 0.26 0.09 -4.5 -2.7 -0.8 0.9 0.3 21.15 1055.42 1.2791 0.0065 0.0004 -0.0013 0.0005 0.5339 0.0506 0.0025 -0.0166 -0.0015
-22.5 37.5 101593 -511 -195 28 -13 297.8 2.3 1.6 0.1 0.0 14.14 2.61 0.91 -0.35 0.23 -9.1 -0.0 -0.6 -0.3 0.1 0.40 -0.00 1.2763 0.0052 0.0015 -0.0005 0.0006 0.5461 0.0467 0.0145 -0.0012 -0.0065
-22.5 52.5 101732 -458 -330 8 -10 297.4 2.0 1.8 -0.1 -0.1 13.59 2.37 1.90 -0.18 0.14 -9.3 0.2 0.1 -0.0 0.0 -3.96 -0.00 1.2748 0.0044 0.0029 -0.0001 0.0006 0.5617 0.0455 0.0312 0.0016 -0.0010
-22.5 67.5 101825 -332 -309 -2 9 296.3 1.9 2.1 -0.1 0.0 12.61 2.10 1.88 -0.24 0.17 -9.4 0.2 0.0 -0.1 -0.0 -7.62 -0.00 1.2744 0.0038 0.0029 -0.0003 0.0003 0.5430 0.0339 0.0301 -0.0019 0.0015
-22.5 82.5 101841 -230 -268 -13 11 295.3 1.6 2.1 -0.0 -0.0 11.69 1.53 1.73 -0.20 0.12 -9.4 0.1 0.1 -0.1 0.0 -34.67 -0.00 1.2739 0.0036 0.0029 -0.0001 0.0005 0.5341 0.0212 0.0245 -0.0035 0.0016
-22.5 97.5 101779 -198 -222 -44 0 294.3 1.0 1.6 -0.0 -0.1 10.89 0.88 1.56 -0.09 0.06 -9.5 -0.1 0.2 -0.0 0.0 -45.71 -0.00 1.2739 0.0040 0.0032 0.0003 0.0010 0.5329 0.0135 0.0227 -0.0005 0.0021
-22.5 112.5 101352 -465 -216 -35 -41 296.0 0.8 2.6 -0.3 -0.0 12.54 2.88 2.17 -0.68 0.30 -6.3 2.5 0.3 -0.7 0.1 -23.52 -0.00 1.2781 0.0068 0.0036 0.0002 0.0012 0.5543 0.0215 0.0294 0.0051 0.0016
-22.5 127.5 96591 -556 -61 0 -44 299.5 7.5 0.7 -1.6 -0.2 6.31 2.51 1.35 0.53 0.48 -4.3 -1.9 -0.1 -0.4 -0.0 9.18 411.47 1.2800 0.0087 0.0022 -0.0008 0.0012 0.5900 0.0345 0.0136 -0.0044 -0.0044
-22.5 142.5 98918 -553 -102 -15 -33 299.1 6.4 0.7 -1.5 -0.4 7.49 2.91 1.73 0.63 0.71 -5.9 -1.7 -0.3 0.4 -0.1 39.16 209.13 1.2780 0.0079 0.0019 -0.0007 0.0009 0.5762 0.0349 0.0049 0.0034 -0.0030
-22.5 157.5 101449 -365 -223 -40 -59 296.4 2.1 1.7 -0.0 0.0 12.30 2.60 1.64 -0.13 0.29 -9.5 0.1 0.0 -0.0 -0.0 50.23 -0.00 1.2741 0.0050 0.0030 -0.0000 0.0010 0.5581 0.0223 0.0265 0.0072 0.0045
-22.5 172.5 101362 -290 -248 -23 -59 296.5 1.8 2.1 -0.1 0.1 12.96 2.08 2.12 -0.32 0.35 -9.3 0.1 0.0 -0.1 0.0 55.17 -0.00 1.2745 0.0042 0.0036 0.0001 0.0007 0.5793 0.0129 0.0256 0.0008 0.0026
-22.5 -172.5 101377 -256 -216 -33 -45 296.6 1.6 2.0 -0.2 0.1 13.34 1.81 1.94 -0.33 0.38 -9.2 0.1 -0.0 -0.1 0.0 31.06 -0.00 1.2748 0.0035 0.0035 0.0001 0.0004 0.5959 0.0114 0.0175 -0.0036 0.0013
-22.5 -157.5 101445 -203 -186 -52 1 296.8 1.4 1.9 -0.1 0.2 13.56 1.75 1.71 -0.15 0.26 -9.2 0.1 -0.1 0.0 0.0 6.21 -0.00 1.2745 0.0029 0.0031 -0.0000 0.0003 0.5981 0.0171 0.0151 -0.0018 -0.0017
-22.5 -142.5 101540 -124 -142 -34 37 297.1 1.2 1.7 -0.1 0.0 13.78 1.53 1.53 -0.02 -0.01 -9.2 0.2 -0.1 0.0 -0.1 -8.34 -0.00 1.2738 0.0021 0.0028 -0.0001 0.0000 0.5925 0.0217 0.0125 0.0005 -0.0044
-22.5 -127.5 101704 -54 -123 2 41 296.8 1.1 1.6 -0.1 0.0 13.23 1.17 1.29 -0.16 0.03 -9.3 0.1 -0.1 -0.0 -0.0 -10.18 -0.00 1.2729 0.0014 0.0025 -0.0004 -0.0002 0.5738 0.0160 0.0083 0.0013 -0.0065
-22.5 -112.5 101878 -27 -147 9 29 295.8 1.0 1.6 -0.2 0.2 12.04 0.85 1.26 -0.19 0.11 -9.4 0.0 -0.0 -0.0 -0.0 -3.07 -0.00 1.2719 0.0015 0.0021 -0.0005 0.0003 0.5463 0.0073 0.0105 0.0007 -0.0087
-22.5 -97.5 101996 -66 -199 -10 4 293.7 0.8 2.0 -0.0 0.2 10.48 0.69 1.37 -0.01 0.13 -9.5 0.0 0.0 0.0 -0.0 -1.55 -0.00 1.2715 0.0025 0.0026 -0.0002 0.0008 0.5235 0.0020 0.0083 -0.0005 -0.0063
-22.5 -82.5 101872 -149 -197 -0 -18 291.1 0.9 2.2 0.0 0.3 9.11 0.62 1.19 0.07 0.14 -9.6 0.0 0.0 0.1 -0.0 6.73 0.00 1.2728 0.0042 0.0032 0.0000 0.0007 0.5058 0.0026 0.0111 0.0003 -0.0021
-22.5 -67.5 58419 39 53 -23 13 274.8 2.6 0.7 -0.4 -0.1 2.39 1.58 1.08 0.14 0.62 -6.9 0.1 0.3 0.2 -0.0 43.26 4628.35 1.2707 0.0068 0.0030 -0.0004 0.0005 0.4193 -0.0177 -0.0174 0.0026 -0.0059
-22.5 -52.5 97412 -367 -2 51 40 297.6 2.4 -0.0 -1.1 0.1 12.46 3.11 1.31 -0.16 -0.03 -4.5 -3.1 -0.1 1.0 0.5 -2.16 338.68 1.2776 0.0040 0.0010 -0.0011 0.0003 0.5726 0.0288 0.0020 -0.0039 0.0044
-22.5 -37.5 101684 -352 -176 48 92 297.4 1.4 1.9 -0.1 0.1 13.61 1.97 1.33 -0.20 0.07 -9.2 0.3 -0.2 -0.0 -0.1 -9.16 -0.00 1.2742 0.0039 0.0026 -0.0003 0.0001 0.5771 0.0384 0.0073 -0.0053 -0.0076
-22.5 -22.5 101933 -220 -227 62 89 296.2 1.5 2.2 -0.1 0.0 12.25 1.43 1.70 -0.31 -0.14 -9.4 0.1 -0.0 -0.1 -0.1 -1.54 -0.00 1.2731 0.0039 0.0033 -0.0002 0.0000 0.5473 0.0203 0.0080 -0.0111 -0.0145
-22.5 -7.5 102015 -212 -211 43 37 294.1 1.2 2.2 -0.0 0.2 10.71 1.22 1.55 -0.19 0.08 -9.5 0.1 0.0 -0.0 -0.0 13.39 -0.00 1.2730 0.0044 0.0032 -0.0002 0.0002 0.5219 0.0153 0.0015 -0.0079 -0.0103
-37.5 7.5 101956 -22 -95 -47 21 286.7 1.4 2.1 0.2 0.1 7.35 0.72 1.05 0.08 0.00 -8.9 0.2 0.1 -0.0 -0.1 22.83 0.00 1.2501 0.0098 0.0069 -0.0001 0.0006 0.5577 0.0131 0.0059 -0.0017 -0.0025
-37.5 22.5 101680 -164 -85 -15 20 290.5 1.6 1.9 -0.0 0.1 8.90 0.86 1.25 -0.12 0.08 -9.3 -0.3 0.2 -0.0 -0.1 29.58 0.00 1.2537 0.0094 0.0063 -0.0006 0.0009 0.5423 0.0095 0.0072 -0.0008 -0.0043
-37.5 37.5 101824 -251 -69 -33 37 290.0 1.2 1.9 -0.0 0.3 9.03 0.93 1.20 -0.03 0.30 -8.8 0.3 0.1 0.1 0.1 30.61 0.00 1.2544 0.0092 0.0059 -0.0007 0.0015 0.5530 0.0183 0.0050 -0.0042 -0.0014
-37.5 52.5 102011 -260 -75 -40 74 288.7 1.5 1.9 -0.1 0.4 8.54 1.03 1.08 -0.13 0.35 -8.5 0.4 0.0 -0.0 0.2 36.90 0.00 1.2534 0.0096 0.0060 -0.0009 0.0018 0.5543 0.0194 0.0046 -0.0062 -0.0011
-37.5 67.5 102078 -109 -82 -87 130 287.9 1.9 2.1 -0.1 0.4 8.09 1.22 1.06 -0.04 0.27 -8.5 0.5 -0.1 0.0 -0.0 22.77 0.00 1.2520 0.0105 0.0063 -0.0011 0.0016 0.5540 0.0227 0.0074 -0.0042 -0.0034
-37.5 82.5 102021 98 -78 -109 126 286.9 2.0 2.1 0.1 0.2 7.60 1.15 1.00 0.11 0.06 -8.6 0.4 -0.1 0.1 -0.2 4.78 0.00 1.2500 0.0110 0.0062 -0.0007 0.0011 0.5511 0.0226 0.0096 -0.0019 -0.0039
-37.5 97.5 101903 178 -21 -88 37 286.1 1.6 2.0 0.2 0.1 7.16 0.80 0.89 0.13 0.01 -8.8 0.2 0.0 0.1 -0.1 -21.84 0.00 1.2482 0.0106 0.0065 -0.0003 0.0008 0.5464 0.0197 0.0099 -0.0017 -0.0043
-37.5 112.5 101729 60 63 -56 -30 286.8 1.0 1.9 0.1 0.0 7.23 0.55 0.91 0.00 -0.04 -9.1 0.1 0.2 -0.1 -0.1 -36.65 0.00 1.2486 0.0106 0.0072 -0.0001 0.0008 0.5409 0.0173 0.0099 -0.0013 -0.0043
-37.5 127.5 101732 -76 137 -61 -43 287.1 1.0 2.0 0.0 0.1 7.54 0.68 1.03 -0.10 -0.01 -8.2 0.3 -0.0 -0.4 -0.3 -30.09 0.00 1.2499 0.0116 0.0072 -0.0004 0.0011 0.5491 0.0229 0.0115 -0.0013 -0.0025
-37.5 142.5 98971 -298 129 -69 -71 287.2 4.6 2.0 -0.2 0.3 6.50 0.65 0.58 0.01 0.04 -6.4 -0.5 0.4 0.2 -0.1 1.50 230.34 1.2508 0.0141 0.0071 -0.0006 0.0014 0.5409 0.0261 0.0077 0.0013 -0.0011
-37.5 157.5 101647 -118 102 -81 -32 289.6 2.1 2.1 -0.0 0.3 8.49 1.51 1.04 -0.03 0.18 -9.1 0.4 -0.3 -0.1 -0.1 10.31 0.00 1.2502 0.0125 0.0062 -0.0005 0.0011 0.5441 0.0216 0.0057 -0.0004 -0.0012
-37.5 172.5 101582 -1 64 -121 -7 288.7 1.9 2.2 -0.1 0.3 8.22 1.28 1.06 -0.00 0.27 -8.8 0.5 -0.1 0.1 0.0 26.93 0.00 1.2494 0.0119 0.0068 -0.0006 0.0012 0.5472 0.0206 0.0058 0.0034 -0.0009
-37.5 -172.5 101578 56 46 -147 29 288.3 2.3 2.3 0.0 0.3 8.21 1.37 1.09 0.08 0.19 -8.8 0.3 -0.2 0.0 -0.1 15.04 0.00 1.2491 0.0118 0.0070 -0.0005 0.0011 0.5495 0.0185 0.0083 0.0032 0.0010
-37.5 -157.5 101628 137 -2 -159 11 288.0 2.2 2.5 0.1 0.3 8.22 1.36 1.23 0.10 0.23 -8.7 0.4 -0.1 0.1 -0.1 1.79 0.00 1.2492 0.0116 0.0073 -0.0006 0.0010 0.5545 0.0181 0.0097 0.0009 0.0029
-37.5 -142.5 101720 226 -15 -128 -28 287.7 2.0 2.5 0.1 0.3 8.10 1.20 1.29 0.13 0.20 -8.7 0.4 -0.0 0.2 -0.0 -9.70 0.00 1.2496 0.0112 0.0076 -0.0003 0.0009 0.5621 0.0169 0.0097 0.0008 0.0021
-37.5 -127.5 101814 242 -12 -72 -60 287.6 1.9 2.4 0.2 0.3 8.10 1.25 1.28 0.18 0.22 -8.5 0.5 0.1 0.1 -0.0 -11.49 0.00 1.2499 0.0108 0.0076 -0.0002 0.0006 0.5668 0.0180 0.0129 -0.0019 0.0020
-37.5 -112.5 101918 276 -19 -57 -56 287.6 2.1 2.7 0.2 0.5 8.12 1.27 1.33 0.17 0.32 -8.5 0.4 -0.1 0.1 -0.1 -10.11 0.00 1.2500 0.0105 0.0075 -0.0001 0.0009 0.5701 0.0143 0.0094 -0.0011 0.0016
-37.5 -97.5 102018 260 -55 -65 -2 287.4 2.0 2.6 0.2 0.6 7.97 1.14 1.26 0.18 0.31 -8.6 0.2 -0.1 0.1 -0.1 -4.29 0.00 1.2494 0.0100 0.0074 0.0002 0.0012 0.5669 0.0074 0.0056 -0.0015 -0.0019
-37.5 -82.5 101996 152 -86 -70 1 286.8 1.5 2.5 0.0 0.4 7.50 0.80 1.12 0.03 0.24 -8.9 -0.0 -0.1 0.1 0.1 4.27 0.00 1.2488 0.0101 0.0077 0.0003 0.0014 0.5551 0.0023 0.0032 0.0010 -0.0020
-37.5 -67.5 96973 -301 -66 -65 19 290.3 6.8 1.9 0.1 0.5 5.39 1.39 1.12 -0.12 0.35 -5.8 -2.1 0.4 0.2 0.0 19.01 383.48 1.2535 0.0134 0.0073 -0.0001 0.0014 0.5610 0.0028 -0.0023 0.0054 -0.0011
-37.5 -52.5 101572 -239 -98 -53 36 289.3 3.0 2.7 -0.1 0.4 8.63 1.86 1.27 -0.03 0.43 -8.3 0.6 -0.7 -0.0 0.1 2.63 0.00 1.2521 0.0112 0.0064 -0.0008 0.0016 0.5615 0.0054 0.0006 -0.0004 0.0011
-37.5 -37.5 101647 -110 -128 -61 118 288.3 1.9 2.4 -0.0 0.4 8.25 1.25 1.19 -0.01 0.36 -8.7 0.4 -0.1 0.0 0.2 -5.08 0.00 1.2506 0.0104 0.0064 -0.0008 0.0019 0.5624 0.0091 0.0023 -0.0007 0.0022
-37.5 -22.5 101768 -4 -131 -46 143 287.5 1.9 2.4 0.1 0.3 8.04 1.23 1.18 0.05 0.20 -8.3 0.6 0.0 0.1 0.0 17.38 0.00 1.2501 0.0107 0.0069 -0.0003 0.0014 0.5689 0.0146 0.0056 0.0005 0.0011
-37.5 -7.5 101915 50 -124 -30 84 286.9 1.8 2.3 0.1 0.1 7.75 1.07 1.14 0.08 0.07 -8.1 0.5 0.1 0.0 -0.1 20.27 0.00 1.2499 0.0105 0.0071 -0.0000 0.0008 0.5682 0.0142 0.0055 -0.0001 -0.0037
-52.5 7.5 99757 -6 -149 -54 -103 273.5 1.2 1.6 0.1 -0.3 3.30 0.36 0.41 0.02 -0.03 -7.5 0.7 0.3 0.1 -0.2 26.86 0.00 1.2109 0.0136 0.0084 0.0002 -0.0011 0.5526 0.0164 0.0074 -0.0014 -0.0019
-52.5 22.5 99784 -74 -17 -64 -111 273.4 0.9 1.6 0.1 -0.0 3.28 0.30 0.42 0.04 0.02 -7.1 0.4 0.4 0.1 -0.1 37.05 0.00 1.2113 0.0120 0.0092 0.0001 -0.0009 0.5556 0.0121 0.0097 -0.0021 -0.0024
-52.5 37.5 99804 -85 95 -74 -27 274.4 0.9 1.5 0.1 0.2 3.48 0.30 0.43 0.03 0.07 -7.6 0.2 0.4 -0.0 0.0 44.84 0.00 1.2128 0.0115 0.0098 -0.0002 0.0001 0.5551 0.0118 0.0138 -0.0024 -0.0000
-52.5 52.5 99814 2 158 -97 105 274.6 1.0 1.5 -0.0 0.2 3.52 0.33 0.45 0.02 0.09 -7.7 0.2 0.3 0.0 0.1 43.75 0.00 1.2136 0.0123 0.0099 -0.0006 0.0011 0.5573 0.0141 0.0145 -0.0031 0.0021
-52.5 67.5 99704 194 188 -109 159 274.9 1.2 1.5 -0.1 0.2 3.58 0.40 0.45 0.01 0.06 -7.8 0.4 0.3 0.0 0.2 35.46 0.00 1.2135 0.0134 0.0094 -0.0007 0.0014 0.5554 0.0169 0.0152 -0.0022 0.0039
-52.5 82.5 99548 348 173 -86 102 274.2 1.4 1.4 -0.1 0.1 3.47 0.44 0.41 0.00 0.05 -7.7 0.5 0.3 0.0 0.0 24.20 0.00 1.2125 0.0142 0.0086 -0.0006 0.0009 0.5531 0.0181 0.0139 -0.0016 0.0034
-52.5 97.5 99384 375 169 -51 -25 275.3 1.3 1.3 0.1 -0.1 3.72 0.43 0.42 0.06 -0.02 -8.0 0.3 0.3 0.0 -0.1 3.72 0.00 1.2130 0.0135 0.0079 -0.0003 -0.0003 0.5468 0.0157 0.0135 0.0002 0.0011
-52.5 112.5 99499 246 204 12 -166 275.5 0.9 1.5 0.2 -0.1 3.84 0.32 0.47 0.07 -0.01 -7.4 0.1 0.3 0.1 -0.3 -15.35 0.00 1.2147 0.0121 0.0080 -0.0002 -0.0012 0.5476 0.0137 0.0149 -0.0002 -0.0010
-52.5 127.5 99748 84 295 33 -193 277.6 0.7 1.3 0.1 0.0 4.39 0.27 0.47 0.06 0.01 -8.0 -0.0 0.3 0.1 -0.1 -23.03 0.00 1.2182 0.0112 0.0080 -0.0005 -0.0012 0.5471 0.0127 0.0159 -0.0011 -0.0028
-52.5 142.5 100110 -58 321 17 -127 278.3 0.9 1.3 0.1 0.2 4.67 0.35 0.46 0.06 0.08 -7.3 -0.0 0.2 0.1 -0.2 -18.50 0.00 1.2211 0.0113 0.0079 -0.0007 -0.0006 0.5495 0.0146 0.0152 -0.0018 -0.0025
-52.5 157.5 100352 -109 269 34 -13 279.6 1.1 1.2 -0.0 0.3 4.97 0.44 0.47 0.03 0.14 -7.9 0.2 0.3 0.1 0.1 -18.96 0.00 1.2232 0.0123 0.0076 -0.0010 0.0004 0.5476 0.0186 0.0145 -0.0029 0.0006
-52.5 172.5 100435 -69 204 21 121 280.1 1.3 1.1 -0.1 0.4 5.11 0.53 0.47 -0.01 0.14 -7.8 0.4 0.3 -0.0 0.0 -19.23 0.00 1.2241 0.0132 0.0073 -0.0010 0.0009 0.5460 0.0204 0.0122 -0.0033 0.0006
-52.5 -172.5 100407 -5 155 10 191 280.4 1.5 1.4 -0.1 0.3 5.19 0.63 0.54 0.00 0.11 -8.1 0.4 0.1 0.1 0.1 -26.53 0.00 1.2241 0.0138 0.0073 -0.0008 0.0007 0.5446 0.0225 0.0107 -0.0015 0.0010
-52.5 -157.5 100390 36 105 40 152 279.8 1.6 1.4 -0.1 0.1 5.07 0.61 0.54 -0.03 0.03 -7.8 0.4 0.2 -0.0 -0.2 -21.84 0.00 1.2234 0.0139 0.0074 -0.0005 0.0000 0.5450 0.0222 0.0113 -0.0012 -0.0004
-52.5 -142.5 100363 17 63 64 44 279.2 1.5 1.2 0.1 -0.0 4.92 0.59 0.47 0.04 -0.02 -8.0 0.4 0.3 0.0 -0.3 -18.05 0.00 1.2225 0.0134 0.0073 0.0002 -0.0007 0.5465 0.0209 0.0129 0.0007 -0.0024
-52.5 -127.5 100299 -22 24 101 -65 279.0 1.3 1.1 0.2 -0.1 4.82 0.52 0.42 0.09 -0.03 -8.0 0.3 0.3 0.1 -0.2 -14.70 0.00 1.2214 0.0125 0.0072 0.0007 -0.0011 0.5457 0.0207 0.0131 0.0014 -0.0031
-52.5 -112.5 100232 -88 1 111 -93 278.9 1.2 1.2 0.2 0.1 4.75 0.48 0.43 0.07 0.02 -8.1 0.2 0.2 0.1 -0.1 -10.98 0.00 1.2206 0.0119 0.0074 0.0008 -0.0008 0.5448 0.0179 0.0119 0.0009 -0.0012
-52.5 -97.5 100196 -151 20 67 -23 278.9 1.2 1.2 0.1 0.2 4.77 0.48 0.45 0.05 0.08 -8.0 0.1 0.1 0.1 -0.0 -8.06 0.00 1.2200 0.0117 0.0080 0.0007 0.0001 0.5451 0.0152 0.0129 0.0006 0.0008
-52.5 -82.5 100257 -170 -16 -5 76 279.0 1.3 1.4 -0.1 0.4 4.82 0.55 0.49 -0.00 0.15 -8.0 0.2 0.1 0.1 0.1 1.37 0.00 1.2196 0.0119 0.0083 0.0002 0.0010 0.5441 0.0161 0.0125 -0.0006 0.0035
-52.5 -67.5 100298 -204 -92 -74 146 280.4 2.9 1.6 -0.1 0.3 4.74 0.71 0.57 0.02 0.17 -6.7 0.3 -0.5 -0.4 0.2 11.93 0.00 1.2202 0.0134 0.0082 -0.0004 0.0015 0.5484 0.0151 0.0101 0.0004 0.0034
-52.5 -52.5 100238 -152 -198 -150 158 278.1 2.2 1.5 -0.1 0.2 4.48 0.74 0.52 -0.02 0.11 -6.5 1.2 0.4 -0.1 0.1 7.31 0.00 1.2183 0.0146 0.0080 -0.0008 0.0016 0.5458 0.0175 0.0088 -0.0008 0.0047
-52.5 -37.5 100142 -44 -252 -153 118 275.2 2.0 1.7 -0.1 0.2 3.78 0.61 0.48 -0.02 0.10 -6.2 1.3 0.1 -0.1 -0.1 9.74 0.00 1.2152 0.0153 0.0076 -0.0008 0.0012 0.5505 0.0181 0.0069 -0.0008 0.0039
-52.5 -22.5 99965 46 -254 -133 58 274.5 1.8 1.5 -0.0 0.1 3.56 0.55 0.41 0.01 0.05 -7.4 1.0 0.1 0.2 -0.0 20.02 0.00 1.2130 0.0155 0.0073 -0.0004 0.0005 0.5512 0.0193 0.0049 -0.0007 0.0025
-52.5 -7.5 99832 77 -230 -83 -30 273.6 1.4 1.5 0.0 -0.1 3.34 0.44 0.39 0.01 -0.00 -7.1 0.9 0.4 0.1 -0.1 27.44 0.00 1.2115 0.0149 0.0077 -0.0000 -0.0005 0.5520 0.0184 0.0061 -0.0007 -0.0009
-67.5 7.5 98336 94 21 123 -67 264.2 7.2 4.7 0.6 -0.8 1.77 0.91 0.54 0.18 -0.01 -5.1 -3.5 -2.6 0.6 0.7 14.67 -0.00 1.1789 0.0230 0.0146 0.0027 -0.0006 0.5395 -0.0064 -0.0072 0.0011 0.0034
-67.5 22.5 98234 112 37 194 -70 264.2 7.0 5.4 0.9 -1.0 1.81 0.88 0.65 0.17 -0.00 -4.7 -3.9 -3.0 0.4 0.7 15.86 -0.00 1.1787 0.0226 0.0156 0.0032 -0.0008 0.5357 -0.0055 -0.0083 0.0017 0.0038
-67.5 37.5 98403 56 81 197 -56 264.4 6.6 5.2 0.9 -1.1 1.76 0.81 0.64 0.14 0.01 -5.2 -2.9 -2.6 0.5 0.8 24.44 -0.00 1.1785 0.0224 0.0159 0.0034 -0.0006 0.5405 -0.0078 -0.0047 0.0024 0.0035
-67.5 52.5 82438 272 318 203 -56 254.7 5.9 2.1 2.1 -0.2 0.61 0.44 0.09 0.19 0.02 -3.0 -2.3 0.3 -0.8 0.1 38.75 1379.92 1.1741 0.0242 0.0160 0.0037 0.0002 0.5190 -0.0080 0.0131 -0.0039 0.0010
-67.5 67.5 95697 -9 253 118 -33 260.4 7.9 1.8 2.6 -0.1 1.16 0.82 0.12 0.38 0.03 -5.5 -2.0 0.1 -0.0 -0.1 25.44 239.59 1.1764 0.0244 0.0137 0.0042 0.0001 0.5599 -0.0197 0.0118 -0.0097 0.0021
-67.5 82.5 92509 200 243 187 -56 261.1 6.3 1.8 2.1 -0.2 1.04 0.68 0.12 0.30 0.02 -3.8 -2.2 -0.0 -0.6 0.2 15.35 489.24 1.1781 0.0241 0.0134 0.0035 0.0001 0.5421 -0.0063 0.0079 -0.0049 0.0014
-67.5 97.5 78758 384 278 258 -82 252.9 5.8 1.3 2.3 0.2 0.62 0.34 0.07 0.19 0.03 -1.8 -2.8 0.5 -1.2 -0.1 1.05 1728.66 1.1759 0.0252 0.0141 0.0033 0.0001 0.4992 0.0027 0.0132 -0.0045 -0.0006
-67.5 112.5 85333 241 248 274 -70 256.6 5.9 1.3 2.1 0.5 0.87 0.51 0.11 0.26 0.09 -2.0 -2.8 0.4 -0.7 -0.3 -17.43 1121.25 1.1788 0.0235 0.0126 0.0033 0.0001 0.5175 -0.0033 0.0080 -0.0040 -0.0010
-67.5 127.5 84669 189 240 290 -10 257.0 5.6 1.3 2.2 0.6 0.77 0.45 0.11 0.23 0.09 -2.3 -2.7 0.1 -1.0 -0.2 -34.13 1194.19 1.1796 0.0233 0.0121 0.0033 0.0002 0.5249 -0.0041 0.0093 -0.0030 -0.0007
-67.5 142.5 87704 124 242 275 37 256.5 6.7 1.1 2.7 0.5 0.67 0.53 0.07 0.29 0.08 -2.9 -2.8 -0.3 -0.8 0.2 -43.58 921.49 1.1810 0.0233 0.0116 0.0033 0.0005 0.5556 -0.0120 0.0128 -0.0078 0.0013
-67.5 157.5 98547 -8 179 262 13 262.3 8.8 1.9 1.7 1.1 1.60 1.08 0.27 0.33 0.22 -1.7 -6.1 0.2 0.5 -0.6 -50.28 -0.00 1.1847 0.0228 0.0111 0.0027 0.0012 0.5605 -0.0171 0.0100 -0.0007 0.0017
-67.5 172.5 98466 64 165 267 64 264.3 7.6 2.6 0.7 1.0 1.90 1.00 0.35 0.19 0.21 -4.7 -3.4 -0.9 1.3 -0.2 -55.77 -0.00 1.1861 0.0226 0.0111 0.0020 0.0013 0.5502 -0.0072 0.0071 0.0016 0.0018
-67.5 -172.5 98308 135 168 235 138 265.6 6.5 2.5 0.7 0.8 2.08 0.87 0.34 0.17 0.17 -5.6 -2.1 -0.5 0.7 -0.4 -57.72 0.00 1.1875 0.0221 0.0112 0.0019 0.0010 0.5444 -0.0009 0.0076 0.0015 0.0036
-67.5 -157.5 98237 151 164 252 165 266.3 5.6 2.7 0.7 0.3 2.18 0.78 0.37 0.15 0.10 -5.8 -1.9 -0.9 0.5 -0.0 -54.39 0.00 1.1882 0.0215 0.0116 0.0021 0.0004 0.5423 0.0024 0.0076 0.0014 0.0045
-67.5 -142.5 98221 82 183 315 156 267.1 4.7 3.3 0.7 -0.5 2.29 0.68 0.43 0.15 -0.00 -6.3 -1.4 -1.4 0.4 0.5 -47.81 0.00 1.1888 0.0204 0.0122 0.0023 -0.0003 0.5400 0.0029 0.0051 0.0016 0.0050
-67.5 -127.5 98224 -2 186 379 105 267.9 4.0 3.3 0.6 -0.5 2.39 0.59 0.45 0.14 0.01 -6.5 -1.1 -1.1 0.2 0.5 -38.27 0.00 1.1893 0.0191 0.0126 0.0023 -0.0005 0.5387 0.0027 0.0050 0.0010 0.0040
-67.5 -112.5 98245 -107 190 388 70 268.8 3.2 3.0 0.5 -0.3 2.52 0.49 0.44 0.10 0.03 -7.0 -0.9 -0.8 0.3 0.4 -30.87 0.00 1.1898 0.0178 0.0127 0.0023 -0.0003 0.5352 0.0027 0.0046 0.0010 0.0033
-67.5 -97.5 98280 -205 184 338 77 269.6 2.6 2.7 0.3 -0.1 2.62 0.43 0.43 0.07 0.08 -7.3 -0.7 -0.5 0.2 0.4 -23.42 0.00 1.1901 0.0171 0.0127 0.0020 0.0001 0.5325 0.0021 0.0045 0.0018 0.0016
-67.5 -82.5 98399 -273 164 263 110 269.3 3.4 2.6 -0.3 -0.2 2.63 0.56 0.41 0.00 0.07 -6.5 -1.5 -0.8 0.8 0.4 -10.63 0.00 1.1897 0.0174 0.0126 0.0015 0.0004 0.5319 0.0003 0.0047 0.0023 0.0022
-67.5 -67.5 95784 -214 146 152 102 266.5 5.0 1.8 0.4 -0.0 2.09 0.78 0.26 0.07 0.08 -5.3 -1.5 -0.4 -0.0 0.5 8.64 241.84 1.1875 0.0192 0.0127 0.0011 0.0008 0.5323 -0.0040 0.0079 -0.0009 0.0024
-67.5 -52.5 98840 -244 206 83 82 264.0 8.1 0.9 0.7 0.4 1.86 1.10 0.15 0.20 0.11 0.6 -8.2 0.2 -0.6 0.2 7.64 0.00 1.1865 0.0207 0.0114 0.0009 0.0012 0.5518 -0.0111 0.0100 -0.0015 0.0023
-67.5 -37.5 98745 -108 158 98 88 264.1 8.1 1.5 0.2 0.2 1.88 1.03 0.18 0.13 0.07 -2.5 -6.5 -0.9 0.6 -0.1 8.22 0.00 1.1845 0.0217 0.0115 0.0009 0.0010 0.5479 -0.0089 0.0079 0.0007 0.0037
-67.5 -22.5 98599 -8 101 140 63 264.1 8.0 2.8 -0.2 -0.1 1.84 0.98 0.32 0.07 0.02 -3.9 -5.6 -1.6 1.4 0.1 6.14 0.00 1.1824 0.0224 0.0120 0.0012 0.0008 0.5446 -0.0076 0.0017 0.0019 0.0054
-67.5 -7.5 98456 65 48 123 -1 264.2 7.7 4.1 0.2 -0.7 1.80 0.95 0.45 0.11 -0.03 -4.5 -4.8 -2.5 1.2 1.0 8.62 -0.00 1.1803 0.0230 0.0132 0.0018 0.0001 0.5411 -0.0061 -0.0054 0.0011 0.0053
-82.5 7.5 66654 520 240 259 -65 241.5 6.5 1.5 2.5 -0.4 0.27 0.18 0.04 0.09 0.00 -3.4 -1.1 -0.1 -0.8 0.1 -9.93 2968.14 1.1543 0.0338 0.0197 0.0048 0.0010 0.4504 -0.0008 0.0111 -0.0021 0.0006
-82.5 22.5 64022 547 249 288 -78 239.7 6.6 1.6 2.6 -0.6 0.24 0.16 0.04 0.08 -0.00 -4.4 -0.7 0.1 -0.5 0.1 -5.53 3270.73 1.1528 0.0349 0.0205 0.0053 0.0010 0.4441 -0.0033 0.0119 -0.0021 0.0002
-82.5 37.5 61354 572 260 316 -86 235.9 7.3 1.2 3.1 -0.5 0.19 0.15 0.02 0.09 -0.00 -2.3 -1.8 0.1 -1.3 0.4 -0.84 3589.26 1.1513 0.0360 0.0211 0.0056 0.0011 0.4387 -0.0064 0.0139 -0.0029 0.0002
-82.5 52.5 60042 574 256 331 -84 231.5 9.4 1.5 4.4 -1.0 0.15 0.15 0.01 0.09 -0.00 -1.4 -1.5 2.6 -0.9 0.2 -2.07 3756.25 1.1497 0.0370 0.0213 0.0061 0.0011 0.4443 -0.0131 0.0152 -0.0070 0.0015
-82.5 67.5 57927 621 267 366 -84 232.1 7.4 1.1 3.4 -0.5 0.13 0.13 0.01 0.08 -0.00 -3.3 -1.1 0.1 -0.9 0.3 -0.16 4008.06 1.1501 0.0373 0.0218 0.0059 0.0013 0.4345 -0.0095 0.0164 -0.0062 -0.0000
-82.5 82.5 60415 562 253 346 -76 230.9 9.5 0.9 4.7 -0.7 0.12 0.15 0.00 0.10 -0.00 1.7 -3.7 3.2 -2.4 -0.5 -4.59 3719.25 1.1491 0.0371 0.0206 0.0063 0.0011 0.4585 -0.0189 0.0175 -0.0127 0.0012
-82.5 97.5 63132 520 250 350 -64 232.9 9.6 1.1 4.3 -0.8 0.14 0.16 0.00 0.10 -0.01 1.2 -4.3 -0.7 -2.1 1.1 -15.13 3403.22 1.1493 0.0365 0.0198 0.0062 0.0009 0.4670 -0.0176 0.0156 -0.0114 0.0022
-82.5 112.5 65578 480 234 340 -51 231.5 11.9 0.5 5.3 -1.1 0.15 0.19 0.00 0.12 -0.01 7.9 -8.8 3.9 -5.0 -0.3 -25.83 3121.46 1.1498 0.0360 0.0187 0.0061 0.0007 0.4763 -0.0200 0.0169 -0.0124 0.0029
-82.5 127.5 68457 490 239 357 -38 235.3 10.8 0.5 3.9 -1.1 0.18 0.21 0.00 0.13 -0.01 1.4 -4.2 -0.5 -1.7 0.9 -37.46 2787.16 1.1518 0.0348 0.0181 0.0054 0.0005 0.4773 -0.0148 0.0143 -0.0086 0.0047
-82.5 142.5 71861 518 238 352 -26 239.5 10.3 1.2 3.3 -1.3 0.24 0.24 0.01 0.13 -0.01 6.0 -8.6 -0.7 -2.7 1.4 -41.74 2404.42 1.1540 0.0337 0.0172 0.0051 0.0002 0.4823 -0.0119 0.0121 -0.0060 0.0053
-82.5 157.5 77401 521 265 320 -20 248.2 7.5 1.2 2.3 -1.0 0.35 0.27 0.03 0.14 -0.01 -2.4 -3.2 -0.3 -0.7 0.5 -37.62 1838.98 1.1570 0.0319 0.0161 0.0049 0.0001 0.4959 -0.0053 0.0096 -0.0026 0.0043
-82.5 172.5 98927 38 251 202 73 256.2 9.9 1.1 3.3 -1.4 0.56 0.60 0.03 0.35 -0.02 6.1 -6.7 -2.0 -2.5 0.9 -44.99 0.00 1.1610 0.0301 0.0136 0.0052 -0.0005 0.5933 -0.0219 0.0052 -0.0110 0.0047
-82.5 -172.5 98735 85 268 217 95 252.8 11.0 1.3 3.9 -1.4 0.64 0.68 0.03 0.39 -0.03 12.1 -9.6 -0.3 -4.2 2.5 -47.03 0.00 1.1615 0.0300 0.0138 0.0051 -0.0005 0.5836 -0.0235 0.0074 -0.0114 0.0067
-82.5 -157.5 98571 126 277 225 106 251.8 11.5 1.3 4.3 -1.5 0.65 0.72 0.03 0.41 -0.03 13.9 -10.9 1.7 -4.6 2.5 -46.69 -0.00 1.1628 0.0295 0.0141 0.0049 -0.0006 0.5801 -0.0244 0.0068 -0.0112 0.0082
-82.5 -142.5 93097 298 293 282 63 253.2 9.3 1.6 3.4 -1.3 0.73 0.63 0.07 0.33 -0.02 9.0 -8.3 2.4 -4.0 0.9 -43.63 427.00 1.1640 0.0289 0.0150 0.0042 -0.0003 0.5509 -0.0140 0.0058 -0.0072 0.0062
-82.5 -127.5 89159 329 300 280 20 253.7 8.2 1.5 2.8 -1.0 0.72 0.56 0.08 0.28 -0.01 4.4 -6.8 0.9 -3.4 1.0 -40.52 767.24 1.1638 0.0290 0.0156 0.0039 -0.0000 0.5356 -0.0107 0.0065 -0.0070 0.0039
-82.5 -112.5 80355 429 312 268 -23 250.4 6.7 1.6 2.1 -0.6 0.58 0.37 0.08 0.17 0.01 -0.1 -4.5 -0.0 -2.2 0.5 -33.87 1569.57 1.1617 0.0295 0.0168 0.0036 0.0005 0.4985 -0.0030 0.0067 -0.0047 0.0019
-82.5 -97.5 74298 453 300 236 -42 245.5 6.4 1.6 2.1 -0.3 0.43 0.27 0.06 0.13 0.01 -1.4 -1.6 -0.4 -0.7 0.4 -29.19 2164.18 1.1600 0.0302 0.0178 0.0035 0.0009 0.4783 0.0009 0.0079 -0.0032 0.0021
-82.5 -82.5 86490 168 238 150 -33 248.9 8.7 1.2 3.1 -0.6 0.43 0.42 0.02 0.23 -0.01 -1.2 -3.5 0.8 -1.4 0.4 -28.77 1049.66 1.1602 0.0292 0.0159 0.0038 0.0007 0.5577 -0.0233 0.0098 -0.0132 0.0052
-82.5 -67.5 96005 -59 176 91 -31 251.8 10.1 1.0 3.5 -0.5 0.55 0.60 0.02 0.33 -0.01 3.0 -5.5 1.1 -2.7 0.8 -25.52 256.20 1.1619 0.0284 0.0147 0.0038 0.0008 0.5957 -0.0337 0.0075 -0.0173 0.0039
-82.5 -52.5 88361 187 187 156 -31 252.8 7.3 1.4 2.2 -0.2 0.52 0.42 0.06 0.20 0.02 -0.6 -3.5 0.4 -1.4 0.3 -21.98 867.46 1.1618 0.0285 0.0155 0.0033 0.0010 0.5471 -0.0146 0.0056 -0.0104 0.0010
-82.5 -37.5 84477 262 191 169 -23 250.2 8.0 1.3 2.6 -0.3 0.46 0.41 0.04 0.21 0.00 1.4 -5.3 0.1 -2.5 0.4 -18.26 1207.48 1.1602 0.0294 0.0160 0.0035 0.0010 0.5299 -0.0147 0.0079 -0.0115 0.0030
-82.5 -22.5 75291 429 210 211 -33 247.6 6.0 1.5 1.9 -0.3 0.40 0.26 0.06 0.12 0.01 -1.9 -1.6 0.6 -1.3 -0.2 -13.77 2061.01 1.1583 0.0308 0.0176 0.0037 0.0010 0.4840 -0.0022 0.0096 -0.0052 0.0019
-82.5 -7.5 68257 516 232 241 -49 244.5 5.3 1.6 1.7 -0.3 0.32 0.17 0.05 0.08 0.00 -4.3 -0.5 0.1 -0.4 0.0 -10.43 2782.40 1.1562 0.0328 0.0192 0.0042 0.0010 0.4542 0.0019 0.0112 -0.0016 0.0003
Source diff could not be displayed: it is too large. Options to address this: view the blob.
% This is not an original GPT2 grid, it has been edited for test purposes and should not be used except for test
% lat lon p:a0 A1 B1 A2 B2 T:a0 A1 B1 A2 B2 Q:a0 A1 B1 A2 B2 dT:a0 A1 B1 A2 B2 undu Hs h:a0 A1 B1 A2 B2 w:a0 A1 B1 A2 B2
52.5 12.5 100913 30 -28 9 -14 283.4 -9.1 -2.9 -0.0 0.3 6.02 -2.61 -1.33 0.29 0.32 -4.6 1.0 -0.3 -0.1 -0.0 41.28 52.71 1.2352 -0.0211 -0.0108 0.0008 0.0009 0.5583 -0.0126 -0.0125 0.0040 0.0012
52.5 17.5 100434 46 -48 -8 -16 282.7 -10.0 -3.0 0.0 0.2 5.88 -2.85 -1.38 0.39 0.36 -4.3 1.1 -0.2 -0.2 0.1 34.11 93.18 1.2344 -0.0225 -0.0111 0.0010 0.0007 0.5578 -0.0120 -0.0115 0.0049 0.0017
47.5 12.5 89942 -161 -172 56 16 281.0 -8.4 -3.1 0.1 0.1 5.13 -2.91 -1.20 0.34 0.34 -6.5 0.6 -0.2 0.2 -0.1 47.30 1024.64 1.2395 -0.0209 -0.0110 0.0010 0.0008 0.5243 -0.0055 -0.0101 0.0041 0.0011
47.5 17.5 99762 183 -97 41 -6 284.8 -10.5 -2.7 -0.3 0.1 6.21 -3.28 -1.34 0.41 0.22 -5.4 1.6 -0.0 0.0 0.1 44.86 160.75 1.2406 -0.0219 -0.0106 0.0008 0.0005 0.5649 -0.0088 -0.0096 0.0044 0.0026
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Please register or to comment