Hydraulic Fracturing in the Toughness-Dominated Regime

This page is based on a Jupyter notebook.

Hydraulic Fracturing in the Toughness-Dominated Regime

Under the toughness-dominated regime without leak-off, the fluid viscosity dissipation is negligible compared to the energy released for fracture surface formation (Detournay et al., 2016). Therefore, in this regime, we can neglect the pressure loss within the fracture and use the Sneddon solution for crack opening (Bourdin et al., 2012, Sneddon et al., 1969) to determine the pressure and length evolution.

The work of the pressure force is as follows:

$$ \begin{equation} \mathcal{W}(R) =\frac{2 p^2 a^2}{E'}. \end{equation} $$

Applying Clapeyron’s theorem, the elastic energy can be determined as

$$ \begin{equation} \mathcal{E}(R) =-\frac{\pi p^2 a^2}{E'}, \end{equation} $$

and the energy release rate with respect to the crack length $a$ propagating along the initial inclination is

$$ \begin{equation} G(R) = - \frac{\partial \mathcal{E}}{\partial (2 a)} = \frac{\pi p^2 a}{E'}. \end{equation} $$

Griffith's criterion (Griffith et al., 1920) states that the fracture propagates when $G=G_c$ and the critical volume for crack propagation is $V_c := \sqrt{\dfrac{4 \pi G_c a^3}{E' }}$ in a quasi-static volume control setting (the fracture propagation is always unstable with pressure control).

The evolution of the corresponding pressure and fracture length

$$ \begin{equation} p(V) = \begin{cases} \dfrac{E' V}{2 \pi a_0^2} &\text{for} V < V_c \\ \left[ \dfrac{2 E' G_c^2}{\pi V} \right] ^{\frac{1}{3}}&\text{for} V \geq V_c, \end{cases} \end{equation} $$ $$ \begin{equation} a(V) = \begin{cases} a_0 & V < V_c \\ \left[ \dfrac{E' V^2}{4 \pi G_c} \right ] ^{\frac{1}{3}} & V \geq V_c. \end{cases} \end{equation} $$

Problem Description

Based on Sneddon's solution (Sneddon et al., 1969), we verified the model with plane-strain hydraulic fracture propagation in a toughness-dominated regime. In an infinite 2D domain, the problem was solved with a line fracture $[-a_0, a_0] \times \{0\}$ ($a_0$ = 0.05). We considered a large finite domain $[-40a_0,40a_0] \times [-40a_0,40a_0]$ to account for the infinite boundaries in the closed-form solution. The effective size of an element, $h$, is $1\times10^{-2}$.

Schematic view of hydraulic fracturing problem and Boundary conditions
Schematic view of hydraulic fracturing problem and Boundary conditions.

  • In order to have the hydraulic fracturing in the toughness dominated-regime, add, $\texttt{propagating}$ in the project file.
  • Yoshioka et al., 2019 provides additional information on the implementation, use of real material properties, and rescaling of the phase-field energy functional.

Input Data

Taking advantage of the linearity of the system, the simulations were run with the dimensionless properties listed in the Table below.

Name Value Symbol
Young’s modulus 1 $E$
Poisson’s ratio 0.15 $\nu$
Fracture toughness 1 $G_{c}$
Regularization parameter 2$h$ $\ell_s$
Length 4 $L$
Height 4 $H$
Initial crack length 0.1 $2a_0$
import math(click to toggle)
import math
import os
import re
import time
from pathlib import Path
from subprocess import run

import gmsh
import matplotlib.pyplot as plt
import numpy as np
import ogstools as ot
import pyvista as pv
from ogstools.msh2vtu import msh2vtu
pi = math.pi
plt.rcParams["text.usetex"] = True
E = 1.0(click to toggle)
E = 1.0
nu = 0.15
Gc = 1.0
h = 0.01
a0 = 0.05  # half of the initial crack length

phasefield_model = "AT1"  # AT1/AT2

Output Directory and Project File

# file's name(click to toggle)
# file's name
prj_name = "Kregime_Propagating.prj"
meshname = "mesh_full_pf"

out_dir = Path(os.environ.get("OGS_TESTRUNNER_OUT_DIR", "_out"))
if not out_dir.exists():
    out_dir.mkdir(parents=True)

Mesh Generation

def mesh_generation(lc, lc_fine):(click to toggle)
def mesh_generation(lc, lc_fine):
    """
    lc ... characteristic length for coarse meshing
    lc_fine ... characteristic length for fine meshing
    """
    L = 4.0  # Length
    H = 4.0  # Height
    b = 0.4  # Length/Height of subdomain with fine mesh

    # Before using any functions in the Python API, Gmsh must be initialized
    gmsh.initialize()
    gmsh.option.setNumber("General.Terminal", 1)
    gmsh.model.add("rectangle")

    # Dimensions
    dim0 = 0
    dim1 = 1
    dim2 = 2

    # Points
    gmsh.model.geo.addPoint(-L / 2, -H / 2, 0, lc, 1)
    gmsh.model.geo.addPoint(L / 2, -H / 2, 0, lc, 2)
    gmsh.model.geo.addPoint(L / 2, H / 2, 0, lc, 3)
    gmsh.model.geo.addPoint(-L / 2, H / 2, 0, lc, 4)
    gmsh.model.geo.addPoint(-b, -b - lc_fine / 2, 0, lc_fine, 5)
    gmsh.model.geo.addPoint(b, -b - lc_fine / 2, 0, lc_fine, 6)
    gmsh.model.geo.addPoint(b, b + lc_fine / 2, 0, lc_fine, 7)
    gmsh.model.geo.addPoint(-b, b + lc_fine / 2, 0, lc_fine, 8)

    # Lines
    gmsh.model.geo.addLine(1, 2, 1)
    gmsh.model.geo.addLine(2, 3, 2)
    gmsh.model.geo.addLine(3, 4, 3)
    gmsh.model.geo.addLine(4, 1, 4)
    gmsh.model.geo.addLine(5, 6, 5)
    gmsh.model.geo.addLine(6, 7, 6)
    gmsh.model.geo.addLine(7, 8, 7)
    gmsh.model.geo.addLine(8, 5, 8)

    # Line loops
    gmsh.model.geo.addCurveLoop([1, 2, 3, 4], 1)
    gmsh.model.geo.addCurveLoop([5, 6, 7, 8], 2)

    # Add plane surfaces defined by one or more curve loops.
    gmsh.model.geo.addPlaneSurface([1, 2], 1)
    gmsh.model.geo.addPlaneSurface([2], 2)

    gmsh.model.geo.synchronize()

    # Prepare structured grid
    gmsh.model.geo.mesh.setTransfiniteCurve(
        6, math.ceil(2 * b / lc_fine + 2), "Progression", 1
    )
    gmsh.model.geo.mesh.setTransfiniteCurve(
        8, math.ceil(2 * b / lc_fine + 2), "Progression", 1
    )
    gmsh.model.geo.mesh.setTransfiniteSurface(2, "Alternate")

    gmsh.model.geo.mesh.setRecombine(dim2, 1)
    gmsh.model.geo.mesh.setRecombine(dim2, 2)

    gmsh.model.geo.synchronize()

    # Physical groups
    P1 = gmsh.model.addPhysicalGroup(dim0, [1])
    gmsh.model.setPhysicalName(dim0, P1, "P1")

    P2 = gmsh.model.addPhysicalGroup(dim0, [2])
    gmsh.model.setPhysicalName(dim0, P2, "P2")

    Bottom = gmsh.model.addPhysicalGroup(dim1, [1])
    gmsh.model.setPhysicalName(dim1, Bottom, "Bottom")

    Right = gmsh.model.addPhysicalGroup(dim1, [2])
    gmsh.model.setPhysicalName(dim1, Right, "Right")

    Top = gmsh.model.addPhysicalGroup(dim1, [3])
    gmsh.model.setPhysicalName(dim1, Top, "Top")

    Left = gmsh.model.addPhysicalGroup(dim1, [4])
    gmsh.model.setPhysicalName(dim1, Left, "Left")

    Computational_domain = gmsh.model.addPhysicalGroup(dim2, [1, 2])
    gmsh.model.setPhysicalName(dim2, Computational_domain, "Computational_domain")
    gmsh.model.geo.synchronize()

    output_file = f"{out_dir}/" + meshname + ".msh"
    gmsh.model.mesh.generate(dim2)
    gmsh.write(output_file)
    gmsh.finalize()

Pre-Processing

def pre_processing(h, a0):(click to toggle)
def pre_processing(h, a0):
    mesh = pv.read(f"{out_dir}/mesh_full_pf_domain.vtu")
    phase_field = np.ones((len(mesh.points), 1))
    pv.set_plot_theme("document")

    for node_id, x in enumerate(mesh.points):
        if (
            (mesh.center[0] - x[0]) <= a0 + 0.001 * h
            and (mesh.center[0] - x[0]) >= -a0 - 0.001 * h
            and (mesh.center[1] - x[1]) < h / 2 + 0.001 * h
            and (mesh.center[1] - x[1]) > -h / 2 - 0.001 * h
        ):
            phase_field[node_id] = 0.0

    mesh.point_data["phase-field"] = phase_field
    mesh.save(f"{out_dir}/mesh_full_pf_OGS_pf_ic.vtu")

Run the Simulation

pv.set_plot_theme("document")(click to toggle)
pv.set_plot_theme("document")
pv.set_jupyter_backend("static")


def Hydraulic_Fracturing_Toughness_Dominated_numerical(h, phasefield_model):
    # mesh properties
    ls = 2 * h
    # generate prefix from properties
    filename = f"results_h_{h:0.4f}_{phasefield_model}"
    mesh_generation(0.1, h)
    # Convert GMSH (.msh) meshes to VTU meshes appropriate for OGS simulation.
    input_file = f"{out_dir}/" + meshname + ".msh"
    msh2vtu(filename=input_file, output_path=out_dir, reindex=True, keep_ids=True)
    %cd {out_dir}
    run(
        "identifySubdomains -f -m mesh_full_pf_domain.vtu -- mesh_full_pf_physical_group_*.vtu",
        shell=True,
        check=True,
    )
    %cd -

    # As a preprocessing step, define the initial phase-field (crack).
    pre_processing(h, a0)
    # change properties in prj file #For more information visit: https://ogstools.opengeosys.org/stable/reference/ogstools.ogs6py.html
    model = ot.Project(
        input_file=prj_name,
        output_file=f"{out_dir}/{prj_name}",
        MKL=True,
        args=f"-o {out_dir}",
    )
    model.replace_parameter_value(name="ls", value=ls)
    model.replace_text(phasefield_model, xpath="./processes/process/phasefield_model")
    model.replace_text(filename, xpath="./time_loop/output/prefix")
    model.write_input()
    # run simulation with ogs
    t0 = time.time()
    print(">>> OGS started execution ... <<<")
    run(
        f"ogs {out_dir}/{prj_name} -o {out_dir} > {out_dir}/log.txt",
        shell=True,
        check=True,
    )
    tf = time.time()
    print(">>> OGS terminated execution  <<< Elapsed time: ", round(tf - t0, 2), " s.")
Hydraulic_Fracturing_Toughness_Dominated_numerical(h, phasefield_model)
Info    : Meshing 1D...
Info    : [  0%] Meshing curve 1 (Line)
Info    : [ 20%] Meshing curve 2 (Line)
Info    : [ 30%] Meshing curve 3 (Line)
Info    : [ 40%] Meshing curve 4 (Line)
Info    : [ 60%] Meshing curve 5 (Line)
Info    : [ 70%] Meshing curve 6 (Line)
Info    : [ 80%] Meshing curve 7 (Line)
Info    : [ 90%] Meshing curve 8 (Line)
Info    : Done meshing 1D (Wall 0.00041556s, CPU 0s)
Info    : Meshing 2D...
Info    : [  0%] Meshing surface 1 (Plane, Frontal-Delaunay)
Info    : [  0%] Blossom: 24032 internal 482 closed
INFO:root:Output: mesh_full_pf
INFO:root:Original mesh (read)
INFO:root:<meshio mesh object>
  Number of points: 14439
  Number of cells:
    vertex: 1
    vertex: 1
    line: 40
    line: 40
    line: 40
    line: 40
    quad: 7878
    quad: 6480
  Cell sets: P1, P2, Bottom, Right, Top, Left, Computational_domain, gmsh:bounding_entities
  Point data: gmsh:dim_tags
  Cell data: gmsh:physical, gmsh:geometrical
  Field data: P1, P2, Bottom, Right, Top, Left, Computational_domain
INFO:root:Detected mesh dimension: 2
INFO:root:##
INFO:root:Domain mesh (written)
INFO:root:14439 points in 3 dimensions
INFO:root:cells: 14358 quad
INFO:root:point_data=['gmsh:dim_tags']
INFO:root:cell_data=['gmsh:physical']
INFO:root:cell_sets=[]
INFO:root:##
INFO:root:Boundary mesh (written)
INFO:root:160 points in 3 dimensions
INFO:root:cells: 160 line
INFO:root:point_data=['gmsh:dim_tags']
INFO:root:cell_data=['gmsh:physical']
INFO:root:cell_sets=[]
INFO:root:##
INFO:root:Submesh P1 (written)
INFO:root:1 points in 3 dimensions
INFO:root:cells: 1 vertex
INFO:root:point_data=['gmsh:dim_tags']
INFO:root:cell_data=['gmsh:physical']
INFO:root:cell_sets=[]
INFO:root:##
INFO:root:Submesh P2 (written)
INFO:root:1 points in 3 dimensions
INFO:root:cells: 1 vertex
INFO:root:point_data=['gmsh:dim_tags']
INFO:root:cell_data=['gmsh:physical']
INFO:root:cell_sets=[]
INFO:root:##
INFO:root:Submesh Bottom (written)
INFO:root:41 points in 3 dimensions
INFO:root:cells: 40 line
INFO:root:point_data=['gmsh:dim_tags']
INFO:root:cell_data=['gmsh:physical']
INFO:root:cell_sets=[]
INFO:root:##
INFO:root:Submesh Right (written)
INFO:root:41 points in 3 dimensions
INFO:root:cells: 40 line
INFO:root:point_data=['gmsh:dim_tags']
INFO:root:cell_data=['gmsh:physical']
INFO:root:cell_sets=[]
INFO:root:##
INFO:root:Submesh Top (written)
INFO:root:41 points in 3 dimensions
INFO:root:cells: 40 line
INFO:root:point_data=['gmsh:dim_tags']
INFO:root:cell_data=['gmsh:physical']
INFO:root:cell_sets=[]
INFO:root:##
INFO:root:Submesh Left (written)
INFO:root:41 points in 3 dimensions
INFO:root:cells: 40 line
INFO:root:point_data=['gmsh:dim_tags']
INFO:root:cell_data=['gmsh:physical']
INFO:root:cell_sets=[]
INFO:root:##
INFO:root:Submesh Computational_domain (written)
INFO:root:14439 points in 3 dimensions
INFO:root:cells: 14358 quad
INFO:root:point_data=['gmsh:dim_tags']
INFO:root:cell_data=['gmsh:physical']
INFO:root:cell_sets=[]
INFO:root:##
Info    : [  0%] Blossom recombination completed (Wall 0.351309s, CPU 0.336192s): 7878 quads, 0 triangles, 0 invalid quads, 0 quads with Q < 0.1, avg Q = 0.793024, min Q = 0.371315
Info    : [ 60%] Meshing surface 2 (Transfinite)
Info    : Done meshing 2D (Wall 0.517487s, CPU 0.490859s)
Info    : 14439 nodes 14848 elements
Info    : Writing '/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/Tests/Data/PhaseField/Kregime_Propagating_jupyter_notebook/Kregime_Propagating_jupyter/mesh_full_pf.msh'...
Info    : Done writing '/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/Tests/Data/PhaseField/Kregime_Propagating_jupyter_notebook/Kregime_Propagating_jupyter/mesh_full_pf.msh'

/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/Tests/Data/PhaseField/Kregime_Propagating_jupyter_notebook/Kregime_Propagating_jupyter
/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/IPython/core/magics/osm.py:417: UserWarning: This is now an optional IPython functionality, setting dhist requires you to install the `pickleshare` library.
  self.shell.db['dhist'] = compress_dhist(dhist)[-100:]
[2025-02-13 08:38:12.996] [ogs] [info] Mesh reading time: 0.0413053 s
[2025-02-13 08:38:12.996] [ogs] [info] MeshNodeSearcher construction time: 0.000543647 s
[2025-02-13 08:38:12.997] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshNodes took 1.6381e-05 s
[2025-02-13 08:38:12.998] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshElements took 0.00186039 s
[2025-02-13 08:38:13.000] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshNodes took 0.00129344 s
[2025-02-13 08:38:13.006] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshElements took 0.00645372 s
[2025-02-13 08:38:13.006] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshNodes took 6.3e-06 s
[2025-02-13 08:38:13.007] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshElements took 0.000866137 s
[2025-02-13 08:38:13.007] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshNodes took 3.4e-07 s
[2025-02-13 08:38:13.008] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshElements took 0.000617069 s
[2025-02-13 08:38:13.008] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshNodes took 2.9e-07 s
[2025-02-13 08:38:13.009] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshElements took 0.00063103 s
[2025-02-13 08:38:13.009] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshNodes took 6.18e-06 s
[2025-02-13 08:38:13.009] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshElements took 0.000681872 s
[2025-02-13 08:38:13.009] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshNodes took 4.77e-06 s
[2025-02-13 08:38:13.010] [ogs] [info] identifySubdomainMesh(): identifySubdomainMeshElements took 0.000624489 s
[2025-02-13 08:38:13.010] [ogs] [info] identifySubdomains time: 0.0134301 s
[2025-02-13 08:38:13.043] [ogs] [info] writing time: 0.032922 s
[2025-02-13 08:38:13.043] [ogs] [info] Entire run time: 1.34533 s
/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/ogs/Tests/Data/PhaseField/Kregime_Propagating_jupyter_notebook
>>> OGS started execution ... <<<
>>> OGS terminated execution  <<< Elapsed time:  350.2  s.

Post-Processing

Analytical Solution for the Evolution of Fracture Length and Pressure

def Analytical_solution(phasefield_model, h):(click to toggle)
def Analytical_solution(phasefield_model, h):
    v = np.linspace(1e-10, 0.3, 31)
    pres = np.linspace(0, 1.0, 31)
    length = np.linspace(0, 1.0, 31)

    ls = 2 * h

    # Effective Gc and a for AT1/A2
    if phasefield_model == "AT1":
        Gc_ref = Gc * (3 * h / 8.0 / ls + 1.0)
        a_eff = a0 * (1 + pi * ls / (4.0 * a0 * (3 * h / 8.0 / ls + 1.0)))
    elif phasefield_model == "AT2":
        Gc_ref = Gc * (h / (2.0 * ls) + 1.0)
        a_eff = a0 * (1 + pi * ls / (4.0 * a0 * (h / (2.0 * ls) + 1.0)))

    Eprime = E / (1 - nu**2)

    V_c = (4 * pi * Gc_ref * a_eff**3 / Eprime) ** 0.5
    P_c = (Eprime * Gc_ref / (pi * a_eff)) ** 0.5

    for i in range(len(v)):
        if v[i] < V_c:
            pres[i] = Eprime * v[i] / (2 * pi * a_eff**2) / P_c
            length[i] = a_eff
        else:
            pres[i] = (2 * Eprime * Gc_ref**2 / (pi * v[i])) ** 0.333333 / P_c
            length[i] = (Eprime * v[i] ** 2 / (4 * pi * Gc_ref)) ** 0.333333

    return v, pres, length, Gc_ref, P_c


fluidVolume_analytical = Analytical_solution(phasefield_model, h)[0]
pressure_analytical = Analytical_solution(phasefield_model, h)[1]
length_analytical = Analytical_solution(phasefield_model, h)[2]
Gc_ref = Analytical_solution(phasefield_model, h)[3]
P_c = Analytical_solution(phasefield_model, h)[4]

Phase Field Versus Analytical Solution for Fracture Length and Pressure Evolution

In phase field approach, we can retrieve the crack length $a$ as:

$$ \begin{equation} a = \dfrac{\displaystyle \int_\Omega \frac{G_c}{4 c_n} \left(\frac{(1-v)^n}{\ell}+ \ell |\nabla v|^2\right)\,\mathrm{d} \Omega }{G_c \left( \dfrac{h}{4 c_n \ell} + 1 \right)}. \end{equation} $$

where $n=1$ corresponds to $\texttt{AT}_1$ ($c_n = 2/3$) and $n=2$ to $\texttt{AT}_2$ ($c_n = 1/2$).

plt.subplots(figsize=(12, 4))(click to toggle)
plt.subplots(figsize=(12, 4))
plt.subplot(1, 2, 1)
fluid_volume = []
surface_energy = []
# Open the file for reading
with (out_dir / "log.txt").open() as fd:
    # Iterate over the lines
    for _i, line in enumerate(fd):
        match_surface_energy = re.search(
            r"""Surface energy: (\d+\.\d*) Pressure work: (\d+\.\d*)  at time: (\d+\.\d*)""",
            line,
        )
        if match_surface_energy:
            surface_energy.append(float(match_surface_energy.group(1)))
            fluid_volume.append(float(match_surface_energy.group(3)))

plt.grid(linestyle="dashed")
plt.xlabel("Volume")
plt.ylabel("Crack length")
plt.plot(fluidVolume_analytical, length_analytical, "black", label="Closed form")
plt.plot(
    fluid_volume,
    np.array(surface_energy[:]) / Gc_ref / 2,
    "bo",
    fillstyle="none",
    label="Phase-field",
)
legend = plt.legend(loc="lower right")

plt.subplot(1, 2, 2)
fluid_volume = []
pressure = []
# Open the file for reading
with (out_dir / "log.txt").open() as fd:
    # Iterate over the lines
    for _i, line in enumerate(fd):
        match_pressure = re.search(
            r"""Pressure: (\d+\.\d*) at time: (\d+\.\d*)""", line
        )
        if match_pressure:
            fluid_volume.append(float(match_pressure.group(2)))
            pressure.append(float(match_pressure.group(1)))


plt.xlabel("Volume")
plt.ylabel("$p_f/p_c$")
plt.plot(fluidVolume_analytical, pressure_analytical, "black", label="Closed form")
plt.plot(
    np.array(fluid_volume[:]),
    np.array(pressure[:]) / P_c,
    "g<",
    fillstyle="none",
    label="Phase-field",
)
plt.grid(linestyle="dashed")
legend = plt.legend(loc="upper right")
plt.show()
DEBUG:matplotlib.pyplot:Loaded backend module://matplotlib_inline.backend_inline version unknown.
DEBUG:matplotlib.pyplot:Loaded backend module://matplotlib_inline.backend_inline version unknown.
DEBUG:matplotlib.font_manager:findfont: Matching sans\-serif:style=normal:variant=normal:weight=normal:stretch=normal:size=10.0.
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSans-BoldOblique.ttf', name='DejaVu Sans', style='oblique', variant='normal', weight=700, stretch='normal', size='scalable')) = 1.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSans-Bold.ttf', name='DejaVu Sans', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 0.33499999999999996
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXSizFourSymBol.ttf', name='STIXSizeFourSym', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSerifDisplay.ttf', name='DejaVu Serif Display', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSerif-Bold.ttf', name='DejaVu Serif', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSansMono-BoldOblique.ttf', name='DejaVu Sans Mono', style='oblique', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSansMono.ttf', name='DejaVu Sans Mono', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXGeneral.ttf', name='STIXGeneral', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXSizTwoSymBol.ttf', name='STIXSizeTwoSym', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/cmex10.ttf', name='cmex10', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/cmsy10.ttf', name='cmsy10', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSansMono-Bold.ttf', name='DejaVu Sans Mono', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXSizOneSymBol.ttf', name='STIXSizeOneSym', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXGeneralItalic.ttf', name='STIXGeneral', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/cmss10.ttf', name='cmss10', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSerif-Italic.ttf', name='DejaVu Serif', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSans.ttf', name='DejaVu Sans', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 0.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXSizOneSymReg.ttf', name='STIXSizeOneSym', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/cmr10.ttf', name='cmr10', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/cmb10.ttf', name='cmb10', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXNonUniBolIta.ttf', name='STIXNonUnicode', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXNonUniIta.ttf', name='STIXNonUnicode', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXNonUni.ttf', name='STIXNonUnicode', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXSizThreeSymReg.ttf', name='STIXSizeThreeSym', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/cmtt10.ttf', name='cmtt10', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSansMono-Oblique.ttf', name='DejaVu Sans Mono', style='oblique', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSerif.ttf', name='DejaVu Serif', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXSizThreeSymBol.ttf', name='STIXSizeThreeSym', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXSizFourSymReg.ttf', name='STIXSizeFourSym', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXNonUniBol.ttf', name='STIXNonUnicode', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXGeneralBolIta.ttf', name='STIXGeneral', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/cmmi10.ttf', name='cmmi10', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSansDisplay.ttf', name='DejaVu Sans Display', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXSizTwoSymReg.ttf', name='STIXSizeTwoSym', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXSizFiveSymReg.ttf', name='STIXSizeFiveSym', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSans-Oblique.ttf', name='DejaVu Sans', style='oblique', variant='normal', weight=400, stretch='normal', size='scalable')) = 1.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/STIXGeneralBol.ttf', name='STIXGeneral', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSerif-BoldItalic.ttf', name='DejaVu Serif', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-ExtraLightIt.otf', name='Source Code Pro', style='italic', variant='normal', weight=200, stretch='normal', size='scalable')) = 11.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/P052-BoldItalic.otf', name='P052', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeSansOblique.otf', name='FreeSans', style='oblique', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/D050000L.otf', name='D050000L', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-Semibold.otf', name='Source Code Pro', style='normal', variant='normal', weight=600, stretch='normal', size='scalable')) = 10.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/Z003-MediumItalic.otf', name='Z003', style='italic', variant='normal', weight=500, stretch='normal', size='scalable')) = 11.145
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusRoman-BoldItalic.otf', name='Nimbus Roman', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSansMono-Bold.ttf', name='DejaVu Sans Mono', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusSansNarrow-Regular.otf', name='Nimbus Sans Narrow', style='normal', variant='normal', weight=400, stretch='condensed', size='scalable')) = 10.25
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeMonoBoldOblique.otf', name='FreeMono', style='oblique', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSerif.ttf', name='DejaVu Serif', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/C059-Bold.otf', name='C059', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/URWBookman-LightItalic.otf', name='URW Bookman', style='italic', variant='normal', weight=300, stretch='normal', size='scalable')) = 11.145
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-BoldIt.otf', name='Source Code Pro', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeSans.otf', name='FreeSans', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/URWGothic-BookOblique.otf', name='URW Gothic', style='oblique', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/C059-BdIta.otf', name='C059', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-MediumIt.otf', name='Source Code Pro', style='italic', variant='normal', weight=500, stretch='normal', size='scalable')) = 11.145
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/URWGothic-DemiOblique.otf', name='URW Gothic', style='oblique', variant='normal', weight=600, stretch='normal', size='scalable')) = 11.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusSansNarrow-BoldOblique.otf', name='Nimbus Sans Narrow', style='oblique', variant='normal', weight=700, stretch='condensed', size='scalable')) = 11.535
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-It.otf', name='Source Code Pro', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVu Sans Mono Bold Oblique for Powerline.ttf', name='DejaVu Sans Mono for Powerline', style='oblique', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSerif-BoldItalic.ttf', name='DejaVu Serif', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-Light.otf', name='Source Code Pro', style='normal', variant='normal', weight=300, stretch='normal', size='scalable')) = 10.145
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusMonoPS-BoldItalic.otf', name='Nimbus Mono PS', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-SemiboldIt.otf', name='Source Code Pro', style='italic', variant='normal', weight=600, stretch='normal', size='scalable')) = 11.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusRoman-Regular.otf', name='Nimbus Roman', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVu Sans Mono Bold for Powerline.ttf', name='DejaVu Sans Mono for Powerline', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSansCondensed.ttf', name='DejaVu Sans', style='normal', variant='normal', weight=400, stretch='condensed', size='scalable')) = 0.25
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/C059-Italic.otf', name='C059', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusMonoPS-Italic.otf', name='Nimbus Mono PS', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSansCondensed-Bold.ttf', name='DejaVu Sans', style='normal', variant='normal', weight=700, stretch='condensed', size='scalable')) = 0.5349999999999999
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVu Sans Mono for Powerline.ttf', name='DejaVu Sans Mono for Powerline', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/URWBookman-DemiItalic.otf', name='URW Bookman', style='italic', variant='normal', weight=600, stretch='normal', size='scalable')) = 11.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSansMono.ttf', name='DejaVu Sans Mono', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSerifCondensed-Italic.ttf', name='DejaVu Serif', style='italic', variant='normal', weight=400, stretch='condensed', size='scalable')) = 11.25
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSansCondensed-Oblique.ttf', name='DejaVu Sans', style='oblique', variant='normal', weight=400, stretch='condensed', size='scalable')) = 1.25
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/URWBookman-Demi.otf', name='URW Bookman', style='normal', variant='normal', weight=600, stretch='normal', size='scalable')) = 10.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/P052-Italic.otf', name='P052', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeSerifBold.otf', name='FreeSerif', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusSansNarrow-Oblique.otf', name='Nimbus Sans Narrow', style='oblique', variant='normal', weight=400, stretch='condensed', size='scalable')) = 11.25
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeMonoBold.otf', name='FreeMono', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSans-BoldOblique.ttf', name='DejaVu Sans', style='oblique', variant='normal', weight=700, stretch='normal', size='scalable')) = 1.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-Regular.otf', name='Source Code Pro', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeMono.otf', name='FreeMono', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/C059-Roman.otf', name='C059', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusSans-Regular.otf', name='Nimbus Sans', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeSerif.otf', name='FreeSerif', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/StandardSymbolsPS.otf', name='Standard Symbols PS', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusRoman-Italic.otf', name='Nimbus Roman', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusSans-Bold.otf', name='Nimbus Sans', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeSerifItalic.otf', name='FreeSerif', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusMonoPS-Regular.otf', name='Nimbus Mono PS', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-LightIt.otf', name='Source Code Pro', style='italic', variant='normal', weight=300, stretch='normal', size='scalable')) = 11.145
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSerifCondensed.ttf', name='DejaVu Serif', style='normal', variant='normal', weight=400, stretch='condensed', size='scalable')) = 10.25
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/URWBookman-Light.otf', name='URW Bookman', style='normal', variant='normal', weight=300, stretch='normal', size='scalable')) = 10.145
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSerif-Bold.ttf', name='DejaVu Serif', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/URWGothic-Book.otf', name='URW Gothic', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuMathTeXGyre.ttf', name='DejaVu Math TeX Gyre', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-Black.otf', name='Source Code Pro', style='normal', variant='normal', weight=900, stretch='normal', size='scalable')) = 10.525
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-BlackIt.otf', name='Source Code Pro', style='italic', variant='normal', weight=900, stretch='normal', size='scalable')) = 11.525
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/P052-Roman.otf', name='P052', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 10.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-ExtraLight.otf', name='Source Code Pro', style='normal', variant='normal', weight=200, stretch='normal', size='scalable')) = 10.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeSansBold.otf', name='FreeSans', style='normal', variant='normal', weight=600, stretch='normal', size='scalable')) = 10.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusMonoPS-Bold.otf', name='Nimbus Mono PS', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/URWGothic-Demi.otf', name='URW Gothic', style='normal', variant='normal', weight=600, stretch='normal', size='scalable')) = 10.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/P052-Bold.otf', name='P052', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeMonoOblique.otf', name='FreeMono', style='oblique', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSans-Oblique.ttf', name='DejaVu Sans', style='oblique', variant='normal', weight=400, stretch='normal', size='scalable')) = 1.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSans.ttf', name='DejaVu Sans', style='normal', variant='normal', weight=400, stretch='normal', size='scalable')) = 0.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSerifCondensed-Bold.ttf', name='DejaVu Serif', style='normal', variant='normal', weight=700, stretch='condensed', size='scalable')) = 10.535
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSans-Bold.ttf', name='DejaVu Sans', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 0.33499999999999996
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-Bold.otf', name='Source Code Pro', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSansCondensed-BoldOblique.ttf', name='DejaVu Sans', style='oblique', variant='normal', weight=700, stretch='condensed', size='scalable')) = 1.535
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeSansBoldOblique.otf', name='FreeSans', style='oblique', variant='normal', weight=600, stretch='normal', size='scalable')) = 11.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusRoman-Bold.otf', name='Nimbus Roman', style='normal', variant='normal', weight=700, stretch='normal', size='scalable')) = 10.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVu Sans Mono Oblique for Powerline.ttf', name='DejaVu Sans Mono for Powerline', style='oblique', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSansMono-BoldOblique.ttf', name='DejaVu Sans Mono', style='oblique', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSansMono-Oblique.ttf', name='DejaVu Sans Mono', style='oblique', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSerifCondensed-BoldItalic.ttf', name='DejaVu Serif', style='italic', variant='normal', weight=700, stretch='condensed', size='scalable')) = 11.535
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSerif-Italic.ttf', name='DejaVu Serif', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusSansNarrow-Bold.otf', name='Nimbus Sans Narrow', style='normal', variant='normal', weight=700, stretch='condensed', size='scalable')) = 10.535
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gnu-free/FreeSerifBoldItalic.otf', name='FreeSerif', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusSans-BoldItalic.otf', name='Nimbus Sans', style='italic', variant='normal', weight=700, stretch='normal', size='scalable')) = 11.335
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/TTF/DejaVuSans-ExtraLight.ttf', name='DejaVu Sans', style='normal', variant='normal', weight=200, stretch='normal', size='scalable')) = 0.24
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/adobe-source-code-pro/SourceCodePro-Medium.otf', name='Source Code Pro', style='normal', variant='normal', weight=500, stretch='normal', size='scalable')) = 10.145
DEBUG:matplotlib.font_manager:findfont: score(FontEntry(fname='/usr/share/fonts/gsfonts/NimbusSans-Italic.otf', name='Nimbus Sans', style='italic', variant='normal', weight=400, stretch='normal', size='scalable')) = 11.05
DEBUG:matplotlib.font_manager:findfont: Matching sans\-serif:style=normal:variant=normal:weight=normal:stretch=normal:size=10.0 to DejaVu Sans ('/var/lib/gitlab-runner/builds/vZ6vnZiU/1/ogs/build/release-petsc/.venv/lib/python3.12/site-packages/matplotlib/mpl-data/fonts/ttf/DejaVuSans.ttf') with score of 0.050000.
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmss10.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=52, nh=16, nd=11
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmp_vo9qbqo 034c697e4966133bcd6756494b8f530a.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./034c697e4966133bcd6756494b8f530a.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 034c697e4966133bcd6756494b8f530a.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmp_vo9qbqo/034c697e4966133bcd6756494b8f530a.aux) )\nOutput written on tmp_vo9qbqo/034c697e4966133bcd6756494b8f530a.dvi (1 page, 320\n bytes).\nTranscript written on tmp_vo9qbqo/034c697e4966133bcd6756494b8f530a.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmr10.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=36, nh=16, nd=10
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmmi10.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=98, nh=15, nd=9
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpykz724j4 2423c9cc8e1075dd3812c89f524ceaa9.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./2423c9cc8e1075dd3812c89f524ceaa9.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 2423c9cc8e1075dd3812c89f524ceaa9.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpykz724j4/2423c9cc8e1075dd3812c89f524ceaa9.aux) )\nOutput written on tmpykz724j4/2423c9cc8e1075dd3812c89f524ceaa9.dvi (1 page, 320\n bytes).\nTranscript written on tmpykz724j4/2423c9cc8e1075dd3812c89f524ceaa9.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmp_j59z9dz 6781b2b3fa4a8d051cd4be1ebfa6cf8b.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./6781b2b3fa4a8d051cd4be1ebfa6cf8b.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 6781b2b3fa4a8d051cd4be1ebfa6cf8b.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmp_j59z9dz/6781b2b3fa4a8d051cd4be1ebfa6cf8b.aux) )\nOutput written on tmp_j59z9dz/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi (1 page, 320\n bytes).\nTranscript written on tmp_j59z9dz/6781b2b3fa4a8d051cd4be1ebfa6cf8b.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpz3w2spsy e19591c58e6d033b61236446e1e642c8.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./e19591c58e6d033b61236446e1e642c8.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file e19591c58e6d033b61236446e1e642c8.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpz3w2spsy/e19591c58e6d033b61236446e1e642c8.aux) )\nOutput written on tmpz3w2spsy/e19591c58e6d033b61236446e1e642c8.dvi (1 page, 320\n bytes).\nTranscript written on tmpz3w2spsy/e19591c58e6d033b61236446e1e642c8.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpgzd_gwjs 50fdb2316153d1041cb27e8f7c31ee36.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./50fdb2316153d1041cb27e8f7c31ee36.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 50fdb2316153d1041cb27e8f7c31ee36.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpgzd_gwjs/50fdb2316153d1041cb27e8f7c31ee36.aux) )\nOutput written on tmpgzd_gwjs/50fdb2316153d1041cb27e8f7c31ee36.dvi (1 page, 320\n bytes).\nTranscript written on tmpgzd_gwjs/50fdb2316153d1041cb27e8f7c31ee36.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmprdkqqbmu a1d5dcbbea8fe443ea69f44b9cdd14fa.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./a1d5dcbbea8fe443ea69f44b9cdd14fa.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file a1d5dcbbea8fe443ea69f44b9cdd14fa.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmprdkqqbmu/a1d5dcbbea8fe443ea69f44b9cdd14fa.aux) )\nOutput written on tmprdkqqbmu/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi (1 page, 320\n bytes).\nTranscript written on tmprdkqqbmu/a1d5dcbbea8fe443ea69f44b9cdd14fa.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/0d/f2/0df2d513d139a1e7c0f94bf5728a067b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ee/19/ee1984d0ddaedebd6a44331208e5efb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/9e/6c9e852699a764721cc299f99eb90573.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/d0/d3/d0d3b0683482935c7a76065861ec9419.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/58/d9/58d9a487f5fba1c1e4c3f6b2207013e3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmplnxb2su7 98c9b8fe9f1d8697d86377fa8c62962d.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./98c9b8fe9f1d8697d86377fa8c62962d.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 98c9b8fe9f1d8697d86377fa8c62962d.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmplnxb2su7/98c9b8fe9f1d8697d86377fa8c62962d.aux) )\nOutput written on tmplnxb2su7/98c9b8fe9f1d8697d86377fa8c62962d.dvi (1 page, 324\n bytes).\nTranscript written on tmplnxb2su7/98c9b8fe9f1d8697d86377fa8c62962d.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/98/c9/98c9b8fe9f1d8697d86377fa8c62962d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpml7pqayl 38a03fcf6b2abfae72206b2821a254ec.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./38a03fcf6b2abfae72206b2821a254ec.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 38a03fcf6b2abfae72206b2821a254ec.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpml7pqayl/38a03fcf6b2abfae72206b2821a254ec.aux) )\nOutput written on tmpml7pqayl/38a03fcf6b2abfae72206b2821a254ec.dvi (1 page, 324\n bytes).\nTranscript written on tmpml7pqayl/38a03fcf6b2abfae72206b2821a254ec.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/38/a0/38a03fcf6b2abfae72206b2821a254ec.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmp2jl43l6j 5356f6f7196cf08a8335bf6cc9a7c454.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./5356f6f7196cf08a8335bf6cc9a7c454.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 5356f6f7196cf08a8335bf6cc9a7c454.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmp2jl43l6j/5356f6f7196cf08a8335bf6cc9a7c454.aux) )\nOutput written on tmp2jl43l6j/5356f6f7196cf08a8335bf6cc9a7c454.dvi (1 page, 284\n bytes).\nTranscript written on tmp2jl43l6j/5356f6f7196cf08a8335bf6cc9a7c454.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/53/56/5356f6f7196cf08a8335bf6cc9a7c454.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpjgvrpnsq bf240be4a9021e8c1393fe8d0b8f1329.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./bf240be4a9021e8c1393fe8d0b8f1329.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file bf240be4a9021e8c1393fe8d0b8f1329.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpjgvrpnsq/bf240be4a9021e8c1393fe8d0b8f1329.aux) )\nOutput written on tmpjgvrpnsq/bf240be4a9021e8c1393fe8d0b8f1329.dvi (1 page, 324\n bytes).\nTranscript written on tmpjgvrpnsq/bf240be4a9021e8c1393fe8d0b8f1329.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/bf/24/bf240be4a9021e8c1393fe8d0b8f1329.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpyh4h7ge9 1058d68597241efabb1c30acb7ced2fe.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./1058d68597241efabb1c30acb7ced2fe.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 1058d68597241efabb1c30acb7ced2fe.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpyh4h7ge9/1058d68597241efabb1c30acb7ced2fe.aux) )\nOutput written on tmpyh4h7ge9/1058d68597241efabb1c30acb7ced2fe.dvi (1 page, 324\n bytes).\nTranscript written on tmpyh4h7ge9/1058d68597241efabb1c30acb7ced2fe.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/10/58/1058d68597241efabb1c30acb7ced2fe.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpfdatyc2o 04fdbbcb8f92afdecb76d256e1af3f20.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./04fdbbcb8f92afdecb76d256e1af3f20.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 04fdbbcb8f92afdecb76d256e1af3f20.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpfdatyc2o/04fdbbcb8f92afdecb76d256e1af3f20.aux) )\nOutput written on tmpfdatyc2o/04fdbbcb8f92afdecb76d256e1af3f20.dvi (1 page, 324\n bytes).\nTranscript written on tmpfdatyc2o/04fdbbcb8f92afdecb76d256e1af3f20.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/04/fd/04fdbbcb8f92afdecb76d256e1af3f20.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpwgu248yh 626babd3a81b99474d0b9387c6a8eb6e.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./626babd3a81b99474d0b9387c6a8eb6e.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 626babd3a81b99474d0b9387c6a8eb6e.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpwgu248yh/626babd3a81b99474d0b9387c6a8eb6e.aux) )\nOutput written on tmpwgu248yh/626babd3a81b99474d0b9387c6a8eb6e.dvi (1 page, 324\n bytes).\nTranscript written on tmpwgu248yh/626babd3a81b99474d0b9387c6a8eb6e.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/62/6b/626babd3a81b99474d0b9387c6a8eb6e.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpoa0222b8 81840467551e1b4b6964a499a81a6307.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./81840467551e1b4b6964a499a81a6307.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 81840467551e1b4b6964a499a81a6307.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpoa0222b8/81840467551e1b4b6964a499a81a6307.aux) )\nOutput written on tmpoa0222b8/81840467551e1b4b6964a499a81a6307.dvi (1 page, 324\n bytes).\nTranscript written on tmpoa0222b8/81840467551e1b4b6964a499a81a6307.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/81/84/81840467551e1b4b6964a499a81a6307.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmptlplk0up 2dfa0742d09d2bfe85c305cad87331d8.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./2dfa0742d09d2bfe85c305cad87331d8.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 2dfa0742d09d2bfe85c305cad87331d8.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmptlplk0up/2dfa0742d09d2bfe85c305cad87331d8.aux) )\nOutput written on tmptlplk0up/2dfa0742d09d2bfe85c305cad87331d8.dvi (1 page, 324\n bytes).\nTranscript written on tmptlplk0up/2dfa0742d09d2bfe85c305cad87331d8.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/2d/fa/2dfa0742d09d2bfe85c305cad87331d8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpiqahxmni ed1d00a258c972d134884da110881fbf.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./ed1d00a258c972d134884da110881fbf.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file ed1d00a258c972d134884da110881fbf.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpiqahxmni/ed1d00a258c972d134884da110881fbf.aux) )\nOutput written on tmpiqahxmni/ed1d00a258c972d134884da110881fbf.dvi (1 page, 288\n bytes).\nTranscript written on tmpiqahxmni/ed1d00a258c972d134884da110881fbf.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ed/1d/ed1d00a258c972d134884da110881fbf.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpdt204ub0 e7241d0ecc11116875082b13d9e87d37.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./e7241d0ecc11116875082b13d9e87d37.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file e7241d0ecc11116875082b13d9e87d37.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpdt204ub0/e7241d0ecc11116875082b13d9e87d37.aux) )\nOutput written on tmpdt204ub0/e7241d0ecc11116875082b13d9e87d37.dvi (1 page, 292\n bytes).\nTranscript written on tmpdt204ub0/e7241d0ecc11116875082b13d9e87d37.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e7/24/e7241d0ecc11116875082b13d9e87d37.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmp2p4cue31 e6b2df9426ecfda989ec2dcbc47651a5.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./e6b2df9426ecfda989ec2dcbc47651a5.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file e6b2df9426ecfda989ec2dcbc47651a5.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmp2p4cue31/e6b2df9426ecfda989ec2dcbc47651a5.aux) )\nOutput written on tmp2p4cue31/e6b2df9426ecfda989ec2dcbc47651a5.dvi (1 page, 284\n bytes).\nTranscript written on tmp2p4cue31/e6b2df9426ecfda989ec2dcbc47651a5.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e6/b2/e6b2df9426ecfda989ec2dcbc47651a5.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpgteaf7zx 9272783e54504806bd4ffa845a9e9693.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./9272783e54504806bd4ffa845a9e9693.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 9272783e54504806bd4ffa845a9e9693.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpgteaf7zx/9272783e54504806bd4ffa845a9e9693.aux) )\nOutput written on tmpgteaf7zx/9272783e54504806bd4ffa845a9e9693.dvi (1 page, 340\n bytes).\nTranscript written on tmpgteaf7zx/9272783e54504806bd4ffa845a9e9693.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/92/72/9272783e54504806bd4ffa845a9e9693.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmmi7.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=98, nh=15, nd=9
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/db/4d/db4d5952387611c107afe7f60b9dfb1b.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 45
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 98 14
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 124 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 145 98
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/55/0c/550c6ba7b6cccb088396c2e4f95f9fd3.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 98
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/40/48/40485b8a59067fcf1aecd9991e0fcb23.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 94
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/c0/97/c097c09006997556b9a94cdc1a4ee662.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 100
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/c9/5d/c95d3cfcbce08d9af850a655c72bd96d.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 101
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/26/3f/263f50403736fbbec1f6ae9afba1715d.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 45
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 98 14
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 124 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 145 77
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/0d/f2/0df2d513d139a1e7c0f94bf5728a067b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ee/19/ee1984d0ddaedebd6a44331208e5efb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/9e/6c9e852699a764721cc299f99eb90573.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/d0/d3/d0d3b0683482935c7a76065861ec9419.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/58/d9/58d9a487f5fba1c1e4c3f6b2207013e3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/98/c9/98c9b8fe9f1d8697d86377fa8c62962d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/38/a0/38a03fcf6b2abfae72206b2821a254ec.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 45
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 98 14
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 124 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 145 110
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/0d/f2/0df2d513d139a1e7c0f94bf5728a067b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 135
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ee/19/ee1984d0ddaedebd6a44331208e5efb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 45
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 98 14
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 124 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 145 98
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/9e/6c9e852699a764721cc299f99eb90573.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 120
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/d0/d3/d0d3b0683482935c7a76065861ec9419.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 111
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/58/d9/58d9a487f5fba1c1e4c3f6b2207013e3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/77/90/779019540464b26bfb7729177473e1d2.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/98/c9/98c9b8fe9f1d8697d86377fa8c62962d.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 136
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/98/c9/98c9b8fe9f1d8697d86377fa8c62962d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/bc/69/bc696d1d1f364b98ae5cc5eb2d448abd.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/38/a0/38a03fcf6b2abfae72206b2821a254ec.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 110
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/38/a0/38a03fcf6b2abfae72206b2821a254ec.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/53/56/5356f6f7196cf08a8335bf6cc9a7c454.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/65/6c65f40749cc143608a75c440cb52392.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/53/56/5356f6f7196cf08a8335bf6cc9a7c454.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 174
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/53/56/5356f6f7196cf08a8335bf6cc9a7c454.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/bf/24/bf240be4a9021e8c1393fe8d0b8f1329.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/10/58/1058d68597241efabb1c30acb7ced2fe.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/04/fd/04fdbbcb8f92afdecb76d256e1af3f20.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/62/6b/626babd3a81b99474d0b9387c6a8eb6e.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/81/84/81840467551e1b4b6964a499a81a6307.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/2d/fa/2dfa0742d09d2bfe85c305cad87331d8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/5d/81/5d8105cccd6acb8a7ebadc0aea2d5f2f.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/bf/24/bf240be4a9021e8c1393fe8d0b8f1329.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 136
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/bf/24/bf240be4a9021e8c1393fe8d0b8f1329.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/29/78/2978b3527b3788f157c4cc7cc932220c.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/10/58/1058d68597241efabb1c30acb7ced2fe.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 134
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/10/58/1058d68597241efabb1c30acb7ced2fe.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/9e/6c9e852699a764721cc299f99eb90573.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/cc/3b/cc3b6e0f34b877d0fb89727af1a3c1e4.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/04/fd/04fdbbcb8f92afdecb76d256e1af3f20.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 121
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/04/fd/04fdbbcb8f92afdecb76d256e1af3f20.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ae/b6/aeb605b2d4a4107130475d56d1f2a5e4.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/62/6b/626babd3a81b99474d0b9387c6a8eb6e.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 114
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/62/6b/626babd3a81b99474d0b9387c6a8eb6e.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/ba/24ba817dd9e158374b86d21c85210569.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/81/84/81840467551e1b4b6964a499a81a6307.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 122
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/81/84/81840467551e1b4b6964a499a81a6307.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/c5/e4/c5e472f31fcebf28a93e14d3c93aa2b1.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/2d/fa/2dfa0742d09d2bfe85c305cad87331d8.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 122
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/2d/fa/2dfa0742d09d2bfe85c305cad87331d8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ed/1d/ed1d00a258c972d134884da110881fbf.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/d0/ef/d0ef6b8d875d535253e5a5d49fb43df8.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ed/1d/ed1d00a258c972d134884da110881fbf.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 290
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ed/1d/ed1d00a258c972d134884da110881fbf.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e7/24/e7241d0ecc11116875082b13d9e87d37.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e6/b2/e6b2df9426ecfda989ec2dcbc47651a5.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/3e/7c/3e7c9fc123f323d422d8d7935adccb48.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e7/24/e7241d0ecc11116875082b13d9e87d37.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 226
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e7/24/e7241d0ecc11116875082b13d9e87d37.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/4c/f8/4cf869e4fb75684e33f07d1e823639c2.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e6/b2/e6b2df9426ecfda989ec2dcbc47651a5.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 229
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e6/b2/e6b2df9426ecfda989ec2dcbc47651a5.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/0d/f2/0df2d513d139a1e7c0f94bf5728a067b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ee/19/ee1984d0ddaedebd6a44331208e5efb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/9e/6c9e852699a764721cc299f99eb90573.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/d0/d3/d0d3b0683482935c7a76065861ec9419.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/58/d9/58d9a487f5fba1c1e4c3f6b2207013e3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/98/c9/98c9b8fe9f1d8697d86377fa8c62962d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/38/a0/38a03fcf6b2abfae72206b2821a254ec.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/53/56/5356f6f7196cf08a8335bf6cc9a7c454.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/92/72/9272783e54504806bd4ffa845a9e9693.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/23/ac/23ac7cef4d2af02f481b96e464add427.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/92/72/9272783e54504806bd4ffa845a9e9693.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 45
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 98 14
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 124 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 145 182
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/92/72/9272783e54504806bd4ffa845a9e9693.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e7/24/e7241d0ecc11116875082b13d9e87d37.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e6/b2/e6b2df9426ecfda989ec2dcbc47651a5.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt

