diff --git a/cpp/CMakeLists.txt b/cpp/CMakeLists.txt index 9505ade91e2d98ce999e5e7e240e34c97d804ad8..672938b2a78da648a660438a3140dbe73ad27095 100644 --- a/cpp/CMakeLists.txt +++ b/cpp/CMakeLists.txt @@ -28,6 +28,7 @@ add_library(everybeam SHARED telescope/oskar.cc griddedresponse/griddedresponse.cc griddedresponse/lofargrid.cc + griddedresponse/oskargrid.cc griddedresponse/dishgrid.cc griddedresponse/mwagrid.cc circularsymmetric/voltagepattern.cc diff --git a/cpp/griddedresponse/CMakeLists.txt b/cpp/griddedresponse/CMakeLists.txt index 2ed7a567bb480cccd7bbd82d10f99053089d5e3e..f2d7117bd005916d72648bde17fe5c47424836c3 100644 --- a/cpp/griddedresponse/CMakeLists.txt +++ b/cpp/griddedresponse/CMakeLists.txt @@ -1,6 +1,7 @@ install (FILES griddedresponse.h lofargrid.h + oskargrid.h dishgrid.h mwagrid.h DESTINATION "include/${CMAKE_PROJECT_NAME}/griddedresponse") diff --git a/cpp/griddedresponse/griddedresponse.h b/cpp/griddedresponse/griddedresponse.h index f1dc5068638fbe95dfbcd975f213dfd69b5c6861..957b03ed12a688d555e81b19aa721e8b1da21846 100644 --- a/cpp/griddedresponse/griddedresponse.h +++ b/cpp/griddedresponse/griddedresponse.h @@ -1,4 +1,4 @@ -// GriddedResponse.h: Base class for computing the (gridded) telescope response. +// griddedresponse.h: Base class for computing the (gridded) telescope response. // // Copyright (C) 2020 // ASTRON (Netherlands Institute for Radio Astronomy) diff --git a/cpp/griddedresponse/lofargrid.h b/cpp/griddedresponse/lofargrid.h index 40d41de119d8100cc9a11fea7936039e7705d3af..eb620f20c7b3c807989669ac78be9aa6f1d37d35 100644 --- a/cpp/griddedresponse/lofargrid.h +++ b/cpp/griddedresponse/lofargrid.h @@ -1,4 +1,4 @@ -// LOFARGrid.h: Class for computing the LOFAR (gridded) response. +// lofargrid.h: Class for computing the LOFAR (gridded) response. // // Copyright (C) 2020 // ASTRON (Netherlands Institute for Radio Astronomy) @@ -39,8 +39,6 @@ namespace griddedresponse { */ class LOFARGrid final : public GriddedResponse { public: - // typedef std::unique_ptr<LOFARGrid> Ptr; - /** * @brief Construct a new LOFARGrid object * @@ -54,8 +52,8 @@ class LOFARGrid final : public GriddedResponse { * @brief Compute the Beam response for a single station * * @param buffer Output buffer, compute and set size with - * GriddedResponse::GetStationBufferSize(1) - * @param stationIdx Station index, must be smaller than number of stations + * GriddedResponse::GetBufferSize(1) + * @param station_idx Station index, must be smaller than number of stations * in the Telescope * @param time Time, modified Julian date, UTC, in seconds (MJD(UTC), s). * @param freq Frequency (Hz) diff --git a/cpp/griddedresponse/oskargrid.cc b/cpp/griddedresponse/oskargrid.cc new file mode 100644 index 0000000000000000000000000000000000000000..e07dd63d0a88a43df4898acc33044e45057aacc8 --- /dev/null +++ b/cpp/griddedresponse/oskargrid.cc @@ -0,0 +1,143 @@ +#include "oskargrid.h" +#include "./../telescope/oskar.h" + +#include <aocommon/imagecoordinates.h> +#include <aocommon/threadpool.h> +#include <cmath> +#include <iostream> + +using everybeam::griddedresponse::OSKARGrid; + +OSKARGrid::OSKARGrid(telescope::Telescope* telescope_ptr, + const coords::CoordinateSystem& coordinate_system) + : GriddedResponse(telescope_ptr, coordinate_system) { + const telescope::OSKAR& oskartelescope = + dynamic_cast<const telescope::OSKAR&>(*telescope_); + size_t ncpus = aocommon::ThreadPool::NCPUs(); + + // Set private members + nthreads_ = std::min(ncpus, oskartelescope.nstations_); + threads_.resize(nthreads_); + delay_dir_ = oskartelescope.ms_properties_.delay_dir; + tile_beam_dir_ = oskartelescope.ms_properties_.delay_dir; +}; + +void OSKARGrid::CalculateStation(std::complex<float>* buffer, double time, + double frequency, size_t station_idx, size_t) { + const telescope::OSKAR& oskartelescope = + static_cast<const telescope::OSKAR&>(*telescope_); + aocommon::Lane<Job> lane(nthreads_); + lane_ = &lane; + + SetITRFVectors(time); + + for (size_t i = 0; i != nthreads_; ++i) { + threads_[i] = + std::thread(&OSKARGrid::CalcThread, this, buffer, time, frequency); + } + + for (size_t y = 0; y != height_; ++y) { + lane.write(Job{.y = y, .antenna_idx = station_idx, .buffer_offset = 0}); + } + + lane.write_end(); + for (size_t i = 0; i != nthreads_; ++i) threads_[i].join(); +} + +void OSKARGrid::CalculateAllStations(std::complex<float>* buffer, double time, + double frequency, size_t) { + const telescope::OSKAR& oskartelescope = + static_cast<const telescope::OSKAR&>(*telescope_); + aocommon::Lane<Job> lane(nthreads_); + lane_ = &lane; + + SetITRFVectors(time); + + // Prepare threads + for (size_t i = 0; i != nthreads_; ++i) { + threads_[i] = + std::thread(&OSKARGrid::CalcThread, this, buffer, time, frequency); + } + + for (size_t y = 0; y != height_; ++y) { + for (size_t antenna_idx = 0; antenna_idx != oskartelescope.GetNrStations(); + ++antenna_idx) { + lane.write(Job{ + .y = y, .antenna_idx = antenna_idx, .buffer_offset = antenna_idx}); + } + } + + lane.write_end(); + for (size_t i = 0; i != nthreads_; ++i) threads_[i].join(); +} + +void OSKARGrid::SetITRFVectors(double time) { + coords::ITRFConverter itrf_converter(time); + coords::SetITRFVector(itrf_converter.ToDirection(delay_dir_), station0_); + coords::SetITRFVector(itrf_converter.ToDirection(tile_beam_dir_), tile0_); + + const casacore::Unit rad_unit("rad"); + + casacore::MDirection l_dir( + casacore::MVDirection(casacore::Quantity(ra_ + M_PI / 2, rad_unit), + casacore::Quantity(0, rad_unit)), + casacore::MDirection::J2000); + coords::SetITRFVector(itrf_converter.ToDirection(l_dir), l_vector_itrf_); + + casacore::MDirection m_dir( + casacore::MVDirection(casacore::Quantity(ra_, rad_unit), + casacore::Quantity(dec_ + M_PI / 2, rad_unit)), + casacore::MDirection::J2000); + coords::SetITRFVector(itrf_converter.ToDirection(m_dir), m_vector_itrf_); + + casacore::MDirection n_dir( + casacore::MVDirection(casacore::Quantity(ra_, rad_unit), + casacore::Quantity(dec_, rad_unit)), + casacore::MDirection::J2000); + coords::SetITRFVector(itrf_converter.ToDirection(n_dir), n_vector_itrf_); + + coords::SetITRFVector(itrf_converter.ToDirection(preapplied_beam_dir_), + diff_beam_centre_); +} + +void OSKARGrid::CalcThread(std::complex<float>* buffer, double time, + double frequency) { + const telescope::OSKAR& oskartelescope = + static_cast<const telescope::OSKAR&>(*telescope_); + const size_t values_per_ant = width_ * height_ * 4; + double sb_freq = use_channel_frequency_ ? frequency : subband_frequency_; + + Job job; + while (lane_->read(job)) { + for (size_t x = 0; x != width_; ++x) { + double l, m, n; + aocommon::ImageCoordinates::XYToLM(x, job.y, dl_, dm_, width_, height_, l, + m); + l += phase_centre_dl_; + m += phase_centre_dm_; + n = sqrt(1.0 - l * l - m * m); + + vector3r_t itrf_direction; + + itrf_direction[0] = + l * l_vector_itrf_[0] + m * m_vector_itrf_[0] + n * n_vector_itrf_[0]; + itrf_direction[1] = + l * l_vector_itrf_[1] + m * m_vector_itrf_[1] + n * n_vector_itrf_[1]; + itrf_direction[2] = + l * l_vector_itrf_[2] + m * m_vector_itrf_[2] + n * n_vector_itrf_[2]; + + std::complex<float>* base_buffer = buffer + (x + job.y * height_) * 4; + + std::complex<float>* ant_buffer_ptr = + base_buffer + job.buffer_offset * values_per_ant; + + matrix22c_t gain_matrix = oskartelescope.GetStation(job.antenna_idx) + ->Response(time, frequency, itrf_direction, + sb_freq, station0_, tile0_); + ant_buffer_ptr[0] = gain_matrix[0][0]; + ant_buffer_ptr[1] = gain_matrix[0][1]; + ant_buffer_ptr[2] = gain_matrix[1][0]; + ant_buffer_ptr[3] = gain_matrix[1][1]; + } + } +} diff --git a/cpp/griddedresponse/oskargrid.h b/cpp/griddedresponse/oskargrid.h new file mode 100644 index 0000000000000000000000000000000000000000..fb92fc0886429cc97bd76f26a17e9f208d2e4202 --- /dev/null +++ b/cpp/griddedresponse/oskargrid.h @@ -0,0 +1,105 @@ +// oskargrid.h: Class for computing the OSKAR (gridded) response. +// +// Copyright (C) 2020 +// ASTRON (Netherlands Institute for Radio Astronomy) +// P.O.Box 2, 7990 AA Dwingeloo, The Netherlands +// +// This file is part of the EveryBeam software suite. +// The EveryBeam software suite is free software: you can redistribute it and/or +// modify it under the terms of the GNU General Public License as published +// by the Free Software Foundation, either version 3 of the License, or +// (at your option) any later version. +// +// The EveryBeam software suite is distributed in the hope that it will be +// useful, but WITHOUT ANY WARRANTY; without even the implied warranty of +// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +// GNU General Public License for more details. +// +// You should have received a copy of the GNU General Public License along +// with the EveryBeam software suite. If not, see +// <http://www.gnu.org/licenses/>. +// +// $Id$ + +#ifndef EVERYBEAM_GRIDDEDRESPONSE_OSKARGRID_H_ +#define EVERYBEAM_GRIDDEDRESPONSE_OSKARGRID_H_ + +#include "griddedresponse.h" +#include <iostream> +#include <aocommon/matrix2x2.h> +#include <complex> +#include <limits> + +namespace everybeam { +namespace griddedresponse { + +/** + * @brief Class for computing the OSKAR gridded response + * + */ +class OSKARGrid final : public GriddedResponse { + public: + /** + * @brief Construct a new OSKARGrid object + * + * @param telescope_ptr Pointer to telescope::OSKAR object + * @param coordinate_system CoordinateSystem struct + */ + OSKARGrid(telescope::Telescope* telescope_ptr, + const coords::CoordinateSystem& coordinate_system); + + /** + * @brief Compute the Beam response for a single station + * + * @param buffer Output buffer, compute and set size with + * GriddedResponse::GetBufferSize(1) + * @param station_idx Station index, must be smaller than number of stations + * in the Telescope + * @param time Time, modified Julian date, UTC, in seconds (MJD(UTC), s). + * @param freq Frequency (Hz) + */ + void CalculateStation(std::complex<float>* buffer, double time, + double frequency, size_t station_idx, + size_t field_id) override; + + /** + * @brief Compute the Beam response for all stations in a Telescope + * + * @param buffer Output buffer, compute and set size with + * GriddedResponse::GetBufferSize() + * @param time Time, modified Julian date, UTC, in seconds (MJD(UTC), s). + * @param freq Frequency (Hz) + */ + void CalculateAllStations(std::complex<float>* buffer, double time, + double frequency, size_t field_id) override; + + private: + casacore::MDirection delay_dir_, tile_beam_dir_, preapplied_beam_dir_; + vector3r_t station0_, tile0_, l_vector_itrf_, m_vector_itrf_, n_vector_itrf_, + diff_beam_centre_; + bool use_channel_frequency_; + double subband_frequency_; + + std::vector<aocommon::MC2x2F> inverse_central_gain_; + + std::size_t nthreads_; + std::vector<std::thread> threads_; + + struct Job { + size_t y, antenna_idx, buffer_offset; + }; + aocommon::Lane<Job>* lane_; + + /** + * @brief Method for computing the ITRF-vectors. + * NOTE: method not thread-safe due to casacore dependencies. + * + * @param time + */ + void SetITRFVectors(double time); + + void CalcThread(std::complex<float>* buffer, double time, double frequency); +}; +} // namespace griddedresponse +} // namespace everybeam +#endif // EVERYBEAM_GRIDDEDRESPONSE_OSKARGRID_H_ diff --git a/cpp/oskar/oskarelementresponse.cc b/cpp/oskar/oskarelementresponse.cc index f1669f35db033da1254d7a9369d5165f2c8b516b..1609286575da7a29572ccf8703b60312bf92347d 100644 --- a/cpp/oskar/oskarelementresponse.cc +++ b/cpp/oskar/oskarelementresponse.cc @@ -44,6 +44,8 @@ void OSKARElementResponseSphericalWave::Response( void OSKARElementResponseSphericalWave::Response( int element_id, double freq, double theta, double phi, std::complex<double> (&response)[2][2]) const { + element_id = 0; + auto dataset = datafile_->Get(freq); auto l_max = dataset->GetLMax(); diff --git a/cpp/telescope/oskar.cc b/cpp/telescope/oskar.cc index f3b9c151d11c7a9e7a36f26f413a23117f10924b..cf16dcd45f9791a4a78c6ea884c1be3a11be15a5 100644 --- a/cpp/telescope/oskar.cc +++ b/cpp/telescope/oskar.cc @@ -1,4 +1,5 @@ #include "oskar.h" +#include "../griddedresponse/oskargrid.h" #include "../common/mathutils.h" #include "../common/casautils.h" #include "../msv3readutils.h" @@ -7,31 +8,31 @@ #include <cassert> #include <casacore/measures/TableMeasures/ArrayMeasColumn.h> -using namespace everybeam; -using namespace everybeam::telescope; -using namespace casacore; +using casacore::MeasurementSet; +using everybeam::Station; +using everybeam::griddedresponse::GriddedResponse; +using everybeam::griddedresponse::OSKARGrid; +using everybeam::telescope::OSKAR; OSKAR::OSKAR(MeasurementSet &ms, const Options &options) : Telescope(ms, options) { stations_.resize(nstations_); ReadAllStations(ms, options_.element_response_model); -} -std::unique_ptr<griddedresponse::GriddedResponse> OSKAR::GetGriddedResponse( - const coords::CoordinateSystem &coordinate_system) { - throw std::runtime_error( - "GetGriddedResponse() is not implemented for OSKAR Telescope"); + casacore::ScalarMeasColumn<casacore::MDirection> delay_dir_col( + ms.field(), + casacore::MSField::columnName(casacore::MSFieldEnums::DELAY_DIR)); - // TODO: return an OSKARGrid here, in a similar way to the commented out code - // below + // Populate struct + ms_properties_ = {.delay_dir = delay_dir_col(0)}; +} +std::unique_ptr<GriddedResponse> OSKAR::GetGriddedResponse( + const coords::CoordinateSystem &coordinate_system) { // Get and return GriddedResponse ptr - // std::unique_ptr<griddedresponse::GriddedResponse> grid( - // new griddedresponse::LOFARGrid(this, coordinate_system)); - // // griddedresponse::GriddedResponse grid(LOFARGrid(this, - // coordinate_system)); - // return grid; -}; + std::unique_ptr<GriddedResponse> grid(new OSKARGrid(this, coordinate_system)); + return grid; +} Station::Ptr OSKAR::ReadStation(const MeasurementSet &ms, std::size_t id, const ElementResponseModel model) const { diff --git a/cpp/telescope/oskar.h b/cpp/telescope/oskar.h index 250e89ba8cfbda57c1bfb07b784aafd2901c3e0f..41b8d1639104cbfdc58d9b1cac2959518cfc4c78 100644 --- a/cpp/telescope/oskar.h +++ b/cpp/telescope/oskar.h @@ -1,4 +1,4 @@ -// OSKARTelescope.h: Base class for computing the response for the OSKAR +// oskar.h: Base class for computing the response for the OSKAR // telescope. // // Copyright (C) 2020 @@ -36,10 +36,17 @@ namespace everybeam { +namespace griddedresponse { +class OSKARGrid; +class GriddedResponse; +} // namespace griddedresponse + namespace telescope { //! OSKAR telescope class class OSKAR final : public Telescope { + friend class griddedresponse::OSKARGrid; + public: /** * @brief Construct a new OSKAR object @@ -80,6 +87,12 @@ class OSKAR final : public Telescope { const ElementResponseModel model) const; std::vector<Station::Ptr> stations_; + + struct MSProperties { + casacore::MDirection delay_dir; + }; + + MSProperties ms_properties_; }; } // namespace telescope } // namespace everybeam diff --git a/demo/CMakeLists.txt b/demo/CMakeLists.txt index f5dd3d4989958a89933785ab54ab925579fe0a9e..5538b3ad952f9cb418e556ae6afd0237aebf2531 100644 --- a/demo/CMakeLists.txt +++ b/demo/CMakeLists.txt @@ -1,4 +1,5 @@ add_subdirectory(comparison-oskar) +add_subdirectory(wsclean-oskar) set(TEST_MEASUREMENTSET CACHE STRING "measurement set used for testing") diff --git a/demo/comparison-oskar/CMakeLists.txt b/demo/comparison-oskar/CMakeLists.txt index c749680334aca52d4cbaf71f9ab3f84efb2e7ac7..a32c038b8332c8e2b021215931b5e157dd2ab547 100644 --- a/demo/comparison-oskar/CMakeLists.txt +++ b/demo/comparison-oskar/CMakeLists.txt @@ -35,6 +35,7 @@ add_custom_target(comparison-oskar-basefunctions add_custom_target(comparison-oskar-station-response COMMAND ${CMAKE_COMMAND} -E env EXTRA_PATH="${CMAKE_CURRENT_BINARY_DIR}:${CMAKE_SOURCE_DIR}/scripts/coeff_scripts:${CMAKE_SOURCE_DIR}/scripts/misc" + DATA_DIR=${CMAKE_SOURCE_DIR}/test_data "${CMAKE_CURRENT_SOURCE_DIR}/compare_stationresponse.sh" DEPENDS make_station_response_image ) diff --git a/demo/comparison-oskar/compare_stationresponse.py b/demo/comparison-oskar/compare_stationresponse.py index f73319133efef7329f0de868262856d2d8cea134..f2330ede586b9e2b382b422726b71174af599d00 100644 --- a/demo/comparison-oskar/compare_stationresponse.py +++ b/demo/comparison-oskar/compare_stationresponse.py @@ -8,11 +8,12 @@ import subprocess tolerance = float(os.environ["TOLERANCE"]) if "TOLERANCE" in os.environ else 0.0 npixels = int(os.environ["NPIXELS"]) if "NPIXELS" in os.environ else 256 +data_dir = os.environ["DATA_DIR"] run_oskar_simulation.main(npixels) -subprocess.check_call(["add_beaminfo.py", "skalowmini-coef.MS", "skalowmini-coef.tm"]) -subprocess.check_call(["oskar_csv_to_hdf5.py", "skalowmini-coef.tm", "oskar.h5"]) +subprocess.check_call(["add_beaminfo.py", "skalowmini-coef.MS", os.path.join(data_dir, "skalowmini-coef.tm")]) +subprocess.check_call(["oskar_csv_to_hdf5.py", os.path.join(data_dir, "skalowmini-coef.tm"), "oskar.h5"]) subprocess.check_call(["./make_station_response_image", str(npixels)]) A = read_oskar_beams() diff --git a/demo/comparison-oskar/run_oskar_simulation.py b/demo/comparison-oskar/run_oskar_simulation.py index 49c1a8a32b39893be7ef63f03560184625745a7f..fe8d528d55ea004ab61c68261be094f40a313144 100755 --- a/demo/comparison-oskar/run_oskar_simulation.py +++ b/demo/comparison-oskar/run_oskar_simulation.py @@ -5,7 +5,7 @@ Generates all-sky zenith-centred beam patterns for SKALA-4 and EDA-2 antennas. import copy import glob -import os.path +import os import re import subprocess @@ -34,6 +34,8 @@ def main(npixels): app2 = 'oskar_sim_beam_pattern' settings_path = '_temp_settings.ini' + data_dir = os.environ["DATA_DIR"] + # Define some basic observation parameters. ra0_deg = 0.0 dec0_deg = -27.0 @@ -64,7 +66,7 @@ def main(npixels): telescopes = { #'stationresponse': { 'basefunctions': { - 'telescope/input_directory': 'skalowmini-coef.tm', + 'telescope/input_directory': os.path.join(data_dir, 'skalowmini-coef.tm'), 'telescope/aperture_array/element_pattern/enable_numerical': True, 'telescope/aperture_array/element_pattern/swap_xy': False, 'telescope/aperture_array/array_pattern/enable': True, diff --git a/demo/comparison-oskar/skalowmini-coef.tm/layout_ecef.txt b/demo/comparison-oskar/skalowmini-coef.tm/layout_ecef.txt deleted file mode 100644 index d8fd2cae5596f55ca98e1e3748a1114dde0204f3..0000000000000000000000000000000000000000 --- a/demo/comparison-oskar/skalowmini-coef.tm/layout_ecef.txt +++ /dev/null @@ -1,10 +0,0 @@ --2564897.754 5085472.868 -2860897.728 --2564857.457 5085483.379 -2860915.054 --2564879.572 5085459.774 -2860937.039 --2564915.084 5085446.228 -2860929.333 --2564937.929 5085452.164 -2860898.506 --2564930.594 5085473.758 -2860866.911 --2564898.762 5085494.730 -2860858.228 --2564866.129 5085499.150 -2860879.485 --2564769.654 5085506.402 -2860952.591 --2564728.973 5085523.918 -2860957.889 diff --git a/demo/wsclean-oskar/CMakeLists.txt b/demo/wsclean-oskar/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..4654c53f0a1b938bb7b51eeb22462d95e96ff84f --- /dev/null +++ b/demo/wsclean-oskar/CMakeLists.txt @@ -0,0 +1,36 @@ +set(MS "testdata.ms") + +# Generate the test MeasurementSet +add_custom_command( + OUTPUT testdata.ms + COMMAND ${CMAKE_COMMAND} -E env + EXTRA_PATH="${CMAKE_SOURCE_DIR}/scripts/misc" + DATA_DIR="${CMAKE_SOURCE_DIR}/test_data" + "${CMAKE_CURRENT_SOURCE_DIR}/run_oskar_simulation.sh" + DEPENDS run_oskar_simulation.sh run_oskar_simulation.py) + +# Generate a template image using the pointing in the test MeasurementSet +add_custom_command( + OUTPUT template-image.fits + COMMAND wsclean -name template -interval 0 1 -no-dirty -scale 2amin -size 300 300 ${MS} + DEPENDS testdata.ms) + +set(MODEL_IMAGES wsclean-I-model.fits wsclean-Q-model.fits wsclean-U-model.fits wsclean-V-model.fits) + +# Use template image to generate model images with pointsources +add_custom_command( + OUTPUT ${MODEL_IMAGES} + COMMAND ${CMAKE_COMMAND} -E env + EXTRA_PATH="" + "${CMAKE_CURRENT_SOURCE_DIR}/make_model_images.sh" + DEPENDS template-image.fits make_model_images.sh make_model_images.py) + +# Main target to run the wsclean-oskar tests +# Uses the test MeasurementSet and model images as input +add_custom_target(run-wsclean-oskar + COMMAND ${CMAKE_COMMAND} -E env + EXTRA_PATH="${CMAKE_CURRENT_BINARY_DIR}:${CMAKE_SOURCE_DIR}/scripts/coeff_scripts" + DATA_DIR="${CMAKE_SOURCE_DIR}/test_data" + MS=${MS} + "${CMAKE_CURRENT_SOURCE_DIR}/run_wsclean_oskar.sh" + DEPENDS ${MODEL_IMAGES} testdata.ms run_wsclean_oskar.sh) diff --git a/demo/wsclean-oskar/aterm.conf b/demo/wsclean-oskar/aterm.conf new file mode 100644 index 0000000000000000000000000000000000000000..3c09fb5c4bc636f3fc0d551c5ff1d3e92ff4fe35 --- /dev/null +++ b/demo/wsclean-oskar/aterm.conf @@ -0,0 +1,4 @@ +aterms = [beam] + +beam.element_response_model=oskarsphericalwave +beam.update_interval=1800 diff --git a/demo/wsclean-oskar/make_model_images.py b/demo/wsclean-oskar/make_model_images.py new file mode 100644 index 0000000000000000000000000000000000000000..a793be6d8b1d19419ab36f68958ae936ced788c0 --- /dev/null +++ b/demo/wsclean-oskar/make_model_images.py @@ -0,0 +1,27 @@ +from astropy.io import fits + +with fits.open("template-image.fits") as img: + + N = img[0].data.shape[-1] + + offset = N//4 + + img[0].data[:] = 0.0 + img[0].data[0,0,offset,offset] = 1.0 + img[0].data[0,0,offset,N-offset] = 1.0 + img[0].data[0,0,N-offset,offset] = 1.0 + img[0].data[0,0,N-offset,N-offset] = 1.0 + img.writeto('wsclean-I-model.fits', overwrite = True) + + img[0].data[:] = 0.0 + img[0].data[0,0,offset,N-offset] = 1.0 + img.writeto('wsclean-Q-model.fits', overwrite = True) + + img[0].data[:] = 0.0 + img[0].data[0,0,N-offset,offset] = 1.0 + img.writeto('wsclean-U-model.fits', overwrite = True) + + img[0].data[:] = 0.0 + img[0].data[0,0,N-offset,N-offset] = 1.0 + img.writeto('wsclean-V-model.fits', overwrite = True) + diff --git a/demo/wsclean-oskar/make_model_images.sh b/demo/wsclean-oskar/make_model_images.sh new file mode 100755 index 0000000000000000000000000000000000000000..b4a3a322564322c8793a827f9e38c848c35ed8de --- /dev/null +++ b/demo/wsclean-oskar/make_model_images.sh @@ -0,0 +1,5 @@ +#!/bin/sh + +export PATH=$EXTRA_PATH:$PATH +python3 -B `dirname "${0}"`/make_model_images.py + diff --git a/demo/wsclean-oskar/run_oskar_simulation.py b/demo/wsclean-oskar/run_oskar_simulation.py new file mode 100755 index 0000000000000000000000000000000000000000..ae5aaf1930bd8f92f4c656189070d510993580c2 --- /dev/null +++ b/demo/wsclean-oskar/run_oskar_simulation.py @@ -0,0 +1,104 @@ +#!/usr/bin/env python3 +""" +Generates all-sky zenith-centred beam patterns for SKALA-4 and EDA-2 antennas. +""" + +import copy +import glob +import os.path +import re +import subprocess + +from astropy.io import fits +from astropy.time import Time, TimeDelta +import matplotlib +matplotlib.use('Agg') +# pylint: disable=wrong-import-position +import matplotlib.pyplot as plt +import numpy +import oskar + + +def get_start_time(ra0_deg, length_sec): + """Returns optimal start time for field RA and observation length.""" + t = Time('2000-01-01 12:00:00', scale='utc', location=('116.764d', '0d')) + dt_hours = (24.0 - t.sidereal_time('apparent').hour) / 1.0027379 + dt_hours += (ra0_deg / 15.0) + start = t + TimeDelta(dt_hours * 3600.0 - length_sec / 2.0, format='sec') + return start.value + +def main(): + """Main function.""" + # Name of the application to run, and a settings file for it. + app1 = 'oskar_sim_interferometer' + settings_path = '_temp_settings.ini' + data_dir = os.environ["DATA_DIR"] + src_dir = os.path.dirname(__file__) + + # Define some basic observation parameters. + ra0_deg = 20.0 + dec0_deg = -30.0 + length_sec = 3600.0*8 + + # Define base settings dictionary. + common_settings = { + 'observation': { + 'phase_centre_ra_deg': ra0_deg, + 'phase_centre_dec_deg': dec0_deg, + #'pointing_file': 'station_pointing.txt', + 'start_time_utc': get_start_time(ra0_deg, length_sec), + 'length': length_sec, + 'num_time_steps': 600 + + }, + 'telescope': { + 'normalise_beams_at_phase_centre': False, + 'aperture_array/element_pattern/normalise': False + }, + } + + # Define frequencies of interest (in MHz). + freqs = [50] + #freqs = [70] + + # Define telescope models to use, and associated overrides for them. + telescopes = { + #'stationresponse': { + 'basefunctions': { + 'telescope/input_directory': os.path.join(data_dir, 'skalowmini-coef.tm'), + 'telescope/aperture_array/element_pattern/enable_numerical': True, + 'telescope/aperture_array/element_pattern/swap_xy': True, + 'telescope/aperture_array/array_pattern/enable': True, + 'telescope/aperture_array/array_pattern/normalise': True + }, + } + + # Loop over telescope models. + for tel, tel_params in telescopes.items(): + + # Copy the base settings diction.ary. + current_settings = copy.deepcopy(common_settings) + + # Update current settings with telescope model parameters. + current_settings.update(tel_params) + + # Loop over frequencies. + for freq in freqs: + + # Create the settings file. + open(settings_path, 'w').close() + settings = oskar.SettingsTree(app1, settings_path) + settings.from_dict(current_settings) + + # Update output root path and frequency. + tel_root = re.sub(r'[^\w]', '', tel) # Strip symbols from tel. + root_path = tel_root + ('_%03d_MHz' % freq) + settings['observation/start_frequency_hz'] = 1e6 * freq + settings['interferometer/ms_filename'] = 'testdata.ms' + settings['sky/oskar_sky_model/file'] = os.path.join(src_dir, 'sky.osm') + + # Run the app with the settings file. + subprocess.call([app1, settings_path]) + +if __name__ == '__main__': + main() diff --git a/demo/wsclean-oskar/run_oskar_simulation.sh b/demo/wsclean-oskar/run_oskar_simulation.sh new file mode 100755 index 0000000000000000000000000000000000000000..d10478ea7222a74e3ddc7e0baaa262bea6034d5d --- /dev/null +++ b/demo/wsclean-oskar/run_oskar_simulation.sh @@ -0,0 +1,5 @@ +#!/bin/sh + +export PATH=$EXTRA_PATH:$PATH +python3 -B `dirname "${0}"`/run_oskar_simulation.py +add_beaminfo.py testdata.ms ${DATA_DIR}/skalowmini-coef.tm diff --git a/demo/wsclean-oskar/run_wsclean_oskar.sh b/demo/wsclean-oskar/run_wsclean_oskar.sh new file mode 100755 index 0000000000000000000000000000000000000000..61161304369cfabfa644c907085101d00260c980 --- /dev/null +++ b/demo/wsclean-oskar/run_wsclean_oskar.sh @@ -0,0 +1,30 @@ +#!/bin/sh +set -e + +SRC_DIR="$( cd "$( dirname "${0}" )" >/dev/null 2>&1 && pwd )" + +atermoptions="-aterm-config ${SRC_DIR}/aterm.conf" # -save-aterms" + +intervaloptions="-interval 0 100" + +# Workaround to generate beam image oskar-1-1-beam-I.fits +wsclean ${intervaloptions} -name oskar-1 -no-dirty -scale 2amin -size 300 300 ${atermoptions} -use-idg -niter 1 ${MS} + +# run wsclean on OSKAR generated data, without and with beam correction +wsclean ${intervaloptions} -name oskar-0 -data-column DATA -pol IQUV -no-dirty -scale 2amin -size 300 300 ${MS} +wsclean ${intervaloptions} -name oskar-1 -data-column DATA -pol IQUV -no-dirty -scale 2amin -size 300 300 ${atermoptions} -use-idg ${MS} + +# use wsclean to generate model data without beam, and to image it without beam correction +wsclean ${intervaloptions} -predict -pol IQUV -use-idg ${MS} +wsclean ${intervaloptions} -name oskar-0-0 -data-column MODEL_DATA -pol IQUV -no-dirty -scale 2amin -size 300 300 -use-idg ${MS} +# wsclean ${intervaloptions} -name beam-0-1 -data-column MODEL_DATA -pol IQUV -no-dirty -scale 2amin -size 300 300 ${atermoptions} -use-idg ${MS} + +# Workaround to generate beam image oskar-1-1-beam-I.fits +wsclean ${intervaloptions} -name oskar-1-1 -no-dirty -scale 2amin -size 300 300 ${atermoptions} -use-idg -niter 1 ${MS} + +# use wsclean to generate model data with beam, and to image it with and without beam correction +wsclean ${intervaloptions} -predict -pol IQUV ${atermoptions} -use-idg ${MS} +wsclean ${intervaloptions} -name oskar-1-1 -data-column MODEL_DATA -pol IQUV -no-dirty -scale 2amin -size 300 300 ${atermoptions} -use-idg ${MS} +wsclean ${intervaloptions} -name oskar-1-0 -data-column MODEL_DATA -pol IQUV -no-dirty -scale 2amin -size 300 300 -use-idg ${MS} + + diff --git a/demo/wsclean-oskar/sky.osm b/demo/wsclean-oskar/sky.osm new file mode 100644 index 0000000000000000000000000000000000000000..0cf4b11283525bb5d38b8e468b4b0d55cfa66644 --- /dev/null +++ b/demo/wsclean-oskar/sky.osm @@ -0,0 +1,10 @@ +# +# RA, Dec, I, Q, U, V, freq0, spix, RM, maj, min, pa +# (deg), (deg), (Jy), (Jy), (Jy), (Jy), (Hz), (-), (rad/m^2), (arcsec), (arcsec), (deg) +# + +22.0 -28.0 1 0 0 0 +18.0 -28.0 1 1 0 0 +22.0 -32.0 1 0 1 0 +18.0 -32.0 1 0 0 1 + diff --git a/demo/comparison-oskar/skalowmini-coef.tm/README.md b/test_data/README.md similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/README.md rename to test_data/README.md diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_110.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_110.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_110.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_110.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_137.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_137.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_160.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_160.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_160.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_160.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_230.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_230.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_230.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_230.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_320.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_320.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_320.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_320.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_50.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_50.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_50.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_50.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_70.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_70.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_70.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_im_0_70.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_110.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_110.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_110.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_110.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_137.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_137.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_160.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_160.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_160.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_160.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_230.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_230.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_230.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_230.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_320.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_320.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_320.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_320.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_50.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_50.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_50.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_50.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_70.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_70.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_70.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_te_re_0_70.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_110.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_110.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_110.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_110.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_137.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_137.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_160.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_160.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_160.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_160.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_230.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_230.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_230.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_230.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_320.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_320.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_320.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_320.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_50.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_50.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_50.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_50.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_70.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_70.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_70.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_im_0_70.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_110.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_110.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_110.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_110.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_137.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_137.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_160.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_160.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_160.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_160.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_230.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_230.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_230.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_230.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_320.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_320.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_320.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_320.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_50.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_50.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_50.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_50.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_70.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_70.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_70.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_x_tm_re_0_70.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_110.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_110.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_110.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_110.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_137.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_137.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_160.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_160.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_160.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_160.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_230.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_230.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_230.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_230.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_320.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_320.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_320.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_320.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_50.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_50.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_50.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_50.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_70.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_70.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_70.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_im_0_70.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_110.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_110.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_110.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_110.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_137.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_137.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_160.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_160.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_160.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_160.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_230.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_230.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_230.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_230.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_320.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_320.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_320.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_320.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_50.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_50.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_50.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_50.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_70.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_70.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_70.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_te_re_0_70.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_110.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_110.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_110.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_110.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_137.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_137.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_160.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_160.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_160.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_160.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_230.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_230.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_230.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_230.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_320.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_320.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_320.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_320.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_50.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_50.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_50.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_50.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_70.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_70.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_70.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_im_0_70.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_110.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_110.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_110.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_110.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_137.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_137.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_160.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_160.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_160.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_160.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_230.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_230.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_230.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_230.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_320.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_320.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_320.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_320.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_50.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_50.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_50.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_50.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_70.txt b/test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_70.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_70.txt rename to test_data/skalowmini-coef.tm/element_pattern_spherical_wave_y_tm_re_0_70.txt diff --git a/test_data/skalowmini-coef.tm/layout.txt b/test_data/skalowmini-coef.tm/layout.txt new file mode 100644 index 0000000000000000000000000000000000000000..0d75d276b7bf11b9d84dffe797aad2631bc6ead5 --- /dev/null +++ b/test_data/skalowmini-coef.tm/layout.txt @@ -0,0 +1,30 @@ +0,0 +-605.1565,146.9829 +-64.79,-577.8771 +-878.9322,-123.8241 +-237.3169,-340.6209 +407.1441,198.459 +139.1693,-888.4022 +345.5998,890.5183 +-203.9332,11.27668 +-404.5717,373.44 +136.5508,745.0029 +-375.0552,-139.6862 +254.7167,-507.6426 +100.512,-355.1444 +-360.9658,161.2952 +698.7782,-471.8213 +210.4574,-100.3645 +-969.0271,190.9689 +893.7347,117.048 +-844.7219,-321.3391 +558.4537,469.6326 +-40.34307,530.6472 +-148.6963,281.2029 +-543.7159,731.1521 +256.6313,445.902 +125.0,125.0 +100.0,100.0 +50.0,50.0 +25.0,25.0 +10.0,10.0 diff --git a/demo/comparison-oskar/skalowmini-coef.tm/position.txt b/test_data/skalowmini-coef.tm/position.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/position.txt rename to test_data/skalowmini-coef.tm/position.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_132.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_132.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_132.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_132.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_133.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_133.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_133.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_133.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_134.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_134.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_134.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_134.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_135.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_135.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_135.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_135.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_136.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_136.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_136.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_136.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_137.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_137.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_138.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_138.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_138.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_138.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_139.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_139.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_139.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_139.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_140.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_140.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_140.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_140.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_141.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_141.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_141.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_141.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_142.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_142.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_142.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_142.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_143.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_143.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_143.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_143.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_144.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_144.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_144.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_144.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_145.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_145.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_145.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_145.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_146.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_146.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_146.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_146.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_147.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_147.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_147.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_147.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_148.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_148.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_148.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_im_0_148.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_132.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_132.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_132.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_132.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_133.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_133.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_133.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_133.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_134.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_134.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_134.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_134.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_135.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_135.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_135.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_135.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_136.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_136.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_136.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_136.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_137.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_137.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_138.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_138.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_138.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_138.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_139.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_139.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_139.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_139.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_140.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_140.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_140.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_140.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_141.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_141.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_141.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_141.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_142.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_142.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_142.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_142.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_143.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_143.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_143.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_143.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_144.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_144.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_144.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_144.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_145.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_145.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_145.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_145.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_146.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_146.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_146.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_146.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_147.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_147.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_147.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_147.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_148.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_148.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_148.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_te_re_0_148.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_132.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_132.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_132.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_132.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_133.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_133.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_133.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_133.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_134.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_134.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_134.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_134.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_135.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_135.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_135.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_135.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_136.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_136.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_136.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_136.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_137.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_137.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_138.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_138.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_138.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_138.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_139.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_139.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_139.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_139.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_140.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_140.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_140.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_140.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_141.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_141.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_141.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_141.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_142.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_142.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_142.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_142.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_143.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_143.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_143.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_143.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_144.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_144.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_144.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_144.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_145.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_145.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_145.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_145.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_146.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_146.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_146.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_146.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_147.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_147.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_147.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_147.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_148.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_148.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_148.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_im_0_148.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_132.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_132.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_132.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_132.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_133.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_133.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_133.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_133.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_134.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_134.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_134.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_134.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_135.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_135.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_135.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_135.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_136.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_136.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_136.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_136.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_137.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_137.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_138.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_138.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_138.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_138.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_139.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_139.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_139.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_139.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_140.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_140.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_140.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_140.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_141.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_141.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_141.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_141.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_142.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_142.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_142.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_142.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_143.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_143.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_143.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_143.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_144.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_144.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_144.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_144.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_145.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_145.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_145.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_145.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_146.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_146.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_146.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_146.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_147.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_147.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_147.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_147.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_148.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_148.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_148.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_x_tm_re_0_148.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_132.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_132.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_132.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_132.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_133.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_133.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_133.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_133.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_134.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_134.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_134.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_134.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_135.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_135.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_135.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_135.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_136.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_136.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_136.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_136.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_137.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_137.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_138.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_138.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_138.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_138.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_139.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_139.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_139.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_139.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_140.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_140.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_140.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_140.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_141.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_141.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_141.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_141.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_142.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_142.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_142.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_142.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_143.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_143.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_143.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_143.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_144.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_144.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_144.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_144.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_145.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_145.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_145.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_145.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_146.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_146.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_146.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_146.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_147.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_147.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_147.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_147.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_148.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_148.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_148.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_im_0_148.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_132.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_132.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_132.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_132.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_133.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_133.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_133.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_133.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_134.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_134.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_134.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_134.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_135.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_135.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_135.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_135.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_136.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_136.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_136.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_136.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_137.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_137.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_138.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_138.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_138.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_138.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_139.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_139.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_139.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_139.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_140.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_140.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_140.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_140.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_141.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_141.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_141.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_141.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_142.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_142.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_142.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_142.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_143.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_143.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_143.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_143.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_144.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_144.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_144.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_144.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_145.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_145.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_145.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_145.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_146.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_146.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_146.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_146.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_147.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_147.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_147.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_147.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_148.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_148.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_148.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_te_re_0_148.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_132.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_132.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_132.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_132.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_133.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_133.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_133.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_133.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_134.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_134.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_134.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_134.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_135.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_135.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_135.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_135.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_136.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_136.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_136.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_136.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_137.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_137.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_138.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_138.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_138.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_138.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_139.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_139.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_139.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_139.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_140.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_140.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_140.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_140.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_141.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_141.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_141.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_141.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_142.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_142.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_142.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_142.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_143.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_143.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_143.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_143.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_144.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_144.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_144.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_144.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_145.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_145.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_145.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_145.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_146.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_146.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_146.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_146.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_147.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_147.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_147.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_147.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_148.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_148.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_148.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_im_0_148.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_132.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_132.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_132.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_132.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_133.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_133.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_133.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_133.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_134.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_134.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_134.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_134.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_135.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_135.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_135.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_135.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_136.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_136.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_136.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_136.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_137.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_137.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_137.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_137.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_138.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_138.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_138.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_138.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_139.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_139.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_139.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_139.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_140.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_140.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_140.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_140.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_141.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_141.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_141.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_141.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_142.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_142.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_142.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_142.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_143.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_143.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_143.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_143.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_144.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_144.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_144.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_144.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_145.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_145.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_145.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_145.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_146.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_146.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_146.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_146.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_147.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_147.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_147.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_147.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_148.txt b/test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_148.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_148.txt rename to test_data/skalowmini-coef.tm/station/element_pattern_spherical_wave_y_tm_re_0_148.txt diff --git a/demo/comparison-oskar/skalowmini-coef.tm/station/layout.txt b/test_data/skalowmini-coef.tm/station/layout.txt similarity index 100% rename from demo/comparison-oskar/skalowmini-coef.tm/station/layout.txt rename to test_data/skalowmini-coef.tm/station/layout.txt