From 4a2f29713604b5cfe86fe2367c98ff731c34166e Mon Sep 17 00:00:00 2001 From: blendoit Date: Sat, 19 Oct 2019 15:10:38 -0700 Subject: Correct randomization of aircraft and save of component tree and eval results --- creator/wing.py | 74 +++--- evaluator.py | 360 +++++++++++++++++++++++++ evaluator/__init__.py | 1 - evaluator/evaluator.py | 344 ------------------------ evaluator/log_eval.txt | 0 example_airfoil.py | 45 +--- generator.py | 46 ++++ generator/generator.py | 64 ----- log_base.txt | 706 +++++++++++++++++++++++++++++++++++++++++++++++++ 9 files changed, 1162 insertions(+), 478 deletions(-) create mode 100644 evaluator.py delete mode 100644 evaluator/__init__.py delete mode 100644 evaluator/evaluator.py delete mode 100644 evaluator/log_eval.txt create mode 100644 generator.py delete mode 100644 generator/generator.py diff --git a/creator/wing.py b/creator/wing.py index 8257d63..01aa6ff 100644 --- a/creator/wing.py +++ b/creator/wing.py @@ -170,71 +170,69 @@ class Spar(base.Component): class Stringer(base.Component): """Contains the coordinates of all stringers.""" - def __init__(self, parent, name): - super().__init__(parent, name) - parent.stringers = self - self.x_start = [] - self.x_end = [] - self.z_start = [] - self.z_end = [] - self.diameter = float() - self.area = float() - - def add_coord(self, airfoil, den_u_1=4, den_u_2=4, den_l_1=4, den_l_2=4): + def __init__(self, + parent, + name, + den_u_1=4, + den_u_2=4, + den_l_1=4, + den_l_2=4): """Add equally distributed stringers to four airfoil locations (upper nose, lower nose, upper surface, lower surface). - Parameters: - airfoil_coord: packed airfoil coordinates - spar_coord: packed spar coordinates den_u_1: upper nose number of stringers den_u_2: upper surface number of stringers den_l_1: lower nose number of stringers den_l_2: lower surface number of stringers - - Returns: - None """ + super().__init__(parent, name) + parent.stringers = self + self.x_start = [] + self.x_end = [] + self.z_start = [] + self.z_end = [] + self.diameter = float() + self.area = float() # Find distance between leading edge and first upper stringer - interval = airfoil.spars[0].x[0] / (den_u_1 + 1) + # interval = self.parent.spars[0].x[0] / (den_u_1 + 1) + interval = 2 # initialise first self.stringer_x at first interval x = interval # Add upper stringers from leading edge until first spar. for _ in range(0, den_u_1): # Index of the first value of airfoil.x > x - i = bi.bisect_left(airfoil.x, x) - self.x = np.append(self.x, airfoil.x[i]) - self.z = np.append(self.z, airfoil.z[i]) + i = bi.bisect_left(self.parent.x, x) + self.x = np.append(self.x, self.parent.x[i]) + self.z = np.append(self.z, self.parent.z[i]) x += interval # Add upper stringers from first spar until last spar - # TODO: stringer placement if only one spar is created - interval = (airfoil.spars[-1].x[0] - - airfoil.spars[0].x[0]) / (den_u_2 + 1) - x = interval + airfoil.spars[0].x[0] + interval = (self.parent.spars[-1].x[0] - + self.parent.spars[0].x[0]) / (den_u_2 + 1) + x = interval + self.parent.spars[0].x[0] for _ in range(0, den_u_2): - i = bi.bisect_left(airfoil.x, x) - self.x = np.append(self.x, airfoil.x[i]) - self.z = np.append(self.z, airfoil.z[i]) + i = bi.bisect_left(self.parent.x, x) + self.x = np.append(self.x, self.parent.x[i]) + self.z = np.append(self.z, self.parent.z[i]) x += interval # Find distance between leading edge and first lower stringer - interval = airfoil.spars[0].x[1] / (den_l_1 + 1) + interval = self.parent.spars[0].x[1] / (den_l_1 + 1) x = interval # Add lower stringers from leading edge until first spar. for _ in range(0, den_l_1): - i = bi.bisect_left(airfoil.x[::-1], x) - self.x = np.append(self.x, airfoil.x[-i]) - self.z = np.append(self.z, airfoil.z[-i]) + i = bi.bisect_left(self.parent.x[::-1], x) + self.x = np.append(self.x, self.parent.x[-i]) + self.z = np.append(self.z, self.parent.z[-i]) x += interval # Add lower stringers from first spar until last spar - interval = (airfoil.spars[-1].x[1] - - airfoil.spars[0].x[1]) / (den_l_2 + 1) - x = interval + airfoil.spars[0].x[1] + interval = (self.parent.spars[-1].x[1] - + self.parent.spars[0].x[1]) / (den_l_2 + 1) + x = interval + self.parent.spars[0].x[1] for _ in range(0, den_l_2): - i = bi.bisect_left(airfoil.x[::-1], x) - self.x = np.append(self.x, airfoil.x[-i]) - self.z = np.append(self.z, airfoil.z[-i]) + i = bi.bisect_left(self.parent.x[::-1], x) + self.x = np.append(self.x, self.parent.x[-i]) + self.z = np.append(self.z, self.parent.z[-i]) x += interval return None diff --git a/evaluator.py b/evaluator.py new file mode 100644 index 0000000..0307079 --- /dev/null +++ b/evaluator.py @@ -0,0 +1,360 @@ +""" +The evaluator.py module contains a single Evaluator class, +which knows all the attributes of a specified Aircraft instance, +and contains functions to analyse the airfoil's geometrical +& structural properties. +""" + +import sys +import os.path +import numpy as np +from math import sqrt +import matplotlib.pyplot as plt +import concurrent.futures +import logging + +logging.basicConfig(filename='log_eval.txt', + level=logging.DEBUG, + format='%(asctime)s - %(levelname)s - %(message)s') + + +class Evaluator: + """Performs structural evaluations on aircrafts. + Individual aircrafts must claim an Evaluator object as parent.""" + def __init__(self, name): + self.name = name + self.aircrafts = [] + self.results = [] + + self.I_ = {'x': 0, 'z': 0, 'xz': 0} + + def _get_lift_rectangular(aircraft, lift=50): + L_prime = [ + lift / (aircraft.wing.semi_span * 2) + for _ in range(aircraft.wing.semi_span) + ] + return L_prime + + def _get_lift_elliptical(aircraft, L_0=3.2): + L_prime = [ + L_0 / (aircraft.wing.semi_span * 2) * + sqrt(1 - (y / aircraft.wing.semi_span)**2) + for y in range(aircraft.wing.semi_span) + ] + return L_prime + + def get_lift_total(self, aircraft): + """Combination of rectangular and elliptical lift.""" + F_z = [ + self._get_lift_rectangular(aircraft) + + self._get_lift_elliptical(aircraft) / 2 + for i in range(aircraft.wing.semi_span) + ] + return F_z + + def get_mass_distribution(self, total_mass): + F_z = [total_mass / self.semi_span for x in range(0, self.semi_span)] + return F_z + + def get_drag(aircraft, drag): + # Transform semi-span integer into list + semi_span = [x for x in range(0, aircraft.wing.semi_span)] + + # Drag increases after 80% of the semi_span + cutoff = round(0.8 * aircraft.wing.span) + + # Drag increases by 25% after 80% of the semi_span + F_x = [drag for x in semi_span[0:cutoff]] + F_x.extend([1.25 * drag for x in semi_span[cutoff:]]) + return F_x + + def get_centroid(aircraft): + """Return the coordinates of the centroid.""" + stringer_area = aircraft.stringer.area + cap_area = aircraft.spar.cap_area + + caps_x = [value for spar in aircraft.spar.x for value in spar] + caps_z = [value for spar in aircraft.spar.z for value in spar] + stringers_x = aircraft.stringer.x + stringers_z = aircraft.stringer.z + + denominator = float( + len(caps_x) * cap_area + len(stringers_x) * stringer_area) + + centroid_x = float( + sum([x * cap_area for x in caps_x]) + + sum([x * stringer_area for x in stringers_x])) + centroid_x = centroid_x / denominator + + centroid_z = float( + sum([z * cap_area for z in caps_z]) + + sum([z * stringer_area for z in stringers_z])) + centroid_z = centroid_z / denominator + + return (centroid_x, centroid_z) + + def get_inertia_terms(self): + """Obtain all inertia terms.""" + stringer_area = self.stringer.area + cap_area = self.spar.cap_area + + # Adds upper and lower components' coordinates to list + x_stringers = self.stringer.x + z_stringers = self.stringer.z + x_spars = self.spar.x[:][0] + self.spar.x[:][1] + z_spars = self.spar.z[:][0] + self.spar.z[:][1] + stringer_count = range(len(x_stringers)) + spar_count = range(len(self.spar.x)) + + # I_x is the sum of the contributions of the spar caps and stringers + # TODO: replace list indices with dictionary value + I_x = sum([ + cap_area * (z_spars[i] - self.centroid[1])**2 for i in spar_count + ]) + I_x += sum([ + stringer_area * (z_stringers[i] - self.centroid[1])**2 + for i in stringer_count + ]) + + I_z = sum([ + cap_area * (x_spars[i] - self.centroid[0])**2 for i in spar_count + ]) + I_z += sum([ + stringer_area * (x_stringers[i] - self.centroid[0])**2 + for i in stringer_count + ]) + + I_xz = sum([ + cap_area * (x_spars[i] - self.centroid[0]) * + (z_spars[i] - self.centroid[1]) for i in spar_count + ]) + I_xz += sum([ + stringer_area * (x_stringers[i] - self.centroid[0]) * + (z_stringers[i] - self.centroid[1]) for i in stringer_count + ]) + return (I_x, I_z, I_xz) + + def get_dx(self, component): + return [x - self.centroid[0] for x in component.x_start] + + def get_dz(self, component): + return [x - self.centroid[1] for x in component.x_start] + + def get_dP(self, xDist, zDist, V_x, V_z, area): + I_x = self.I_['x'] + I_z = self.I_['z'] + I_xz = self.I_['xz'] + denom = float(I_x * I_z - I_xz**2) + z = float() + for _ in range(len(xDist)): + z += float(-area * xDist[_] * (I_x * V_x - I_xz * V_z) / denom - + area * zDist[_] * (I_z * V_z - I_xz * V_x) / denom) + return z + + def analysis(self): + """Perform all analysis calculations and store in self.results.""" + # with concurrent.futures.ProcessPoolExecutor() as executor: + # for aircraft in self.aircrafts: + # lift = executor.submit(self.get_lift_total(aircraft)) + # drag = executor.submit(self.get_drag_total(aircraft)) + # mass = executor.submit(self.get_mass_total(aircraft)) + # thrust = executor.submit(self.get_thrust_total(aircraft)) + + # for aircraft in self.aircrafts: + # print(lift.result()) + # print(drag.result()) + # print(mass.result()) + # print(thrust.result()) + + # for f in concurrent.futures.as_completed(l, d, m, t): + # print(f.result()) + + for aircraft in self.aircrafts: + # lift = self.get_lift_total(aircraft), + # drag = self.get_drag(aircraft.wing), + # centroid = self.get_centroid(aircraft.wing) + results = {"Lift": 400, "Drag": 20, "Centroid": [0.2, 4.5]} + self.results.append(results) + # results = { + # "Lift": self.get_lift_total(aircraft), + # "Drag": self.get_drag(aircraft), + # "Centroid": self.get_centroid(aircraft) + # } + return results + + # def analysis(self, V_x, V_z): + # """Perform all analysis calculations and store in class instance.""" + + # self.drag = self.get_drag(10) + # self.lift_rectangular = self.get_lift_rectangular(13.7) + # self.lift_elliptical = self.get_lift_elliptical(15) + # self.lift_total = self.get_lift_total() + # self.mass_dist = self.get_mass_distribution(self.mass_total) + # self.centroid = self.get_centroid() + # self.I_['x'] = self.get_inertia_terms()[0] + # self.I_['z'] = self.get_inertia_terms()[1] + # self.I_['xz'] = self.get_inertia_terms()[2] + # spar_dx = self.get_dx(self.spar) + # spar_dz = self.get_dz(self.spar) + # self.spar.dP_x = self.get_dP(spar_dx, spar_dz, V_x, 0, + # self.spar.cap_area) + # self.spar.dP_z = self.get_dP(spar_dx, spar_dz, 0, V_z, + # self.spar.cap_area) + # print("yayyyyy") + # return None + + # print(f"Analysis results for {aircraft.name}:\n", results) + # self.results = self.get_lift_total(aircraft) + + # self.drag = self.get_drag(10) + # self.lift_rectangular = self.get_lift_rectangular(13.7) + # self.lift_elliptical = self.get_lift_elliptical(15) + # self.lift_total = self.get_lift_total() + # self.mass_dist = self.get_mass_distribution(self.mass_total) + # self.centroid = self.get_centroid() + # self.I_['x'] = self.get_inertia_terms()[0] + # self.I_['z'] = self.get_inertia_terms()[1] + # self.I_['xz'] = self.get_inertia_terms()[2] + # spar_dx = self.get_dx(self.spar) + # spar_dz = self.get_dz(self.spar) + # self.spar.dP_x = self.get_dP(spar_dx, spar_dz, V_x, 0, + # self.spar.cap_area) + # self.spar.dP_z = self.get_dP(spar_dx, spar_dz, 0, V_z, + # self.spar.cap_area) + # return None + + def tree_print(self, *aircrafts): + """Print the list of subcomponents.""" + name = f" TREE FOR {[i.name for i in aircrafts]} IN {self.name} " + num_of_dashes = len(name) + print(num_of_dashes * '-') + print(name) + for aircraft in aircrafts: + print(".") + print(f"`-- {aircraft}") + print(f" |--{aircraft.wing}") + print(f" | |-- {aircraft.wing.stringers}") + for spar in aircraft.wing.spars[:-1]: + print(f" | |-- {spar}") + print(f" | `-- {aircraft.wing.spars[-1]}") + print(f" |-- {aircraft.fuselage}") + print(f" `-- {aircraft.propulsion}") + print(num_of_dashes * '-') + return None + + def tree_save(self, + *aircrafts, + save_path='/home/blendux/Projects/Aircraft_Studio/save'): + """Save the evaluator's tree to a file.""" + for aircraft in aircrafts: + file_name = f"{aircraft.name}_tree.txt" + full_path = os.path.join(save_path, file_name) + with open(full_path, 'w') as f: + try: + f.write(".\n") + f.write(f"`-- {aircraft}\n") + f.write(f" |--{aircraft.wing}\n") + for spar in aircraft.wing.spars[:-1]: + f.write(f" | |-- {spar}\n") + f.write(f" | `-- {aircraft.wing.spars[-1]}\n") + f.write(f" |-- {aircraft.fuselage}\n") + f.write(f" `-- {aircraft.propulsion}\n") + logging.debug(f'Successfully wrote to file {full_path}') + + except IOError: + print( + f'Unable to write {file_name} to specified directory.', + 'Was the full path passed to the function?') + return None + + def info_save(self, save_path, number): + """Save all the object's coordinates (must be full path).""" + file_name = 'airfoil_{}_eval.txt'.format(number) + full_path = os.path.join(save_path, file_name) + try: + with open(full_path, 'w') as sys.stdout: + self.info_print(6) + # This line required to reset behavior of sys.stdout + sys.stdout = sys.__stdout__ + print('Successfully wrote to file {}'.format(full_path)) + except IOError: + print( + 'Unable to write {} to specified directory.\n'.format( + file_name), 'Was the full path passed to the function?') + return None + + +def plot_geom(evaluator): + """This function plots analysis results over the airfoil's geometry.""" + # Plot chord + x_chord = [0, evaluator.chord] + y_chord = [0, 0] + plt.plot(x_chord, y_chord, linewidth='1') + # Plot quarter chord + plt.plot(evaluator.chord / 4, + 0, + '.', + color='g', + markersize=24, + label='Quarter-chord') + # Plot airfoil surfaces + x = [0.98 * x for x in evaluator.airfoil.x] + y = [0.98 * z for z in evaluator.airfoil.z] + plt.fill(x, y, color='w', linewidth='1', fill=False) + x = [1.02 * x for x in evaluator.airfoil.x] + y = [1.02 * z for z in evaluator.airfoil.z] + plt.fill(x, y, color='b', linewidth='1', fill=False) + + # Plot spars + try: + for _ in range(len(evaluator.spar.x)): + x = (evaluator.spar.x[_]) + y = (evaluator.spar.z[_]) + plt.plot(x, y, '-', color='b') + except AttributeError: + print('No spars to plot.') + # Plot stringers + try: + for _ in range(0, len(evaluator.stringer.x)): + x = evaluator.stringer.x[_] + y = evaluator.stringer.z[_] + plt.plot(x, y, '.', color='y', markersize=12) + except AttributeError: + print('No stringers to plot.') + + # Plot centroid + x = evaluator.centroid[0] + y = evaluator.centroid[1] + plt.plot(x, y, '.', color='r', markersize=24, label='centroid') + + # Graph formatting + plt.xlabel('X axis') + plt.ylabel('Z axis') + + plot_bound = max(evaluator.airfoil.x) + plt.xlim(-0.10 * plot_bound, 1.10 * plot_bound) + plt.ylim(-(1.10 * plot_bound / 2), (1.10 * plot_bound / 2)) + plt.gca().set_aspect('equal', adjustable='box') + plt.gca().legend() + plt.grid(axis='both', linestyle=':', linewidth=1) + plt.show() + return None + + +def plot_lift(evaluator): + x = range(evaluator.semi_span) + y_1 = evaluator.lift_rectangular + y_2 = evaluator.lift_elliptical + y_3 = evaluator.lift_total + plt.plot(x, y_1, '.', color='b', markersize=4, label='Rectangular lift') + plt.plot(x, y_2, '.', color='g', markersize=4, label='Elliptical lift') + plt.plot(x, y_3, '.', color='r', markersize=4, label='Total lift') + + # Graph formatting + plt.xlabel('Semi-span location') + plt.ylabel('Lift') + + plt.gca().legend() + plt.grid(axis='both', linestyle=':', linewidth=1) + plt.show() + return None diff --git a/evaluator/__init__.py b/evaluator/__init__.py deleted file mode 100644 index 1561fb0..0000000 --- a/evaluator/__init__.py +++ /dev/null @@ -1 +0,0 @@ -from . import evaluator diff --git a/evaluator/evaluator.py b/evaluator/evaluator.py deleted file mode 100644 index 53fab3b..0000000 --- a/evaluator/evaluator.py +++ /dev/null @@ -1,344 +0,0 @@ -""" -The evaluator.py module contains a single Evaluator class, -which knows all the attributes of a specified Aircraft instance, -and contains functions to analyse the airfoil's geometrical -& structural properties. -""" - -import sys -import os.path -import numpy as np -from math import sqrt -import matplotlib.pyplot as plt -import concurrent.futures -import logging - -logging.basicConfig(filename='log_eval.txt', - level=logging.DEBUG, - format='%(asctime)s - %(levelname)s - %(message)s') - - -class Evaluator: - """Performs structural evaluations on aircrafts. - Individual aircrafts must claim an Evaluator object as parent.""" - def __init__(self, name): - self.name = name - self.aircrafts = [] - self.results = [] - - self.I_ = {'x': 0, 'z': 0, 'xz': 0} - - def get_lift_rectangular(aircraft, lift=50): - L_prime = [ - lift / (aircraft.wing.semi_span * 2) - for x in range(aircraft.wing.semi_span) - ] - return L_prime - - def get_lift_elliptical(aircraft, L_0=3.2): - L_prime = [ - L_0 / (aircraft.wing.semi_span * 2) * - sqrt(1 - (y / aircraft.wing.semi_span)**2) - for y in range(aircraft.wing.semi_span) - ] - return L_prime - - def get_lift_total(self, aircraft): - F_z = [ - self.get_lift_rectangular(aircraft) + - self.get_lift_elliptical(aircraft) / 2 - for _ in range(aircraft.wing.semi_span) - ] - return F_z - - def get_mass_distribution(self, total_mass): - F_z = [total_mass / self.semi_span for x in range(0, self.semi_span)] - return F_z - - def get_drag(aircraft, drag): - # Transform semi-span integer into list - semi_span = [x for x in range(0, aircraft.wing.semi_span)] - - # Drag increases after 80% of the semi_span - cutoff = round(0.8 * aircraft.wing.span) - - # Drag increases by 25% after 80% of the semi_span - F_x = [drag for x in semi_span[0:cutoff]] - F_x.extend([1.25 * drag for x in semi_span[cutoff:]]) - return F_x - - def get_centroid(aircraft): - """Return the coordinates of the centroid.""" - stringer_area = aircraft.stringer.area - cap_area = aircraft.spar.cap_area - - caps_x = [value for spar in aircraft.spar.x for value in spar] - caps_z = [value for spar in aircraft.spar.z for value in spar] - stringers_x = aircraft.stringer.x - stringers_z = aircraft.stringer.z - - denominator = float( - len(caps_x) * cap_area + len(stringers_x) * stringer_area) - - centroid_x = float( - sum([x * cap_area for x in caps_x]) + - sum([x * stringer_area for x in stringers_x])) - centroid_x = centroid_x / denominator - - centroid_z = float( - sum([z * cap_area for z in caps_z]) + - sum([z * stringer_area for z in stringers_z])) - centroid_z = centroid_z / denominator - - return (centroid_x, centroid_z) - - def get_inertia_terms(self): - """Obtain all inertia terms.""" - stringer_area = self.stringer.area - cap_area = self.spar.cap_area - - # Adds upper and lower components' coordinates to list - x_stringers = self.stringer.x - z_stringers = self.stringer.z - x_spars = self.spar.x[:][0] + self.spar.x[:][1] - z_spars = self.spar.z[:][0] + self.spar.z[:][1] - stringer_count = range(len(x_stringers)) - spar_count = range(len(self.spar.x)) - - # I_x is the sum of the contributions of the spar caps and stringers - # TODO: replace list indices with dictionary value - I_x = sum([ - cap_area * (z_spars[i] - self.centroid[1])**2 for i in spar_count - ]) - I_x += sum([ - stringer_area * (z_stringers[i] - self.centroid[1])**2 - for i in stringer_count - ]) - - I_z = sum([ - cap_area * (x_spars[i] - self.centroid[0])**2 for i in spar_count - ]) - I_z += sum([ - stringer_area * (x_stringers[i] - self.centroid[0])**2 - for i in stringer_count - ]) - - I_xz = sum([ - cap_area * (x_spars[i] - self.centroid[0]) * - (z_spars[i] - self.centroid[1]) for i in spar_count - ]) - I_xz += sum([ - stringer_area * (x_stringers[i] - self.centroid[0]) * - (z_stringers[i] - self.centroid[1]) for i in stringer_count - ]) - return (I_x, I_z, I_xz) - - def get_dx(self, component): - return [x - self.centroid[0] for x in component.x_start] - - def get_dz(self, component): - return [x - self.centroid[1] for x in component.x_start] - - def get_dP(self, xDist, zDist, V_x, V_z, area): - I_x = self.I_['x'] - I_z = self.I_['z'] - I_xz = self.I_['xz'] - denom = float(I_x * I_z - I_xz**2) - z = float() - for _ in range(len(xDist)): - z += float(-area * xDist[_] * (I_x * V_x - I_xz * V_z) / denom - - area * zDist[_] * (I_z * V_z - I_xz * V_x) / denom) - return z - - def analysis(self): - """Perform all analysis calculations and store in self.results.""" - with concurrent.futures.ProcessPoolExecutor() as executor: - f1 = executor.submit(self.get_lift_total) - - for aircraft in self.aircrafts: - # lift = self.get_lift_total(aircraft), - # drag = self.get_drag(aircraft.wing), - # centroid = self.get_centroid(aircraft.wing) - results = {"Lift": 400, "Drag": 20, "Centroid": [0.2, 4.5]} - self.results.append(results) - # results = { - # "Lift": self.get_lift_total(aircraft), - # "Drag": self.get_drag(aircraft), - # "Centroid": self.get_centroid(aircraft) - # } - return results - - # def analysis(self, V_x, V_z): - # """Perform all analysis calculations and store in class instance.""" - - # self.drag = self.get_drag(10) - # self.lift_rectangular = self.get_lift_rectangular(13.7) - # self.lift_elliptical = self.get_lift_elliptical(15) - # self.lift_total = self.get_lift_total() - # self.mass_dist = self.get_mass_distribution(self.mass_total) - # self.centroid = self.get_centroid() - # self.I_['x'] = self.get_inertia_terms()[0] - # self.I_['z'] = self.get_inertia_terms()[1] - # self.I_['xz'] = self.get_inertia_terms()[2] - # spar_dx = self.get_dx(self.spar) - # spar_dz = self.get_dz(self.spar) - # self.spar.dP_x = self.get_dP(spar_dx, spar_dz, V_x, 0, - # self.spar.cap_area) - # self.spar.dP_z = self.get_dP(spar_dx, spar_dz, 0, V_z, - # self.spar.cap_area) - # print("yayyyyy") - # return None - - # print(f"Analysis results for {aircraft.name}:\n", results) - # self.results = self.get_lift_total(aircraft) - - # self.drag = self.get_drag(10) - # self.lift_rectangular = self.get_lift_rectangular(13.7) - # self.lift_elliptical = self.get_lift_elliptical(15) - # self.lift_total = self.get_lift_total() - # self.mass_dist = self.get_mass_distribution(self.mass_total) - # self.centroid = self.get_centroid() - # self.I_['x'] = self.get_inertia_terms()[0] - # self.I_['z'] = self.get_inertia_terms()[1] - # self.I_['xz'] = self.get_inertia_terms()[2] - # spar_dx = self.get_dx(self.spar) - # spar_dz = self.get_dz(self.spar) - # self.spar.dP_x = self.get_dP(spar_dx, spar_dz, V_x, 0, - # self.spar.cap_area) - # self.spar.dP_z = self.get_dP(spar_dx, spar_dz, 0, V_z, - # self.spar.cap_area) - # return None - - def tree_print(self): - """Print the list of subcomponents.""" - name = f" TREE FOR {[_.name for _ in self.aircrafts]} IN {self.name} " - num_of_dashes = len(name) - print(num_of_dashes * '-') - print(name) - for aircraft in self.aircrafts: - print(".") - print(f"`-- {aircraft}") - print(f" |--{aircraft.wing}") - print(f" | |-- {aircraft.wing.stringers}") - for spar in aircraft.wing.spars[:-1]: - print(f" | |-- {spar}") - print(f" | `-- {aircraft.wing.spars[-1]}") - print(f" |-- {aircraft.fuselage}") - print(f" `-- {aircraft.propulsion}") - print(num_of_dashes * '-') - return None - - def tree_save(self, - save_path='/home/blendux/Projects/Aircraft_Studio/save'): - """Save the evaluator's tree to a file.""" - file_name = f"{self.name}_tree.txt" - full_path = os.path.join(save_path, file_name) - with open(full_path, 'w') as f: - try: - for aircraft in self.aircrafts: - f.write(".\n") - f.write(f"`-- {aircraft}\n") - f.write(f" |--{aircraft.wing}\n") - for spar in aircraft.wing.spars[:-1]: - f.write(f" | |-- {spar}\n") - f.write(f" | `-- {aircraft.wing.spars[-1]}\n") - f.write(f" |-- {aircraft.fuselage}\n") - f.write(f" `-- {aircraft.propulsion}\n") - logging.debug(f'Successfully wrote to file {full_path}') - - except IOError: - print(f'Unable to write {file_name} to specified directory.\n', - 'Was the full path passed to the function?') - return None - - def info_save(self, save_path, number): - """Save all the object's coordinates (must be full path).""" - file_name = 'airfoil_{}_eval.txt'.format(number) - full_path = os.path.join(save_path, file_name) - try: - with open(full_path, 'w') as sys.stdout: - self.info_print(6) - # This line required to reset behavior of sys.stdout - sys.stdout = sys.__stdout__ - print('Successfully wrote to file {}'.format(full_path)) - except IOError: - print( - 'Unable to write {} to specified directory.\n'.format( - file_name), 'Was the full path passed to the function?') - return None - - -def plot_geom(evaluator): - """This function plots analysis results over the airfoil's geometry.""" - # Plot chord - x_chord = [0, evaluator.chord] - y_chord = [0, 0] - plt.plot(x_chord, y_chord, linewidth='1') - # Plot quarter chord - plt.plot(evaluator.chord / 4, - 0, - '.', - color='g', - markersize=24, - label='Quarter-chord') - # Plot airfoil surfaces - x = [0.98 * x for x in evaluator.airfoil.x] - y = [0.98 * z for z in evaluator.airfoil.z] - plt.fill(x, y, color='w', linewidth='1', fill=False) - x = [1.02 * x for x in evaluator.airfoil.x] - y = [1.02 * z for z in evaluator.airfoil.z] - plt.fill(x, y, color='b', linewidth='1', fill=False) - - # Plot spars - try: - for _ in range(len(evaluator.spar.x)): - x = (evaluator.spar.x[_]) - y = (evaluator.spar.z[_]) - plt.plot(x, y, '-', color='b') - except AttributeError: - print('No spars to plot.') - # Plot stringers - try: - for _ in range(0, len(evaluator.stringer.x)): - x = evaluator.stringer.x[_] - y = evaluator.stringer.z[_] - plt.plot(x, y, '.', color='y', markersize=12) - except AttributeError: - print('No stringers to plot.') - - # Plot centroid - x = evaluator.centroid[0] - y = evaluator.centroid[1] - plt.plot(x, y, '.', color='r', markersize=24, label='centroid') - - # Graph formatting - plt.xlabel('X axis') - plt.ylabel('Z axis') - - plot_bound = max(evaluator.airfoil.x) - plt.xlim(-0.10 * plot_bound, 1.10 * plot_bound) - plt.ylim(-(1.10 * plot_bound / 2), (1.10 * plot_bound / 2)) - plt.gca().set_aspect('equal', adjustable='box') - plt.gca().legend() - plt.grid(axis='both', linestyle=':', linewidth=1) - plt.show() - return None - - -def plot_lift(evaluator): - x = range(evaluator.semi_span) - y_1 = evaluator.lift_rectangular - y_2 = evaluator.lift_elliptical - y_3 = evaluator.lift_total - plt.plot(x, y_1, '.', color='b', markersize=4, label='Rectangular lift') - plt.plot(x, y_2, '.', color='g', markersize=4, label='Elliptical lift') - plt.plot(x, y_3, '.', color='r', markersize=4, label='Total lift') - - # Graph formatting - plt.xlabel('Semi-span location') - plt.ylabel('Lift') - - plt.gca().legend() - plt.grid(axis='both', linestyle=':', linewidth=1) - plt.show() - return None diff --git a/evaluator/log_eval.txt b/evaluator/log_eval.txt deleted file mode 100644 index e69de29..0000000 diff --git a/example_airfoil.py b/example_airfoil.py index c50949d..82ee254 100644 --- a/example_airfoil.py +++ b/example_airfoil.py @@ -9,11 +9,12 @@ Evaluate an airfoil; Generate a population of airfoils & optimize. """ -import resources.materials as mt +import matplotlib.pyplot as plt + import creator -import evaluator.evaluator as evaluator +import evaluator import generator -import matplotlib.pyplot as plt +import resources.materials as mt import time start_time = time.time() @@ -47,8 +48,7 @@ af.add_naca(2412) spar1 = creator.wing.Spar(af, 'spar1') spar2 = creator.wing.Spar(af, 'spar2', 0.57) # spar2 = creator.wing.Spar(af, 'spar2', 0.7) -stringer = creator.wing.Stringer(af, 'stringer') -stringer.add_coord(af, 5, 6, 5, 4) +stringer = creator.wing.Stringer(af, 'stringer', 5, 6, 5, 4) stringer.info_save(SAVE_PATH) ac2 = creator.base.Aircraft(eval, "ac2") @@ -58,36 +58,19 @@ af2.info_save() spar3 = creator.wing.Spar(af2, 'spar3', 0.23) spar4 = creator.wing.Spar(af2, 'spar4', 0.67) stringer2 = creator.wing.Stringer(af2, 'stringer2') -stringer2.add_coord(af) stringer2.info_save(SAVE_PATH) -# print(eval.analysis()) + +for _ in range(5): + aircraft = generator.default_aircraft(eval) + aircraft2 = generator.default_aircraft(eval) + eval.tree_print(aircraft, aircraft2) + eval.tree_save(aircraft) + +print(eval.analysis()) # creator.wing.plot_geom(af) -eval.tree_print() - -# for aircraft in eval.aircrafts: -# print(aircraft) -# print(aircraft.wing.material) -# for spar in aircraft.wing.spars: -# print(spar, f"is made out of: {spar.material['name']}") - -# Plot components with matplotlib -# creator.wing.plot_geom(af, [af.spar1, af.spar2], None) - -# Evaluator object contains airfoil analysis results. -# The analysis is performed in the evaluator.py module. -# eval.analysis(1, 1) -# eval.info_print(2) -# eval.info_save(SAVE_PATH, 'foo_name') -# evaluator.plot_geom(eval) -# evaluator.plot_lift(eval) - -# import resources.NACA_2412 -# cl = resources.NACA_2412.cl -# alpha = resources.NACA_2412.alpha -# plt.plot(alpha, cl) -# plt.show() +# eval.tree_print() # Final execution time final_time = time.time() - start_time diff --git a/generator.py b/generator.py new file mode 100644 index 0000000..0ad8d0f --- /dev/null +++ b/generator.py @@ -0,0 +1,46 @@ +""" +The generator.py module contains classes describing genetic populations +and methods to generate default aircraft. +""" + +import random + +import creator + + +def default_aircraft(evaluator): + """Generate a default aircraft with a random name.""" + name = 'default_aircraft_' + str(random.randrange(1000, 9999)) + aircraft = creator.base.Aircraft(evaluator, name) + airfoil = creator.wing.Airfoil(aircraft, 'default_airfoil') + airfoil.add_naca(2412) + soar1 = creator.wing.Spar(airfoil, 'default_spar_1', 0.30) + soar2 = creator.wing.Spar(airfoil, 'default_spar_2', 0.60) + stringer = creator.wing.Stringer(airfoil, 'default_stringer') + return aircraft + + +def default_fuselage(): + pass + + +def default_propulsion(): + pass + + +class Population(): + """Collection of random airfoils.""" + def __init__(self, size): + af = creator.Airfoil + # print(af) + self.size = size + self.gen_number = 0 # incremented for every generation + + def mutate(self, prob_mt): + """Randomly mutate the genes of prob_mt % of the population.""" + def crossover(self, prob_cx): + """Combine the genes of prob_cx % of the population.""" + def reproduce(self, prob_rp): + """Pass on the genes of the fittest prob_rp % of the population.""" + def fitness(): + """Rate the fitness of an individual on a relative scale (0-100)""" diff --git a/generator/generator.py b/generator/generator.py deleted file mode 100644 index 0213828..0000000 --- a/generator/generator.py +++ /dev/null @@ -1,64 +0,0 @@ -# This file is part of Marius Peter's airfoil analysis package (this program). -# -# This program 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. -# -# This program 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 this program. If not, see . -""" -The generator.py module contains a single Population class, -which represents a collection of randomized airfoils. -""" - -from tools import creator - - -def default_airfoil(): - """Generate the default airfoil.""" - airfoil = creator.Airfoil.from_dimensions(100, 200) - airfoil.add_naca(2412) - airfoil.add_mass(10) - - airfoil.spar = creator.Spar() - airfoil.spar.add_coord(airfoil, 0.23) - airfoil.spar.add_coord(airfoil, 0.57) - airfoil.spar.add_spar_caps(0.3) - airfoil.spar.add_mass(10) - airfoil.spar.add_webs(0.4) - - airfoil.stringer = creator.Stringer() - airfoil.stringer.add_coord(airfoil, 3, 6, 5, 4) - airfoil.stringer.add_area(0.1) - airfoil.stringer.add_mass(5) - airfoil.stringer.add_webs(0.1) - - return airfoil - - -class Population(creator.Airfoil): - """Collection of random airfoils.""" - - def __init__(self, size): - af = creator.Airfoil - # print(af) - self.size = size - self.gen_number = 0 # incremented for every generation - - def mutate(self, prob_mt): - """Randomly mutate the genes of prob_mt % of the population.""" - - def crossover(self, prob_cx): - """Combine the genes of prob_cx % of the population.""" - - def reproduce(self, prob_rp): - """Pass on the genes of the fittest prob_rp % of the population.""" - - def fitness(): - """Rate the fitness of an individual on a relative scale (0-100)""" diff --git a/log_base.txt b/log_base.txt index 2e80351..150c896 100644 --- a/log_base.txt +++ b/log_base.txt @@ -9191,3 +9191,709 @@ 2019-10-17 22:24:00,767 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt 2019-10-17 22:24:00,788 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt 2019-10-17 22:24:00,789 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-17 22:28:56,204 - DEBUG - $HOME=/home/blendux +2019-10-17 22:28:56,205 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-17 22:28:56,205 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-17 22:28:56,210 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-17 22:28:56,212 - DEBUG - matplotlib version 3.1.1 +2019-10-17 22:28:56,212 - DEBUG - interactive is False +2019-10-17 22:28:56,212 - DEBUG - platform is linux +2019-10-17 22:28:56,212 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-17 22:28:56,245 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-17 22:28:56,247 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-17 22:28:56,342 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-17 22:28:56,353 - DEBUG - Loaded backend tkagg version unknown. +2019-10-17 22:28:56,353 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-17 22:28:56,368 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-17 22:28:56,390 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-17 22:28:56,391 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:27:24,516 - DEBUG - $HOME=/home/blendux +2019-10-19 13:27:24,516 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-19 13:27:24,517 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-19 13:27:24,522 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-19 13:27:24,524 - DEBUG - matplotlib version 3.1.1 +2019-10-19 13:27:24,524 - DEBUG - interactive is False +2019-10-19 13:27:24,524 - DEBUG - platform is linux +2019-10-19 13:27:24,524 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-19 13:27:24,571 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-19 13:27:24,574 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-19 13:27:24,749 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-19 13:27:24,774 - DEBUG - Loaded backend tkagg version unknown. +2019-10-19 13:27:24,774 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-19 13:27:24,792 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:27:24,810 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:27:24,811 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:27:42,145 - DEBUG - $HOME=/home/blendux +2019-10-19 13:27:42,145 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-19 13:27:42,145 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-19 13:27:42,150 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-19 13:27:42,152 - DEBUG - matplotlib version 3.1.1 +2019-10-19 13:27:42,152 - DEBUG - interactive is False +2019-10-19 13:27:42,152 - DEBUG - platform is linux +2019-10-19 13:27:42,153 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-19 13:27:42,183 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-19 13:27:42,185 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-19 13:27:42,272 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-19 13:27:42,283 - DEBUG - Loaded backend tkagg version unknown. +2019-10-19 13:27:42,283 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-19 13:27:42,298 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:27:42,317 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:27:42,318 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:30:06,313 - DEBUG - $HOME=/home/blendux +2019-10-19 13:30:06,313 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-19 13:30:06,313 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-19 13:30:06,318 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-19 13:30:06,320 - DEBUG - matplotlib version 3.1.1 +2019-10-19 13:30:06,320 - DEBUG - interactive is False +2019-10-19 13:30:06,320 - DEBUG - platform is linux +2019-10-19 13:30:06,320 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-19 13:30:06,352 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-19 13:30:06,353 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-19 13:30:06,441 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-19 13:30:06,451 - DEBUG - Loaded backend tkagg version unknown. +2019-10-19 13:30:06,452 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-19 13:30:06,466 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:30:06,486 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:30:06,488 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:30:33,837 - DEBUG - $HOME=/home/blendux +2019-10-19 13:30:33,838 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-19 13:30:33,838 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-19 13:30:33,842 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-19 13:30:33,844 - DEBUG - matplotlib version 3.1.1 +2019-10-19 13:30:33,844 - DEBUG - interactive is False +2019-10-19 13:30:33,844 - DEBUG - platform is linux +2019-10-19 13:30:33,844 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-19 13:30:33,876 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-19 13:30:33,877 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-19 13:30:33,966 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-19 13:30:33,976 - DEBUG - Loaded backend tkagg version unknown. +2019-10-19 13:30:33,976 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-19 13:30:33,990 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:30:34,034 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:30:34,035 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:31:04,434 - DEBUG - $HOME=/home/blendux +2019-10-19 13:31:04,435 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-19 13:31:04,435 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-19 13:31:04,440 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-19 13:31:04,441 - DEBUG - matplotlib version 3.1.1 +2019-10-19 13:31:04,441 - DEBUG - interactive is False +2019-10-19 13:31:04,441 - DEBUG - platform is linux +2019-10-19 13:31:04,441 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-19 13:31:04,473 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-19 13:31:04,474 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-19 13:31:04,563 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-19 13:31:04,572 - DEBUG - Loaded backend tkagg version unknown. +2019-10-19 13:31:04,573 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-19 13:31:04,588 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:31:04,607 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:31:04,608 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:31:30,159 - DEBUG - $HOME=/home/blendux +2019-10-19 13:31:30,159 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-19 13:31:30,159 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-19 13:31:30,164 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-19 13:31:30,166 - DEBUG - matplotlib version 3.1.1 +2019-10-19 13:31:30,166 - DEBUG - interactive is False +2019-10-19 13:31:30,166 - DEBUG - platform is linux +2019-10-19 13:31:30,166 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-19 13:31:30,198 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-19 13:31:30,199 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-19 13:31:30,287 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-19 13:31:30,296 - DEBUG - Loaded backend tkagg version unknown. +2019-10-19 13:31:30,297 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-19 13:31:30,312 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:31:30,332 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:31:30,333 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:31:48,578 - DEBUG - $HOME=/home/blendux +2019-10-19 13:31:48,579 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-19 13:31:48,579 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-19 13:31:48,584 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-19 13:31:48,585 - DEBUG - matplotlib version 3.1.1 +2019-10-19 13:31:48,586 - DEBUG - interactive is False +2019-10-19 13:31:48,586 - DEBUG - platform is linux +2019-10-19 13:31:48,586 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-19 13:31:48,617 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-19 13:31:48,619 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-19 13:31:48,705 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-19 13:31:48,715 - DEBUG - Loaded backend tkagg version unknown. +2019-10-19 13:31:48,715 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-19 13:31:48,730 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:31:48,750 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:31:48,751 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:31:48,878 - DEBUG - findfont: Matching :family=sans-serif:style=normal:variant=normal:weight=normal:stretch=normal:size=12.0. +2019-10-19 13:31:48,878 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,878 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,878 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,878 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 0.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 0.33499999999999996 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 1.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,879 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 1.335 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,880 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.525 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 11.24 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 11.525 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.145 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 7.698636363636363 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,881 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 3.6863636363636365 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 3.9713636363636367 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 6.698636363636363 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,882 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 4.971363636363637 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.145 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,883 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 11.24 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.525 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 7.413636363636363 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 11.24 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,884 - DEBUG - findfont: score() = 11.145 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 11.145 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 6.413636363636363 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 11.24 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.145 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,885 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 4.6863636363636365 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 11.145 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,886 - DEBUG - findfont: Matching :family=sans-serif:style=normal:variant=normal:weight=normal:stretch=normal:size=12.0 to DejaVu Sans ('/usr/lib/python3.7/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSans.ttf') with score of 0.050000. +2019-10-19 13:31:48,900 - DEBUG - findfont: Matching :family=sans-serif:style=normal:variant=normal:weight=normal:stretch=normal:size=10.0. +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 0.05 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,900 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 0.33499999999999996 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 1.05 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,901 - DEBUG - findfont: score() = 1.335 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.525 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,902 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 11.24 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 11.525 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.145 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 7.698636363636363 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 3.6863636363636365 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,903 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 3.9713636363636367 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 6.698636363636363 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 4.971363636363637 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 10.145 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,904 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 11.24 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.525 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 7.413636363636363 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,905 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 11.24 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 11.145 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,906 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 11.145 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 6.413636363636363 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 11.335 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 11.24 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.145 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.24 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 4.6863636363636365 +2019-10-19 13:31:48,907 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 11.145 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 10.335 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 10.05 +2019-10-19 13:31:48,908 - DEBUG - findfont: score() = 11.05 +2019-10-19 13:31:48,908 - DEBUG - findfont: Matching :family=sans-serif:style=normal:variant=normal:weight=normal:stretch=normal:size=10.0 to DejaVu Sans ('/usr/lib/python3.7/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSans.ttf') with score of 0.050000. +2019-10-19 13:32:56,610 - DEBUG - $HOME=/home/blendux +2019-10-19 13:32:56,610 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-19 13:32:56,611 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-19 13:32:56,615 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-19 13:32:56,617 - DEBUG - matplotlib version 3.1.1 +2019-10-19 13:32:56,617 - DEBUG - interactive is False +2019-10-19 13:32:56,617 - DEBUG - platform is linux +2019-10-19 13:32:56,617 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-19 13:32:56,649 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-19 13:32:56,650 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-19 13:32:56,740 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-19 13:32:56,750 - DEBUG - Loaded backend tkagg version unknown. +2019-10-19 13:32:56,750 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-19 13:32:56,765 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:32:56,785 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:32:56,786 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:33:59,775 - DEBUG - $HOME=/home/blendux +2019-10-19 13:33:59,775 - DEBUG - CONFIGDIR=/home/blendux/.config/matplotlib +2019-10-19 13:33:59,775 - DEBUG - matplotlib data path: /usr/lib/python3.7/site-packages/matplotlib/mpl-data +2019-10-19 13:33:59,780 - DEBUG - loaded rc file /usr/lib/python3.7/site-packages/matplotlib/mpl-data/matplotlibrc +2019-10-19 13:33:59,782 - DEBUG - matplotlib version 3.1.1 +2019-10-19 13:33:59,782 - DEBUG - interactive is False +2019-10-19 13:33:59,782 - DEBUG - platform is linux +2019-10-19 13:33:59,782 - DEBUG - loaded modules: ['sys', 'builtins', '_frozen_importlib', '_imp', '_thread', '_warnings', '_weakref', 'zipimport', '_frozen_importlib_external', '_io', 'marshal', 'posix', 'encodings', 'codecs', '_codecs', 'encodings.aliases', 'encodings.utf_8', '_signal', '__main__', 'encodings.latin_1', 'io', 'abc', '_abc', 'site', 'os', 'stat', '_stat', 'posixpath', 'genericpath', 'os.path', '_collections_abc', '_sitebuiltins', '_bootlocale', '_locale', 'types', 'importlib', 'importlib._bootstrap', 'importlib._bootstrap_external', 'warnings', 'importlib.util', 'importlib.abc', 'importlib.machinery', 'contextlib', 'collections', 'operator', '_operator', 'keyword', 'heapq', '_heapq', 'itertools', 'reprlib', '_collections', 'functools', '_functools', 'mpl_toolkits', 'sphinxcontrib', 'resources', 'resources.materials', 'creator', 'creator.base', 'numpy', '__future__', 'numpy._globals', 'numpy.__config__', 'numpy.version', 'numpy._distributor_init', 'numpy.core', 'numpy.core.info', 'numpy.core.multiarray', 'numpy.core.overrides', 'textwrap', 're', 'enum', 'sre_compile', '_sre', 'sre_parse', 'sre_constants', 'copyreg', 'datetime', 'time', 'math', '_datetime', 'numpy.core._multiarray_umath', 'numpy.compat', 'numpy.compat._inspect', 'numpy.compat.py3k', 'pathlib', 'fnmatch', 'ntpath', 'errno', 'urllib', 'urllib.parse', 'pickle', 'struct', '_struct', '_compat_pickle', '_pickle', 'numpy.core.umath', 'numpy.core.numerictypes', 'numbers', 'numpy.core._string_helpers', 'numpy.core._type_aliases', 'numpy.core._dtype', 'numpy.core.numeric', 'numpy.core._exceptions', 'numpy.core._asarray', 'numpy.core._ufunc_config', 'collections.abc', 'numpy.core.fromnumeric', 'numpy.core._methods', 'numpy.core.arrayprint', 'numpy.core.defchararray', 'numpy.core.records', 'numpy.core.memmap', 'numpy.core.function_base', 'numpy.core.machar', 'numpy.core.getlimits', 'numpy.core.shape_base', 'numpy.core.einsumfunc', 'numpy.core._add_newdocs', 'numpy.core._multiarray_tests', 'numpy.core._dtype_ctypes', '_ctypes', 'ctypes', 'ctypes._endian', 'numpy.core._internal', 'platform', 'subprocess', 'signal', '_posixsubprocess', 'select', 'selectors', 'threading', 'traceback', 'linecache', 'tokenize', 'token', '_weakrefset', 'numpy._pytesttester', 'numpy.lib', 'numpy.lib.info', 'numpy.lib.type_check', 'numpy.lib.ufunclike', 'numpy.lib.index_tricks', 'numpy.matrixlib', 'numpy.matrixlib.defmatrix', 'ast', '_ast', 'numpy.linalg', 'numpy.linalg.info', 'numpy.linalg.linalg', 'numpy.lib.twodim_base', 'numpy.linalg.lapack_lite', 'numpy.linalg._umath_linalg', 'numpy.lib.function_base', 'numpy.lib.histograms', 'numpy.lib.stride_tricks', 'numpy.lib.mixins', 'numpy.lib.nanfunctions', 'numpy.lib.shape_base', 'numpy.lib.scimath', 'numpy.lib.polynomial', 'numpy.lib.utils', 'numpy.lib.arraysetops', 'numpy.lib.npyio', 'weakref', 'numpy.lib.format', 'numpy.lib._datasource', 'shutil', 'zlib', 'bz2', '_compression', '_bz2', 'lzma', '_lzma', 'pwd', 'grp', 'numpy.lib._iotools', 'numpy.lib.financial', 'decimal', '_pydecimal', 'contextvars', '_contextvars', 'locale', 'numpy.lib.arrayterator', 'numpy.lib.arraypad', 'numpy.lib._version', 'numpy.fft', 'numpy.fft.info', 'numpy.fft.pocketfft', 'numpy.fft.pocketfft_internal', 'numpy.fft.helper', 'numpy.polynomial', 'numpy.polynomial.polynomial', 'numpy.polynomial.polyutils', 'numpy.polynomial._polybase', 'numpy.polynomial.chebyshev', 'numpy.polynomial.legendre', 'numpy.polynomial.hermite', 'numpy.polynomial.hermite_e', 'numpy.polynomial.laguerre', 'numpy.random', 'numpy.random._pickle', 'numpy.random.mtrand', 'cython_runtime', 'numpy.random.common', 'numpy.random.bounded_integers', 'numpy.random.mt19937', 'numpy.random.bit_generator', '_cython_0_29_13', 'secrets', 'base64', 'binascii', 'hmac', '_hashlib', 'hashlib', '_blake2', '_sha3', 'random', 'bisect', '_bisect', '_random', 'numpy.random.entropy', 'numpy.random.philox', 'numpy.random.pcg64', 'numpy.random.sfc64', 'numpy.random.generator', 'numpy.ctypeslib', 'numpy.ma', 'numpy.ma.core', 'numpy.ma.extras', 'numpy.testing', 'unittest', 'unittest.result', 'unittest.util', 'unittest.case', 'difflib', 'logging', 'string', '_string', 'atexit', 'pprint', 'unittest.suite', 'unittest.loader', 'unittest.main', 'argparse', 'gettext', 'unittest.runner', 'unittest.signals', 'numpy.testing._private', 'numpy.testing._private.utils', 'gc', 'tempfile', 'numpy.testing._private.decorators', 'numpy.testing._private.nosetester', 'creator.fuselage', 'creator.propulsion', 'creator.wing', 'matplotlib', 'distutils', 'distutils.version', 'inspect', 'dis', 'opcode', '_opcode', 'matplotlib.cbook', 'glob', 'gzip', 'matplotlib.cbook.deprecation', 'matplotlib.rcsetup', 'matplotlib.fontconfig_pattern', 'pyparsing', 'copy', 'matplotlib.colors', 'matplotlib._color_data', 'cycler', 'six', 'six.moves', 'matplotlib._version', 'json', 'json.decoder', 'json.scanner', '_json', 'json.encoder', 'matplotlib.ft2font', 'dateutil', 'dateutil._version', 'kiwisolver', 'socket', '_socket'] +2019-10-19 13:33:59,814 - DEBUG - CACHEDIR=/home/blendux/.cache/matplotlib +2019-10-19 13:33:59,816 - DEBUG - Using fontManager instance from /home/blendux/.cache/matplotlib/fontlist-v310.json +2019-10-19 13:33:59,903 - DEBUG - Loaded backend qt5agg version unknown. +2019-10-19 13:33:59,913 - DEBUG - Loaded backend tkagg version unknown. +2019-10-19 13:33:59,913 - DEBUG - Loaded backend TkAgg version unknown. +2019-10-19 13:33:59,927 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:33:59,946 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:33:59,947 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:38:38,653 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:38:38,671 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:38:38,672 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 13:54:31,121 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:54:31,141 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:55:12,952 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:55:12,972 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:55:29,386 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:55:29,405 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:56:25,811 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:56:25,830 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:58:52,465 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:58:52,483 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 13:59:49,788 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 13:59:49,809 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:04:11,482 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:04:11,503 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:04:26,522 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:04:26,542 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:04:26,543 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:04:40,446 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:04:40,466 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:04:40,467 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:04:44,245 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:04:44,265 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:04:44,266 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:04:48,645 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:04:48,664 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:04:48,665 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:05:24,981 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:05:25,000 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:05:25,001 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:06:28,965 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:06:28,984 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:06:28,985 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:06:59,114 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:06:59,134 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:06:59,135 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:08:46,335 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:08:46,355 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:08:46,356 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:09:09,261 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:09:09,281 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:09:09,282 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:10:03,883 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:10:03,901 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:10:03,902 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:25:20,005 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:25:20,024 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:25:20,025 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:30:21,842 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:30:21,860 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:30:21,861 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:35:25,816 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:35:25,836 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:35:25,836 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:38:02,841 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:38:02,862 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:38:02,863 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:38:28,781 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:38:28,801 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:38:28,802 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:40:46,061 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:40:46,080 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:40:46,081 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:43:25,526 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:43:25,545 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:43:25,546 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:43:37,410 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:43:37,430 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:43:37,431 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:43:39,920 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:43:39,939 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:43:39,941 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:44:08,265 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:44:08,283 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:44:08,284 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:44:11,058 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:44:11,078 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:44:11,079 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:44:38,693 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:44:38,737 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:44:38,738 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:46:01,472 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:46:01,492 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:46:01,493 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:46:22,051 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:46:22,071 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:46:22,072 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:47:36,392 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:47:36,412 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:47:36,413 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:48:18,770 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:48:18,790 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:48:18,791 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:49:14,694 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:49:14,715 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:49:14,716 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:50:03,636 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:50:03,656 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:50:03,657 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:50:03,766 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:51:29,096 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:51:29,116 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:51:29,117 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:52:05,407 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:52:05,427 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:52:05,428 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:52:05,439 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:52:05,451 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:52:05,463 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:52:05,475 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:52:05,486 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:52:05,498 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:52:05,509 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:52:05,521 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:52:05,533 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:52:05,544 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:56:45,789 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:56:45,808 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:56:45,809 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:57:00,745 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:57:00,765 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:57:00,766 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:57:00,778 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:57:00,789 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:57:00,800 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:57:00,812 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:57:00,849 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:57:00,861 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:57:00,872 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:57:00,883 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:57:00,895 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:57:00,906 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/eval_tree.txt +2019-10-19 14:58:09,048 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 14:58:09,069 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 14:58:09,070 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 14:58:09,082 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_4854_tree.txt +2019-10-19 14:58:09,094 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1540_tree.txt +2019-10-19 14:58:09,106 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_8092_tree.txt +2019-10-19 14:58:09,118 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_2839_tree.txt +2019-10-19 14:58:09,130 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_7512_tree.txt +2019-10-19 14:58:09,141 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_8127_tree.txt +2019-10-19 14:58:09,153 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_6052_tree.txt +2019-10-19 14:58:09,165 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1718_tree.txt +2019-10-19 14:58:09,177 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_7208_tree.txt +2019-10-19 14:58:09,188 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1910_tree.txt +2019-10-19 15:00:35,777 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 15:00:35,797 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 15:00:35,798 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 15:00:35,809 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_3406_tree.txt +2019-10-19 15:00:35,821 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_3587_tree.txt +2019-10-19 15:00:35,833 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_9420_tree.txt +2019-10-19 15:00:35,844 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1543_tree.txt +2019-10-19 15:00:35,856 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_3870_tree.txt +2019-10-19 15:00:35,867 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_6625_tree.txt +2019-10-19 15:00:35,879 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_5532_tree.txt +2019-10-19 15:00:35,890 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_5589_tree.txt +2019-10-19 15:00:35,902 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_9706_tree.txt +2019-10-19 15:00:35,914 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_6608_tree.txt +2019-10-19 15:05:24,019 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 15:05:24,037 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 15:05:24,038 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 15:05:24,048 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_7382_tree.txt +2019-10-19 15:05:24,060 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_3485_tree.txt +2019-10-19 15:05:24,071 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_2016_tree.txt +2019-10-19 15:05:24,082 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1194_tree.txt +2019-10-19 15:05:24,094 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_7938_tree.txt +2019-10-19 15:05:24,106 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_9898_tree.txt +2019-10-19 15:05:24,117 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_7760_tree.txt +2019-10-19 15:05:24,129 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_5854_tree.txt +2019-10-19 15:05:24,140 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_9291_tree.txt +2019-10-19 15:05:24,151 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_7602_tree.txt +2019-10-19 15:05:43,074 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 15:05:43,094 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 15:05:43,095 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 15:05:43,106 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1776_tree.txt +2019-10-19 15:05:43,118 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_4948_tree.txt +2019-10-19 15:05:43,129 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_6698_tree.txt +2019-10-19 15:05:43,141 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_2652_tree.txt +2019-10-19 15:05:43,152 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_8138_tree.txt +2019-10-19 15:05:43,163 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1975_tree.txt +2019-10-19 15:05:43,174 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_5299_tree.txt +2019-10-19 15:05:43,185 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_5765_tree.txt +2019-10-19 15:05:43,196 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_2761_tree.txt +2019-10-19 15:05:43,207 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_6650_tree.txt +2019-10-19 15:07:50,477 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 15:07:50,498 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 15:07:50,499 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 15:07:50,510 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_8489_tree.txt +2019-10-19 15:07:50,521 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_9127_tree.txt +2019-10-19 15:07:50,533 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_2304_tree.txt +2019-10-19 15:07:50,545 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_2489_tree.txt +2019-10-19 15:07:50,557 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1087_tree.txt +2019-10-19 15:07:50,569 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_6582_tree.txt +2019-10-19 15:07:50,580 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_7781_tree.txt +2019-10-19 15:07:50,593 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_4472_tree.txt +2019-10-19 15:07:50,604 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_2328_tree.txt +2019-10-19 15:07:50,616 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_8146_tree.txt +2019-10-19 15:08:03,176 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 15:08:03,197 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 15:08:03,198 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 15:08:03,209 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_5493_tree.txt +2019-10-19 15:08:03,220 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_9868_tree.txt +2019-10-19 15:08:03,232 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_3602_tree.txt +2019-10-19 15:08:03,244 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_6319_tree.txt +2019-10-19 15:08:03,256 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_8134_tree.txt +2019-10-19 15:08:03,268 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_3627_tree.txt +2019-10-19 15:08:03,279 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_3228_tree.txt +2019-10-19 15:08:03,291 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_5040_tree.txt +2019-10-19 15:08:03,303 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1172_tree.txt +2019-10-19 15:08:03,315 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1025_tree.txt +2019-10-19 15:08:22,175 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 15:08:22,196 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 15:08:22,197 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 15:08:22,208 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1610_tree.txt +2019-10-19 15:08:22,220 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_9685_tree.txt +2019-10-19 15:08:22,231 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_5293_tree.txt +2019-10-19 15:08:22,243 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1515_tree.txt +2019-10-19 15:08:22,255 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_9450_tree.txt +2019-10-19 15:09:16,504 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 15:09:16,524 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 15:09:16,525 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 15:09:16,545 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_8532_tree.txt +2019-10-19 15:09:16,567 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_6201_tree.txt +2019-10-19 15:09:16,590 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_9508_tree.txt +2019-10-19 15:09:16,612 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_8637_tree.txt +2019-10-19 15:09:16,635 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_2043_tree.txt +2019-10-19 15:09:45,671 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer_info.txt +2019-10-19 15:09:45,692 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/af2_info.txt +2019-10-19 15:09:45,693 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/stringer2_info.txt +2019-10-19 15:09:45,715 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1531_tree.txt +2019-10-19 15:09:45,738 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_4784_tree.txt +2019-10-19 15:09:45,760 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_1265_tree.txt +2019-10-19 15:09:45,783 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_4292_tree.txt +2019-10-19 15:09:45,805 - DEBUG - Successfully wrote to file /home/blendux/Projects/Aircraft_Studio/save/default_aircraft_3669_tree.txt -- cgit v1.2.3