png

plt.subplots(figsize=(12, 4))(click to toggle)
plt.subplots(figsize=(12, 4))
plt.subplot(1, 2, 1)
plt.grid(linestyle="dashed")
plt.plot(
    fluidVolume_analytical[1:],
    (
        abs(length_analytical[1:] - np.array(surface_energy[:]) / (2 * Gc_ref))
        / (np.array(surface_energy[:]) / (2 * Gc_ref))
    )
    * 100,
    "-.ob",
    fillstyle="none",
    label="Closed form",
)
plt.ylim([0.0, 10])
plt.xlabel("Volume")
plt.ylabel(
    r"$\frac{|a_\mathrm{num}-{a}_\mathrm{ana}|}{{a}_\mathrm{num}}\times 100\%$",
    fontsize=14,
)

plt.subplot(1, 2, 2)
plt.grid(linestyle="dashed")
plt.plot(
    fluidVolume_analytical[1:],
    (abs(pressure_analytical[1:] - np.array(pressure[:]) / P_c) / pressure[:]) * 100,
    "-.<g",
    fillstyle="none",
    label="Closed form",
)
plt.ylim([0.0, 10])
plt.xlabel("Volume")
plt.ylabel(
    r"$\frac{|p_\mathrm{num}-{p}_\mathrm{ana}|}{{p}_\mathrm{num}}\times 100\%$",
    fontsize=14,
)
plt.show()
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/0d/f2/0df2d513d139a1e7c0f94bf5728a067b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ee/19/ee1984d0ddaedebd6a44331208e5efb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/9e/6c9e852699a764721cc299f99eb90573.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/d0/d3/d0d3b0683482935c7a76065861ec9419.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/58/d9/58d9a487f5fba1c1e4c3f6b2207013e3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/98/c9/98c9b8fe9f1d8697d86377fa8c62962d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/38/a0/38a03fcf6b2abfae72206b2821a254ec.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/53/56/5356f6f7196cf08a8335bf6cc9a7c454.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmp6cjcj3gq 4cf178168dad8deab6cc568ca016e994.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./4cf178168dad8deab6cc568ca016e994.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 4cf178168dad8deab6cc568ca016e994.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmp6cjcj3gq/4cf178168dad8deab6cc568ca016e994.aux) )\nOutput written on tmp6cjcj3gq/4cf178168dad8deab6cc568ca016e994.dvi (1 page, 272\n bytes).\nTranscript written on tmp6cjcj3gq/4cf178168dad8deab6cc568ca016e994.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/4c/f1/4cf178168dad8deab6cc568ca016e994.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpknl002i7 3474246c5667a1943923141978d23c3a.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./3474246c5667a1943923141978d23c3a.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 3474246c5667a1943923141978d23c3a.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpknl002i7/3474246c5667a1943923141978d23c3a.aux) )\nOutput written on tmpknl002i7/3474246c5667a1943923141978d23c3a.dvi (1 page, 272\n bytes).\nTranscript written on tmpknl002i7/3474246c5667a1943923141978d23c3a.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/34/74/3474246c5667a1943923141978d23c3a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpc2hcfb38 84e5bc723afbadf8c0b55a9f33281fe1.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./84e5bc723afbadf8c0b55a9f33281fe1.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 84e5bc723afbadf8c0b55a9f33281fe1.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpc2hcfb38/84e5bc723afbadf8c0b55a9f33281fe1.aux) )\nOutput written on tmpc2hcfb38/84e5bc723afbadf8c0b55a9f33281fe1.dvi (1 page, 272\n bytes).\nTranscript written on tmpc2hcfb38/84e5bc723afbadf8c0b55a9f33281fe1.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/e5/84e5bc723afbadf8c0b55a9f33281fe1.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmperqxoh2z 5072e23f5e5ce59679a8b62884de426d.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./5072e23f5e5ce59679a8b62884de426d.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 5072e23f5e5ce59679a8b62884de426d.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmperqxoh2z/5072e23f5e5ce59679a8b62884de426d.aux) )\nOutput written on tmperqxoh2z/5072e23f5e5ce59679a8b62884de426d.dvi (1 page, 272\n bytes).\nTranscript written on tmperqxoh2z/5072e23f5e5ce59679a8b62884de426d.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/72/5072e23f5e5ce59679a8b62884de426d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpr76i2l72 f2c6ad0f02cef9e8a87728106b9ccd29.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./f2c6ad0f02cef9e8a87728106b9ccd29.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file f2c6ad0f02cef9e8a87728106b9ccd29.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpr76i2l72/f2c6ad0f02cef9e8a87728106b9ccd29.aux) )\nOutput written on tmpr76i2l72/f2c6ad0f02cef9e8a87728106b9ccd29.dvi (1 page, 272\n bytes).\nTranscript written on tmpr76i2l72/f2c6ad0f02cef9e8a87728106b9ccd29.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/f2/c6/f2c6ad0f02cef9e8a87728106b9ccd29.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpyfiw8fw6 7c8fc8fee5ab82aeeaf6dd954cd5feb3.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./7c8fc8fee5ab82aeeaf6dd954cd5feb3.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 7c8fc8fee5ab82aeeaf6dd954cd5feb3.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpyfiw8fw6/7c8fc8fee5ab82aeeaf6dd954cd5feb3.aux) )\nOutput written on tmpyfiw8fw6/7c8fc8fee5ab82aeeaf6dd954cd5feb3.dvi (1 page, 276\n bytes).\nTranscript written on tmpyfiw8fw6/7c8fc8fee5ab82aeeaf6dd954cd5feb3.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/7c/8f/7c8fc8fee5ab82aeeaf6dd954cd5feb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/2d/84/2d84808fb62fe6c38d400d3ac2dda4e0.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmss12.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=54, nh=16, nd=11
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmp2xxrmcdd f220c92d0fd525a92de14ff835c5c109.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./f220c92d0fd525a92de14ff835c5c109.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file f220c92d0fd525a92de14ff835c5c109.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmp2xxrmcdd/f220c92d0fd525a92de14ff835c5c109.aux) )\nOutput written on tmp2xxrmcdd/f220c92d0fd525a92de14ff835c5c109.dvi (1 page, 548\n bytes).\nTranscript written on tmp2xxrmcdd/f220c92d0fd525a92de14ff835c5c109.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/f2/20/f220c92d0fd525a92de14ff835c5c109.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmsy9.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=43, nh=15, nd=15
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmmi9.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=97, nh=15, nd=9
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmr7.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=38, nh=16, nd=9
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmsy10.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=44, nh=15, nd=16
DEBUG:matplotlib.dviread:opening tfm file /usr/share/texmf-dist/fonts/tfm/public/cm/cmr12.tfm
DEBUG:matplotlib.dviread:lh=18, bc=0, ec=127, nw=34, nh=16, nd=10
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:latex -interaction=nonstopmode --halt-on-error --output-directory=tmpcf8h3emt 1dd7b3300f8b60957054f1a3f1e897a3.tex
DEBUG:matplotlib.texmanager:b'This is pdfTeX, Version 3.141592653-2.6-1.40.26 (TeX Live 2024/Arch Linux) (preloaded format=latex)\n restricted \\write18 enabled.\nentering extended mode\n(./1dd7b3300f8b60957054f1a3f1e897a3.tex\nLaTeX2e <2023-11-01> patch level 1\nL3 programming layer <2024-02-20>\n(/usr/share/texmf-dist/tex/latex/base/article.cls\nDocument Class: article 2023/05/17 v1.4n Standard LaTeX document class\n(/usr/share/texmf-dist/tex/latex/base/size10.clo))\n(/usr/share/texmf-dist/tex/latex/type1cm/type1cm.sty)\n(/usr/share/texmf-dist/tex/latex/cm-super/type1ec.sty\n(/usr/share/texmf-dist/tex/latex/base/t1cmr.fd))\n(/usr/share/texmf-dist/tex/latex/base/inputenc.sty)\n(/usr/share/texmf-dist/tex/latex/geometry/geometry.sty\n(/usr/share/texmf-dist/tex/latex/graphics/keyval.sty)\n(/usr/share/texmf-dist/tex/generic/iftex/ifvtex.sty\n(/usr/share/texmf-dist/tex/generic/iftex/iftex.sty)))\n(/usr/share/texmf-dist/tex/latex/underscore/underscore.sty)\n(/usr/share/texmf-dist/tex/latex/firstaid/underscore-ltx.sty)\n(/usr/share/texmf-dist/tex/latex/base/textcomp.sty)\n(/usr/share/texmf-dist/tex/latex/l3backend/l3backend-dvips.def)\nNo file 1dd7b3300f8b60957054f1a3f1e897a3.aux.\n*geometry* driver: auto-detecting\n*geometry* detected driver: dvips\n[1] (tmpcf8h3emt/1dd7b3300f8b60957054f1a3f1e897a3.aux) )\nOutput written on tmpcf8h3emt/1dd7b3300f8b60957054f1a3f1e897a3.dvi (1 page, 548\n bytes).\nTranscript written on tmpcf8h3emt/1dd7b3300f8b60957054f1a3f1e897a3.log.\n'
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/1d/d7/1dd7b3300f8b60957054f1a3f1e897a3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/4f/844f707e0917555faafa721cd5105dbd.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/03/4c/034c697e4966133bcd6756494b8f530a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/24/23/2423c9cc8e1075dd3812c89f524ceaa9.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/67/81/6781b2b3fa4a8d051cd4be1ebfa6cf8b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/e1/95/e19591c58e6d033b61236446e1e642c8.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/fd/50fdb2316153d1041cb27e8f7c31ee36.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/a1/d5/a1d5dcbbea8fe443ea69f44b9cdd14fa.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/0d/f2/0df2d513d139a1e7c0f94bf5728a067b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ee/19/ee1984d0ddaedebd6a44331208e5efb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/9e/6c9e852699a764721cc299f99eb90573.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/d0/d3/d0d3b0683482935c7a76065861ec9419.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/58/d9/58d9a487f5fba1c1e4c3f6b2207013e3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/98/c9/98c9b8fe9f1d8697d86377fa8c62962d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/38/a0/38a03fcf6b2abfae72206b2821a254ec.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/0d/f2/0df2d513d139a1e7c0f94bf5728a067b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ee/19/ee1984d0ddaedebd6a44331208e5efb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/9e/6c9e852699a764721cc299f99eb90573.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/d0/d3/d0d3b0683482935c7a76065861ec9419.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/58/d9/58d9a487f5fba1c1e4c3f6b2207013e3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/98/c9/98c9b8fe9f1d8697d86377fa8c62962d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/38/a0/38a03fcf6b2abfae72206b2821a254ec.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/53/56/5356f6f7196cf08a8335bf6cc9a7c454.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/53/56/5356f6f7196cf08a8335bf6cc9a7c454.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/4c/f1/4cf178168dad8deab6cc568ca016e994.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/34/74/3474246c5667a1943923141978d23c3a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/e5/84e5bc723afbadf8c0b55a9f33281fe1.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/72/5072e23f5e5ce59679a8b62884de426d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/f2/c6/f2c6ad0f02cef9e8a87728106b9ccd29.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/7c/8f/7c8fc8fee5ab82aeeaf6dd954cd5feb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ac/02/ac02a42ba630a2e1674673907131c972.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/4c/f1/4cf178168dad8deab6cc568ca016e994.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 45
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 98 14
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 124 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 145 53
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/4c/f1/4cf178168dad8deab6cc568ca016e994.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/94/a3/94a3a37ed6882f8b8832e95989276539.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/34/74/3474246c5667a1943923141978d23c3a.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 54
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/34/74/3474246c5667a1943923141978d23c3a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/1e/e7/1ee7052f2795476bc1657ae924119c17.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/e5/84e5bc723afbadf8c0b55a9f33281fe1.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 36
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 89 11
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 112 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 133 46
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/e5/84e5bc723afbadf8c0b55a9f33281fe1.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/5c/0e/5c0e17f23221ae3af4b35b05b197894a.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/72/5072e23f5e5ce59679a8b62884de426d.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 39
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 92 12
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 116 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 137 55
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/72/5072e23f5e5ce59679a8b62884de426d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/8a/62/8a621bf929eb0235d591fef1eca49efa.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/f2/c6/f2c6ad0f02cef9e8a87728106b9ccd29.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 42
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 95 13
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 120 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 141 54
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/f2/c6/f2c6ad0f02cef9e8a87728106b9ccd29.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/83/e5/83e5920c278f8ffef0b0a9d1b95b13c3.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/7c/8f/7c8fc8fee5ab82aeeaf6dd954cd5feb3.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 45
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 98 14
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 124 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 145 70
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/7c/8f/7c8fc8fee5ab82aeeaf6dd954cd5feb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/2d/84/2d84808fb62fe6c38d400d3ac2dda4e0.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/f2/20/f220c92d0fd525a92de14ff835c5c109.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/96/bc/96bcb7bcc02d360b867814c5ec33eaf6.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/f2/20/f220c92d0fd525a92de14ff835c5c109.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 591
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/f2/20/f220c92d0fd525a92de14ff835c5c109.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/0d/f2/0df2d513d139a1e7c0f94bf5728a067b.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/ee/19/ee1984d0ddaedebd6a44331208e5efb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/6c/9e/6c9e852699a764721cc299f99eb90573.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/d0/d3/d0d3b0683482935c7a76065861ec9419.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/58/d9/58d9a487f5fba1c1e4c3f6b2207013e3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/98/c9/98c9b8fe9f1d8697d86377fa8c62962d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/38/a0/38a03fcf6b2abfae72206b2821a254ec.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/53/56/5356f6f7196cf08a8335bf6cc9a7c454.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/4c/f1/4cf178168dad8deab6cc568ca016e994.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/34/74/3474246c5667a1943923141978d23c3a.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/84/e5/84e5bc723afbadf8c0b55a9f33281fe1.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/50/72/5072e23f5e5ce59679a8b62884de426d.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/f2/c6/f2c6ad0f02cef9e8a87728106b9ccd29.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/7c/8f/7c8fc8fee5ab82aeeaf6dd954cd5feb3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/1d/d7/1dd7b3300f8b60957054f1a3f1e897a3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.texmanager:dvipng -bg Transparent -D 100.0 -T tight -o /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/95/d1/95d1017416a7293118900a87d7e83cfd.png /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/1d/d7/1dd7b3300f8b60957054f1a3f1e897a3.dvi
DEBUG:matplotlib.texmanager:b'This is dvipng 1.17 Copyright 2002-2015, 2019 Jan-Ake Larsson\n[1] \n'
DEBUG:PIL.PngImagePlugin:STREAM b'IHDR' 16 13
DEBUG:PIL.PngImagePlugin:STREAM b'PLTE' 41 48
DEBUG:PIL.PngImagePlugin:STREAM b'tRNS' 101 15
DEBUG:PIL.PngImagePlugin:STREAM b'pHYs' 128 9
DEBUG:PIL.PngImagePlugin:STREAM b'IDAT' 149 576
DEBUG:matplotlib.texmanager:family: serif, package: \usepackage{type1ec}, font: Computer Modern Roman, skipped: DejaVu Serif, Bitstream Vera Serif
DEBUG:matplotlib.texmanager:family: sans-serif, package: \usepackage{type1ec}, font: Computer Modern Sans Serif, skipped: DejaVu Sans, Bitstream Vera Sans
DEBUG:matplotlib.texmanager:family: cursive, package: \usepackage{chancery}, font: Zapf Chancery, skipped: Apple Chancery, Textile
DEBUG:matplotlib.texmanager:family: monospace, package: \usepackage{type1ec}, font: Computer Modern Typewriter, skipped: DejaVu Sans Mono, Bitstream Vera Sans Mono
DEBUG:matplotlib.dviread:Dvi: /var/lib/gitlab-runner/.cache/matplotlib/tex.cache/1d/d7/1dd7b3300f8b60957054f1a3f1e897a3.dvi
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: header=l3backend-dvips.pro
DEBUG:matplotlib.dviread:Dvi._xxx: encountered special: papersize=5203.43999pt,5203.43999pt

png

In order to reduce computation time, we perform the simulation with a coarse mesh; the results for the $\texttt{AT}_1$ Model with a mesh size of $h=0.001$ are provided below.

$\texttt{AT}_1$ Model:

Phase field versus analytical solution for fracture length and pressure evolution
Phase field versus analytical solution for fracture length and pressure evolution, $\texttt{AT}_1$.

Error between the Phase field and analytical solution for fracture length and pressure evolution.
Error between the Phase field and analytical solution for fracture length and pressure evolution, $\texttt{AT}_1$.

Hydraulic Fracturing Animation (Using Phase Field Approach)

filename = f"results_h_{h:0.4f}_{phasefield_model}"(click to toggle)
filename = f"results_h_{h:0.4f}_{phasefield_model}"
reader = pv.get_reader(f"{out_dir}/" + filename + ".pvd")

plotter = pv.Plotter(shape=(1, 2), border=False)
plotter.open_gif(f"{out_dir}/Kregime_Propagating.gif")
for time_value in reader.time_values:
    reader.set_active_time_value(time_value)
    mesh = reader.read()[0]
    sargs = {
        "title": "Phase field",
        "title_font_size": 16,
        "label_font_size": 12,
        "n_labels": 5,
        "position_x": 0.25,
        "position_y": 0.15,
        "fmt": "%.1f",
        "width": 0.5,
    }
    p = pv.Plotter(shape=(1, 2), border=False)
    clim = [0, 1.0]
    points = mesh.point_data["phasefield"].shape[0]
    xs = mesh.points[:, 0]
    ys = mesh.points[:, 1]
    pf = mesh.point_data["phasefield"]
    plotter.clear()
    plotter.add_mesh(
        mesh,
        scalars=pf,
        show_scalar_bar=True,
        colormap="coolwarm",
        clim=clim,
        scalar_bar_args=sargs,
        lighting=False,
    )
    plotter.add_text(f"Time: {time_value:0.02f}", color="black")

    plotter.view_xy()
    plotter.write_frame()

plotter.close()
DEBUG:PIL.Image:Importing BlpImagePlugin
DEBUG:PIL.Image:Importing BmpImagePlugin
DEBUG:PIL.Image:Importing BufrStubImagePlugin
DEBUG:PIL.Image:Importing CurImagePlugin
DEBUG:PIL.Image:Importing DcxImagePlugin
DEBUG:PIL.Image:Importing DdsImagePlugin
DEBUG:PIL.Image:Importing EpsImagePlugin
DEBUG:PIL.Image:Importing FitsImagePlugin
DEBUG:PIL.Image:Importing FliImagePlugin
DEBUG:PIL.Image:Importing FpxImagePlugin
DEBUG:PIL.Image:Image: failed to import FpxImagePlugin: No module named 'olefile'
DEBUG:PIL.Image:Importing FtexImagePlugin
DEBUG:PIL.Image:Importing GbrImagePlugin
DEBUG:PIL.Image:Importing GifImagePlugin
DEBUG:PIL.Image:Importing GribStubImagePlugin
DEBUG:PIL.Image:Importing Hdf5StubImagePlugin
DEBUG:PIL.Image:Importing IcnsImagePlugin
DEBUG:PIL.Image:Importing IcoImagePlugin
DEBUG:PIL.Image:Importing ImImagePlugin
DEBUG:PIL.Image:Importing ImtImagePlugin
DEBUG:PIL.Image:Importing IptcImagePlugin
DEBUG:PIL.Image:Importing JpegImagePlugin
DEBUG:PIL.Image:Importing Jpeg2KImagePlugin
DEBUG:PIL.Image:Importing McIdasImagePlugin
DEBUG:PIL.Image:Importing MicImagePlugin
DEBUG:PIL.Image:Image: failed to import MicImagePlugin: No module named 'olefile'
DEBUG:PIL.Image:Importing MpegImagePlugin
DEBUG:PIL.Image:Importing MpoImagePlugin
DEBUG:PIL.Image:Importing MspImagePlugin
DEBUG:PIL.Image:Importing PalmImagePlugin
DEBUG:PIL.Image:Importing PcdImagePlugin
DEBUG:PIL.Image:Importing PcxImagePlugin
DEBUG:PIL.Image:Importing PdfImagePlugin
DEBUG:PIL.Image:Importing PixarImagePlugin
DEBUG:PIL.Image:Importing PngImagePlugin
DEBUG:PIL.Image:Importing PpmImagePlugin
DEBUG:PIL.Image:Importing PsdImagePlugin
DEBUG:PIL.Image:Importing QoiImagePlugin
DEBUG:PIL.Image:Importing SgiImagePlugin
DEBUG:PIL.Image:Importing SpiderImagePlugin
DEBUG:PIL.Image:Importing SunImagePlugin
DEBUG:PIL.Image:Importing TgaImagePlugin
DEBUG:PIL.Image:Importing TiffImagePlugin
DEBUG:PIL.Image:Importing WebPImagePlugin
DEBUG:PIL.Image:Importing WmfImagePlugin
DEBUG:PIL.Image:Importing XbmImagePlugin
DEBUG:PIL.Image:Importing XpmImagePlugin
DEBUG:PIL.Image:Importing XVThumbImagePlugin

Phase Field Profile at Last Time Step

mesh = reader.read()[0](click to toggle)
mesh = reader.read()[0]

points = mesh.point_data["phasefield"].shape[0]
xs = mesh.points[:, 0]
ys = mesh.points[:, 1]
pf = mesh.point_data["phasefield"]

clim = [0, 1.0]
sargs = {
    "title": "Phase field",
    "title_font_size": 16,
    "label_font_size": 12,
    "n_labels": 5,
    "position_x": 0.25,
    "position_y": 0.0,
    "fmt": "%.1f",
    "width": 0.5,
}
plotter = pv.Plotter(shape=(1, 2), border=False)
plotter.add_mesh(
    mesh,
    scalars=pf,
    show_edges=False,
    show_scalar_bar=True,
    colormap="coolwarm",
    clim=clim,
    scalar_bar_args=sargs,
    lighting=False,
)

plotter.view_xy()
plotter.camera.zoom(1.5)
plotter.window_size = [1000, 500]
plotter.show()
INFO:trame_server.utils.namespace:Translator(prefix=None)
INFO:wslink.backends.aiohttp:awaiting runner setup
INFO:wslink.backends.aiohttp:awaiting site startup
DEBUG:pyvista.trame.jupyter:Server ready: <trame_server.core.Server object at 0x761ca805fb30>
INFO:wslink.backends.aiohttp:Print WSLINK_READY_MSG
INFO:wslink.backends.aiohttp:Schedule auto shutdown with timout 0
INFO:wslink.backends.aiohttp:awaiting running future
INFO:trame_server.controller:trigger(trigger__1)
INFO:trame_server.controller:trigger(trigger__2)
INFO:trame_server.controller:trigger(P_0x761caa1fde20_31Camera)
INFO:trame_server.controller:trigger(P_0x761caa1fde20_31AnimateStart)
INFO:trame_server.controller:trigger(P_0x761caa1fde20_31AnimateStop)
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = style
INFO:trame_client.widgets.core:js_key = fluid
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:before: class = { 'rounded-circle': !P_0x761caa1fde20_31_show_ui }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token rounded
INFO:trame_server.state:has(rounded => rounded) = False
INFO:trame_server.utils.namespace:(prefix=None) token -
INFO:trame_server.state:has(- => -) = False
INFO:trame_server.utils.namespace:(prefix=None) token circle
INFO:trame_server.state:has(circle => circle) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token :
INFO:trame_server.state:has(: => :) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token !
INFO:trame_server.state:has(! => !) = False
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_show_ui
INFO:trame_server.state:has(P_0x761caa1fde20_31_show_ui => P_0x761caa1fde20_31_show_ui) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_show_ui
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { 'rounded-circle': !P_0x761caa1fde20_31_show_ui }
INFO:trame_client.widgets.core:after: class = { 'rounded-circle': !P_0x761caa1fde20_31_show_ui }
INFO:trame_client.widgets.core:js_key = style
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = style
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = size
INFO:trame_client.widgets.core:js_key = variant
INFO:trame_client.widgets.core:js_key = icon
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_show_ui=
INFO:trame_server.state:has(P_0x761caa1fde20_31_show_ui= => P_0x761caa1fde20_31_show_ui=) = False
INFO:trame_server.utils.namespace:(prefix=None) token !
INFO:trame_server.state:has(! => !) = False
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_show_ui
INFO:trame_server.state:has(P_0x761caa1fde20_31_show_ui => P_0x761caa1fde20_31_show_ui) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_show_ui
INFO:trame_server.utils.namespace: => P_0x761caa1fde20_31_show_ui=!P_0x761caa1fde20_31_show_ui
INFO:trame_server.utils.namespace: token mdi-dots-vertical
INFO:trame_server.utils.namespace: token {
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace: => {
INFO:trame_server.utils.namespace: token { P_0x761caa1fde20_31_show_ui ? 'Hide' : 'Show' }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_show_ui
INFO:trame_server.state:has(P_0x761caa1fde20_31_show_ui => P_0x761caa1fde20_31_show_ui) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_show_ui
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token ?
INFO:trame_server.state:has(? => ?) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token Hide
INFO:trame_server.state:has(Hide => Hide) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token :
INFO:trame_server.state:has(: => :) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token Show
INFO:trame_server.state:has(Show => Show) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { P_0x761caa1fde20_31_show_ui ? 'Hide' : 'Show' }
INFO:trame_server.utils.namespace: token } menu
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = style
INFO:trame_client.widgets.core:js_key = v-show
INFO:trame_client.widgets.core:before: v-show = P_0x761caa1fde20_31_show_ui
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_show_ui
INFO:trame_server.state:has(P_0x761caa1fde20_31_show_ui => P_0x761caa1fde20_31_show_ui) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_show_ui
INFO:trame_server.utils.namespace: => P_0x761caa1fde20_31_show_ui
INFO:trame_client.widgets.core:after: v-show = P_0x761caa1fde20_31_show_ui
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = vertical
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = size
INFO:trame_client.widgets.core:js_key = variant
INFO:trame_client.widgets.core:js_key = icon
INFO:trame_server.controller:trigger(trigger__3)
INFO:trame_server.utils.namespace: token mdi-arrow-expand-all
INFO:trame_server.utils.namespace: token Reset Camera
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = vertical
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = size
INFO:trame_client.widgets.core:js_key = variant
INFO:trame_client.widgets.core:js_key = icon
INFO:trame_server.controller:trigger(trigger__4)
INFO:trame_server.utils.namespace: token mdi-axis-arrow
INFO:trame_server.utils.namespace: token Perspective view
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = size
INFO:trame_client.widgets.core:js_key = variant
INFO:trame_client.widgets.core:js_key = icon
INFO:trame_server.controller:trigger(trigger__5)
INFO:trame_server.utils.namespace: token mdi-axis-x-arrow
INFO:trame_server.utils.namespace: token Reset Camera X
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = size
INFO:trame_client.widgets.core:js_key = variant
INFO:trame_client.widgets.core:js_key = icon
INFO:trame_server.controller:trigger(trigger__6)
INFO:trame_server.utils.namespace: token mdi-axis-y-arrow
INFO:trame_server.utils.namespace: token Reset Camera Y
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = size
INFO:trame_client.widgets.core:js_key = variant
INFO:trame_client.widgets.core:js_key = icon
INFO:trame_server.controller:trigger(trigger__7)
INFO:trame_server.utils.namespace: token mdi-axis-z-arrow
INFO:trame_server.utils.namespace: token Reset Camera Z
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = vertical
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = v-model
INFO:trame_client.widgets.core:before: v-model = P_0x761caa1fde20_31_edge_visibility
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_edge_visibility
INFO:trame_server.state:has(P_0x761caa1fde20_31_edge_visibility => P_0x761caa1fde20_31_edge_visibility) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_edge_visibility
INFO:trame_server.utils.namespace: => P_0x761caa1fde20_31_edge_visibility
INFO:trame_client.widgets.core:after: v-model = P_0x761caa1fde20_31_edge_visibility
INFO:trame_client.widgets.core:js_key = density
INFO:trame_client.widgets.core:js_key = hideDetails
INFO:trame_client.widgets.core:js_key = falseIcon
INFO:trame_client.widgets.core:js_key = trueIcon
INFO:trame_server.utils.namespace: token Toggle edge visibility ({
INFO:trame_server.utils.namespace: token { P_0x761caa1fde20_31_edge_visibility ? 'on' : 'off' }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_edge_visibility
INFO:trame_server.state:has(P_0x761caa1fde20_31_edge_visibility => P_0x761caa1fde20_31_edge_visibility) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_edge_visibility
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token ?
INFO:trame_server.state:has(? => ?) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token on
INFO:trame_server.state:has(on => on) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token :
INFO:trame_server.state:has(: => :) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token off
INFO:trame_server.state:has(off => off) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { P_0x761caa1fde20_31_edge_visibility ? 'on' : 'off' }
INFO:trame_server.utils.namespace: token })
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = v-model
INFO:trame_client.widgets.core:before: v-model = P_0x761caa1fde20_31_outline_visibility
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_outline_visibility
INFO:trame_server.state:has(P_0x761caa1fde20_31_outline_visibility => P_0x761caa1fde20_31_outline_visibility) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_outline_visibility
INFO:trame_server.utils.namespace: => P_0x761caa1fde20_31_outline_visibility
INFO:trame_client.widgets.core:after: v-model = P_0x761caa1fde20_31_outline_visibility
INFO:trame_client.widgets.core:js_key = density
INFO:trame_client.widgets.core:js_key = hideDetails
INFO:trame_client.widgets.core:js_key = falseIcon
INFO:trame_client.widgets.core:js_key = trueIcon
INFO:trame_server.utils.namespace: token Toggle bounding box ({
INFO:trame_server.utils.namespace: token { P_0x761caa1fde20_31_outline_visibility ? 'on' : 'off' }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_outline_visibility
INFO:trame_server.state:has(P_0x761caa1fde20_31_outline_visibility => P_0x761caa1fde20_31_outline_visibility) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_outline_visibility
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token ?
INFO:trame_server.state:has(? => ?) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token on
INFO:trame_server.state:has(on => on) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token :
INFO:trame_server.state:has(: => :) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token off
INFO:trame_server.state:has(off => off) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { P_0x761caa1fde20_31_outline_visibility ? 'on' : 'off' }
INFO:trame_server.utils.namespace: token })
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = v-model
INFO:trame_client.widgets.core:before: v-model = P_0x761caa1fde20_31_grid_visibility
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_grid_visibility
INFO:trame_server.state:has(P_0x761caa1fde20_31_grid_visibility => P_0x761caa1fde20_31_grid_visibility) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_grid_visibility
INFO:trame_server.utils.namespace: => P_0x761caa1fde20_31_grid_visibility
INFO:trame_client.widgets.core:after: v-model = P_0x761caa1fde20_31_grid_visibility
INFO:trame_client.widgets.core:js_key = density
INFO:trame_client.widgets.core:js_key = hideDetails
INFO:trame_client.widgets.core:js_key = falseIcon
INFO:trame_client.widgets.core:js_key = trueIcon
INFO:trame_server.utils.namespace: token Toggle ruler ({
INFO:trame_server.utils.namespace: token { P_0x761caa1fde20_31_grid_visibility ? 'on' : 'off' }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_grid_visibility
INFO:trame_server.state:has(P_0x761caa1fde20_31_grid_visibility => P_0x761caa1fde20_31_grid_visibility) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_grid_visibility
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token ?
INFO:trame_server.state:has(? => ?) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token on
INFO:trame_server.state:has(on => on) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token :
INFO:trame_server.state:has(: => :) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token off
INFO:trame_server.state:has(off => off) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { P_0x761caa1fde20_31_grid_visibility ? 'on' : 'off' }
INFO:trame_server.utils.namespace: token })
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = v-model
INFO:trame_client.widgets.core:before: v-model = P_0x761caa1fde20_31_axis_visiblity
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_axis_visiblity
INFO:trame_server.state:has(P_0x761caa1fde20_31_axis_visiblity => P_0x761caa1fde20_31_axis_visiblity) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_axis_visiblity
INFO:trame_server.utils.namespace: => P_0x761caa1fde20_31_axis_visiblity
INFO:trame_client.widgets.core:after: v-model = P_0x761caa1fde20_31_axis_visiblity
INFO:trame_client.widgets.core:js_key = density
INFO:trame_client.widgets.core:js_key = hideDetails
INFO:trame_client.widgets.core:js_key = falseIcon
INFO:trame_client.widgets.core:js_key = trueIcon
INFO:trame_server.utils.namespace: token Toggle axis ({
INFO:trame_server.utils.namespace: token { P_0x761caa1fde20_31_axis_visiblity ? 'on' : 'off' }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_axis_visiblity
INFO:trame_server.state:has(P_0x761caa1fde20_31_axis_visiblity => P_0x761caa1fde20_31_axis_visiblity) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_axis_visiblity
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token ?
INFO:trame_server.state:has(? => ?) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token on
INFO:trame_server.state:has(on => on) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token :
INFO:trame_server.state:has(: => :) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token off
INFO:trame_server.state:has(off => off) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { P_0x761caa1fde20_31_axis_visiblity ? 'on' : 'off' }
INFO:trame_server.utils.namespace: token })
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = vertical
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = v-model
INFO:trame_client.widgets.core:before: v-model = P_0x761caa1fde20_31_use_server_rendering
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_use_server_rendering
INFO:trame_server.state:has(P_0x761caa1fde20_31_use_server_rendering => P_0x761caa1fde20_31_use_server_rendering) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_use_server_rendering
INFO:trame_server.utils.namespace: => P_0x761caa1fde20_31_use_server_rendering
INFO:trame_client.widgets.core:after: v-model = P_0x761caa1fde20_31_use_server_rendering
INFO:trame_client.widgets.core:js_key = density
INFO:trame_client.widgets.core:js_key = hideDetails
INFO:trame_client.widgets.core:js_key = falseIcon
INFO:trame_client.widgets.core:js_key = trueIcon
INFO:trame_server.utils.namespace: token Toggle rendering mode ({
INFO:trame_server.utils.namespace: token { P_0x761caa1fde20_31_use_server_rendering ? 'remote' : 'local' }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_use_server_rendering
INFO:trame_server.state:has(P_0x761caa1fde20_31_use_server_rendering => P_0x761caa1fde20_31_use_server_rendering) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_use_server_rendering
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token ?
INFO:trame_server.state:has(? => ?) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token remote
INFO:trame_server.state:has(remote => remote) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token :
INFO:trame_server.state:has(: => :) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token local
INFO:trame_server.state:has(local => local) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { P_0x761caa1fde20_31_use_server_rendering ? 'remote' : 'local' }
INFO:trame_server.utils.namespace: token })
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = style
INFO:trame_client.widgets.core:js_key = v-show
INFO:trame_client.widgets.core:before: v-show = P_0x761caa1fde20_31_use_server_rendering
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_use_server_rendering
INFO:trame_server.state:has(P_0x761caa1fde20_31_use_server_rendering => P_0x761caa1fde20_31_use_server_rendering) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_use_server_rendering
INFO:trame_server.utils.namespace: => P_0x761caa1fde20_31_use_server_rendering
INFO:trame_client.widgets.core:after: v-show = P_0x761caa1fde20_31_use_server_rendering
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = class
INFO:trame_client.widgets.core:js_key = v-model
INFO:trame_client.widgets.core:before: v-model = P_0x761caa1fde20_31_parallel_projection
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_parallel_projection
INFO:trame_server.state:has(P_0x761caa1fde20_31_parallel_projection => P_0x761caa1fde20_31_parallel_projection) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_parallel_projection
INFO:trame_server.utils.namespace: => P_0x761caa1fde20_31_parallel_projection
INFO:trame_client.widgets.core:after: v-model = P_0x761caa1fde20_31_parallel_projection
INFO:trame_client.widgets.core:js_key = density
INFO:trame_client.widgets.core:js_key = hideDetails
INFO:trame_client.widgets.core:js_key = falseIcon
INFO:trame_client.widgets.core:js_key = trueIcon
INFO:trame_server.utils.namespace: token Toggle parallel projection ({
INFO:trame_server.utils.namespace: token { P_0x761caa1fde20_31_parallel_projection ? 'on' : 'off' }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token P_0x761caa1fde20_31_parallel_projection
INFO:trame_server.state:has(P_0x761caa1fde20_31_parallel_projection => P_0x761caa1fde20_31_parallel_projection) = True
INFO:trame_server.utils.namespace:(prefix=None) translated P_0x761caa1fde20_31_parallel_projection
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token ?
INFO:trame_server.state:has(? => ?) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token on
INFO:trame_server.state:has(on => on) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token :
INFO:trame_server.state:has(: => :) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token off
INFO:trame_server.state:has(off => off) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { P_0x761caa1fde20_31_parallel_projection ? 'on' : 'off' }
INFO:trame_server.utils.namespace: token })
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = size
INFO:trame_client.widgets.core:js_key = variant
INFO:trame_client.widgets.core:js_key = icon
INFO:trame_server.utils.namespace:(prefix=None) token utils
INFO:trame_server.state:has(utils => utils) = False
INFO:trame_server.utils.namespace:(prefix=None) token .
INFO:trame_server.state:has(. => .) = False
INFO:trame_server.utils.namespace:(prefix=None) token download
INFO:trame_server.state:has(download => download) = False
INFO:trame_server.utils.namespace:(prefix=None) token (
INFO:trame_server.state:has(( => () = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token screenshot
INFO:trame_server.state:has(screenshot => screenshot) = False
INFO:trame_server.utils.namespace:(prefix=None) token .
INFO:trame_server.state:has(. => .) = False
INFO:trame_server.utils.namespace:(prefix=None) token png
INFO:trame_server.state:has(png => png) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token ,
INFO:trame_server.state:has(, => ,) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token trigger
INFO:trame_server.state:has(trigger => trigger) = False
INFO:trame_server.utils.namespace:(prefix=None) token (
INFO:trame_server.state:has(( => () = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token trigger__1
INFO:trame_server.state:has(trigger__1 => trigger__1) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token )
INFO:trame_server.state:has() => )) = False
INFO:trame_server.utils.namespace:(prefix=None) token ,
INFO:trame_server.state:has(, => ,) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token image
INFO:trame_server.state:has(image => image) = False
INFO:trame_server.utils.namespace:(prefix=None) token /
INFO:trame_server.state:has(/ => /) = False
INFO:trame_server.utils.namespace:(prefix=None) token png
INFO:trame_server.state:has(png => png) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token )
INFO:trame_server.state:has() => )) = False
INFO:trame_server.utils.namespace: => utils.download('screenshot.png', trigger('trigger__1'), 'image/png')
INFO:trame_server.utils.namespace: token mdi-file-png-box
INFO:trame_server.utils.namespace: token Save screenshot
INFO:trame_client.widgets.core:js_key = location
INFO:trame_client.widgets.core:js_key = v-slot:activator
INFO:trame_client.widgets.core:before: v-slot:activator = { props }
INFO:trame_server.utils.namespace:(prefix=None) token {
INFO:trame_server.state:has({ => {) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token }
INFO:trame_server.state:has(} => }) = False
INFO:trame_server.utils.namespace: => { props }
INFO:trame_client.widgets.core:after: v-slot:activator = { props }
INFO:trame_client.widgets.core:js_key = v-bind
INFO:trame_client.widgets.core:before: v-bind = props
INFO:trame_server.utils.namespace:(prefix=None) token props
INFO:trame_server.state:has(props => props) = False
INFO:trame_server.utils.namespace: => props
INFO:trame_client.widgets.core:after: v-bind = props
INFO:trame_client.widgets.core:js_key = size
INFO:trame_client.widgets.core:js_key = variant
INFO:trame_client.widgets.core:js_key = icon
INFO:trame_server.utils.namespace:(prefix=None) token utils
INFO:trame_server.state:has(utils => utils) = False
INFO:trame_server.utils.namespace:(prefix=None) token .
INFO:trame_server.state:has(. => .) = False
INFO:trame_server.utils.namespace:(prefix=None) token download
INFO:trame_server.state:has(download => download) = False
INFO:trame_server.utils.namespace:(prefix=None) token (
INFO:trame_server.state:has(( => () = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token scene
INFO:trame_server.state:has(scene => scene) = False
INFO:trame_server.utils.namespace:(prefix=None) token -
INFO:trame_server.state:has(- => -) = False
INFO:trame_server.utils.namespace:(prefix=None) token export
INFO:trame_server.state:has(export => export) = False
INFO:trame_server.utils.namespace:(prefix=None) token .
INFO:trame_server.state:has(. => .) = False
INFO:trame_server.utils.namespace:(prefix=None) token html
INFO:trame_server.state:has(html => html) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token ,
INFO:trame_server.state:has(, => ,) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token trigger
INFO:trame_server.state:has(trigger => trigger) = False
INFO:trame_server.utils.namespace:(prefix=None) token (
INFO:trame_server.state:has(( => () = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token trigger__2
INFO:trame_server.state:has(trigger__2 => trigger__2) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token )
INFO:trame_server.state:has() => )) = False
INFO:trame_server.utils.namespace:(prefix=None) token ,
INFO:trame_server.state:has(, => ,) = False
INFO:trame_server.utils.namespace:(prefix=None) token  
INFO:trame_server.state:has(  =>  ) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token application
INFO:trame_server.state:has(application => application) = False
INFO:trame_server.utils.namespace:(prefix=None) token /
INFO:trame_server.state:has(/ => /) = False
INFO:trame_server.utils.namespace:(prefix=None) token octet
INFO:trame_server.state:has(octet => octet) = False
INFO:trame_server.utils.namespace:(prefix=None) token -
INFO:trame_server.state:has(- => -) = False
INFO:trame_server.utils.namespace:(prefix=None) token stream
INFO:trame_server.state:has(stream => stream) = False
INFO:trame_server.utils.namespace:(prefix=None) token '
INFO:trame_server.state:has(' => ') = False
INFO:trame_server.utils.namespace:(prefix=None) token )
INFO:trame_server.state:has() => )) = False
INFO:trame_server.utils.namespace: => utils.download('scene-export.html', trigger('trigger__2'), 'application/octet-stream')
INFO:trame_server.utils.namespace: token mdi-download
INFO:trame_server.utils.namespace: token Export scene as HTML
INFO:trame_client.widgets.core:js_key = stillRatio
INFO:trame_client.widgets.core:js_key = ref
INFO:trame_client.widgets.core:js_key = interactiveRatio
INFO:trame_client.widgets.core:js_key = stillRatio
DEBUG:pyvista.trame.jupyter:http://localhost:44877/index.html?ui=P_0x761caa1fde20_31&reconnect=auto
Widget(value='<iframe src="http://localhost:44877/index.html?ui=P_0x761caa1fde20_31&reconnect=auto" class="pyv…

References

[1] Detournay, Emmanuel. Mechanics of hydraulic fractures. Annual review of fluid mechanics 48 (2016): 311-339.

[2] Bourdin, Blaise, Chukwudi Chukwudozie, and Keita Yoshioka. A variational approach to the numerical simulation of hydraulic fracturing. In SPE annual technical conference and exhibition. OnePetro, 2012.

[3] Sneddon, Ian Naismith, and Morton Lowengrub. Crack problems in the classical theory of elasticity. 1969, 221 P (1969).

[4] Griffith, Alan Arnold. VI. The phenomena of rupture and flow in solids. Philosophical transactions of the royal society of london. Series A, containing papers of a mathematical or physical character 221, no. 582-593 (1921): 163-198.

[5] Yoshioka, Keita, Francesco Parisio, Dmitri Naumov, Renchao Lu, Olaf Kolditz, and Thomas Nagel. Comparative verification of discrete and smeared numerical approaches for the simulation of hydraulic fracturing. GEM-International Journal on Geomathematics 10, no. 1 (2019): 1-35.


This article was written by Mostafa Mollaali, Keita Yoshioka. If you are missing something or you find an error please let us know.
Generated with Hugo 0.122.0 in CI job 520198 | Last revision: March 3, 2023