diff --git a/examples/goalOrientedAFEM.m b/examples/goalOrientedAFEM.m
index a07806216b2b6a115b00a751585e3797c48ba33d..59fd93992125b6d2106dfb0a5b7180b4a1937fb8 100644
--- a/examples/goalOrientedAFEM.m
+++ b/examples/goalOrientedAFEM.m
@@ -3,9 +3,12 @@
 % ******************************************************************************
 
 %% paramters
-nDofsMax = 1e4;
+nDofsMax = 1e5;
 theta = 0.5;
-pmax = 3;
+pmax = 4;
+
+step = 1;
+while step< 3
 
 %% initialization for every polynomial degree
 [nElem, nDofs, goalErrEst] = deal(zeros(pmax, 1000));
@@ -57,15 +60,27 @@ for p = 1:pmax
         zeta2 = estimate(blf, lfG, z);
         nDofs(p,ell) = getDofs(fes).nDofs;
         nElem(p,ell) = mesh.nElements;
-        goalErrEst(p,ell) = sqrt(sum(eta2)*sum(zeta2));
-        printLogMessage('number of dofs: %d, estimator: %.2e', nDofs(p,ell), goalErrEst(p,ell));
 
+        %% goal estimator 
+        goalErrEstGOAFEM(p,ell) = sqrt(sum(eta2)*sum(zeta2));
+        switch step
+            case 1
+                printLogMessage('GOAFEM: number of dofs: %d, estimator: %.2e', nDofs(p,ell), goalErrEstGOAFEM(p,ell));
+            case 2
+                printLogMessage('AFEM: number of dofs: %d, estimator: %.2e', nDofs(p,ell), goalErrEstGOAFEM(p,ell));
+        end
         %% stoping criterion
         meshSufficientlyFine = (nDofs(p,ell) > nDofsMax);
 
         %% refine mesh
         if ~meshSufficientlyFine
-            marked = markGoafemMS(eta2, zeta2, theta);
+            %% switch here
+        switch step
+            case 1
+        marked = markGoafemMS(eta2, zeta2, theta);
+            case 2
+        marked = markDoerflerSorting(eta2, theta);
+        end
             mesh.refineLocally(marked, 'NVB');
             v.setData(prolongate(P, v));
             w.setData(prolongate(P, w));
@@ -75,16 +90,25 @@ end
 
 %% plot convergence rates
 pmax = size(nDofs, 1);
-figure()
-for p = 1:pmax
+
+switch step
+            case 1
+     figure()
+                for p = 1:pmax
+    idx = find(nDofs(p,:) > 0);
+   loglog(nDofs(p,idx), goalErrEstGOAFEM(p,idx), '-o', 'LineWidth', 2, 'DisplayName', ['GOAFEM p=',num2str(p)]);
+   grid on
+   hold on
+                end
+            case 2
+                for p = 1:pmax
     idx = find(nDofs(p,:) > 0);
-    loglog(nDofs(p,idx), goalErrEst(p,idx), '-o', 'LineWidth', 2, 'DisplayName', ['p=',num2str(p)]);
-    hold on
+   loglog(nDofs(p,idx), goalErrEstGOAFEM(p,idx), '--', 'LineWidth', 2, 'DisplayName', ['AFEM p=',num2str(p)]);
+        end
 end
-for p = unique([1,pmax])
-    x = nDofs(p,idx) / nDofs(p,1);
-    loglog(nDofs(p,1)*x, goalErrEst(p,1)*x.^(-p), '--', 'LineWidth', 2, 'Color', 'k', 'DisplayName', ['\alpha = ', num2str(p)])
+step = step +1;
 end
+
 legend
 xlabel('number of dofs')
 ylabel('goal error estimator')
diff --git a/experiments/Neumann_exact.m b/experiments/Neumann_exact.m
new file mode 100644
index 0000000000000000000000000000000000000000..ef27907dd073a74b08b15ce4e41c77e867452691
--- /dev/null
+++ b/experiments/Neumann_exact.m
@@ -0,0 +1,189 @@
+% ******************************************************************************
+% Adaptive FEM algorithm for a nonsymmetric problem on the L-shaped domain
+% using the Zarantonello iteration from Section 6.1 in [Brunner, Heid,
+% Innerberger, Miraçi, Praetorius, Streitberger, 2022]
+% ******************************************************************************
+clear all; close all;
+%% parameters
+nDofsMax = 5e1;%1e2;
+pmax = 1;
+theta = 0.5;
+lamalg = 1e-1;
+delta = 0.5;
+
+%% initialization for every polynomial degree
+for p = 1:1:pmax
+    %% setup geometry & spaces
+  %  leveldata = LevelData('results');
+%    leveldata.problem = 'neumann_exact';
+%    leveldata.domain = 'Lshape';
+ %   printLogMessage('*** p = %d (of %d) ***', p, pmax)
+ %   leveldata.identifier = ['p', num2str(p)];
+    mesh = Mesh.loadFromGeometry('Lshape');
+    mesh.refineUniform(1);
+    fes = FeSpace(mesh, HigherOrderH1Fe(p), 'dirichlet', 1, 'neumann', 2);
+    u = FeFunction(fes);
+    u.setData(0);
+    uZaraOld = FeFunction(fes);
+    uExact = FeFunction(fes);
+    ncFes = FeSpace(mesh, LowestOrderL2Fe());
+    w = FeFunction(ncFes);
+    Q = Prolongation.chooseFor(ncFes);
+
+    %% set problem data for -\Delta u = 0 on L-shaped
+    blf = BilinearForm();
+    lf = LinearForm();
+
+    blf.a = Constant(mesh, 1);
+    blf.qra = QuadratureRule.ofOrder(max(2*p-2, 1));
+
+    %lfF.f = MeshFunction(mesh, @(x) modifiedRightHandSide(x));
+    lf.f = MeshFunction(mesh, @(x) 0);
+    lf.neumann = MeshFunction(mesh, @(x) exactSolutionNeumannData(x));
+    lf.fvec = Constant(mesh, [0; 0]);
+    lf.qrf = QuadratureRule.ofOrder(2*p);
+    lf.qrfvec = QuadratureRule.ofOrder(2*p);
+    lf.qrNeumann = QuadratureRule.ofOrder(2*p, '1D');
+
+    %% set up solver and operator for nested iteration
+    [solver,  P] = IterativeSolver.choose(fes, blf, 'multigrid', 'lowOrderVcycle');
+    solver.tol = 1e-8;
+    solver.maxIter = 100;
+
+    %% adaptive loop
+    ell = 0;
+    work = 0;
+    time = 0;
+    meshSufficientlyFine = false;
+    while ~meshSufficientlyFine
+        %% setup
+        ell = ell + 1;
+
+        tic;
+        [A, F] = assembleAll(blf, lf, fes);
+
+        solver.setupSystemMatrix(A);
+        freeDofs = getFreeDofs(fes);
+        solver.setupRhs(F, u.data(freeDofs)');
+         uEllExact = A \ F;
+        nDofs = getDofs(fes).nDofs;
+        nFreeDofs = size(freeDofs, 1);
+
+        jPrimal = 0;
+        jContractionPrimal = 0;
+        primalSolverIsConverged = false;
+        while ~primalSolverIsConverged
+            work = work + nFreeDofs;
+            solver.step();
+            jIncrementNormPrimal = energyNorm(A, u.data(freeDofs)' - solver.x);
+
+            u.setFreeData(solver.x);
+            eta2 = estimate(blf, lf, u);
+            estimator = sqrt(sum(eta2));
+
+            primalSolverIsConverged = jIncrementNormPrimal < lamalg*estimator;
+        end
+        
+        uExact.setData(nodalInterpolation(MeshFunction(mesh, @exactSolution), fes));
+        jPrimal = jPrimal + solver.iterationCount;
+
+        deltaU = u.data - uExact.data;
+        h1Error = energyNorm(A, deltaU(freeDofs)');
+
+        %% stoping criterion
+        meshSufficientlyFine = (nDofs > nDofsMax);
+
+        %% refine mesh
+        if ~meshSufficientlyFine
+            marked = markDoerflerBinning(eta2, theta);
+            mesh.refineLocally(marked, 'NVB');
+            u.setData(prolongate(P, u));
+        end
+        time = time + toc;
+        relTime = time / nFreeDofs;
+        % leveldata.append( ...
+        %     'nDofs', uint32(nFreeDofs), ...
+        %     'nElems', uint32(mesh.nElements),...
+        %     'error', h1Error, ...
+        %     'estimator', estimator, ...
+        %     'time_cumulative', time,...
+        %     'relative_time', relTime, ...
+        %     'work', work ...
+        %     );
+        % leveldata.printLevel();
+    end
+    if nDofs > 1e6
+        leveldata.saveToTable();
+    end
+    %leveldata.plot('nDofs');
+end
+
+
+%% local functions for exact solution
+function y = exactSolution(x)
+    [phi, r] = cart2pol(x(1,:,:), x(2,:,:));
+    phi = phi + 2*pi*(phi < 0);
+    y = r.^(2/3) .* sin(2/3 * phi);
+end
+
+function y = exactSolutionNeumannData(x)
+    x1 = x(1,:,:);
+    x2 = x(2,:,:);
+    
+    % determine boundary partsexactSolutionNeumannData
+    right  = (x1 > 0) & (abs(x1) > abs(x2));
+    left   = (x1 < 0) & (abs(x1) > abs(x2));
+    top    = (x2 > 0) & (abs(x1) < abs(x2));
+    bottom = (x2 < 0) & (abs(x1) < abs(x2));
+
+    % compute d/dn uex
+    [phi, r] = cart2pol(x(1,:,:), x(2,:,:));
+    Cr = 2/3 * r.^(-4/3);
+    Cphi = 2/3 * (phi + 2*pi*(phi < 0));
+    dudx = Cr .* (x1.*sin(Cphi) - x2.*cos(Cphi));
+    dudy = Cr .* (x2.*sin(Cphi) + x1.*cos(Cphi));
+
+    y = zeros(size(x1));
+    y(right)  = dudx(right);
+    y(left)   =-dudx(left);
+    y(top)    = dudy(top);
+    y(bottom) =-dudy(bottom);
+end
+
+function indicators = estimate(blf, lf, u)
+p = u.fes.finiteElement.order;
+mesh =  u.fes.mesh;
+trafo = getAffineTransformation(mesh);
+
+% compute volume residual element-wise
+% For p=1, the diffusion term vanishes in the residual.
+f = CompositeFunction(@(a, v, f) (a .* (v(1,:,:) + v(4,:,:)) + f).^2, blf.a, Hessian(u), lf.f);
+qr = QuadratureRule.ofOrder(2*p);
+volumeResidual = integrateElement(f, qr);
+
+% compute edge residual edge-wise
+f = CompositeFunction(@(a, Du, fvec) a .* Du - fvec , blf.a, Gradient(u), lf.fvec);
+qr = QuadratureRule.ofOrder(2*max(p-1, 1), '1D');
+edgeResidual = integrateNormalJump(f, qr, ...
+    @(j) zeros(size(j)), {}, mesh.boundaries{1}, ... % no jump on dirichlet edges
+    @(j, phi) j-phi, {lf.neumann}, mesh.boundaries{2},...
+    @(j) j.^2, {}, ':');
+ 
+% combine the residuals suitably
+hT = sqrt(trafo.area);
+indicators = hT.^2 .* volumeResidual + ...
+    hT .* sum(edgeResidual(mesh.element2edges), Dim.Vector);
+end
+
+function [A, F] = assembleAll(blf, lf, fes)
+freeDofs = getFreeDofs(fes);
+A = assemble(blf, fes);
+A = A(freeDofs, freeDofs);
+
+F = assemble(lf, fes);
+F = F(freeDofs);
+end
+
+function e = energyNorm(A, v)
+e = sqrt(v' * A * v);
+end
\ No newline at end of file
diff --git a/experiments/dataAdaptiveErrorElementwise.aux b/experiments/dataAdaptiveErrorElementwise.aux
new file mode 100644
index 0000000000000000000000000000000000000000..b64012178f9cbc148dca209ceaf227aee4833711
--- /dev/null
+++ b/experiments/dataAdaptiveErrorElementwise.aux
@@ -0,0 +1,2 @@
+\relax 
+\gdef \@abspage@last{1}
diff --git a/experiments/dataAdaptiveErrorElementwise.fdb_latexmk b/experiments/dataAdaptiveErrorElementwise.fdb_latexmk
new file mode 100644
index 0000000000000000000000000000000000000000..5ad580273b44cfbd8b2beec2fe7adb3bec5ef230
--- /dev/null
+++ b/experiments/dataAdaptiveErrorElementwise.fdb_latexmk
@@ -0,0 +1,145 @@
+# Fdb version 4
+["pdflatex"] 1712783395 "/Users/m/Documents/PhD/gitHub/mooafem/experiments/dataAdaptiveErrorElementwise.tex" "dataAdaptiveErrorElementwise.pdf" "dataAdaptiveErrorElementwise" 1712783396 0
+  "/Users/m/Documents/PhD/gitHub/mooafem/experiments/dataAdaptiveErrorElementwise.tex" 1712781368 67062 ce2a5f2f68dab2a8499ae26948b52489 ""
+  "/dev/null" 1712783395 0 d41d8cd98f00b204e9800998ecf8427e ""
+  "/usr/local/texlive/2023/texmf-dist/tex/context/base/mkii/supp-pdf.mkii" 1461363279 71627 94eb9990bed73c364d7f53f960cc8c5b ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty" 1572645307 492 1994775aa15b0d1289725a0b1bbc2d4c ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty" 1644112042 7237 bdd120a32c8fdb4b433cf9ca2e7cd98a ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcore.code.tex" 1673816307 1016 1c2b89187d12a2768764b83b4945667c ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorearrows.code.tex" 1601326656 43820 1fef971b75380574ab35a0d37fd92608 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreexternal.code.tex" 1601326656 19324 f4e4c6403dd0f1605fd20ed22fa79dea ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoregraphicstate.code.tex" 1601326656 6038 ccb406740cc3f03bbfb58ad504fe8c27 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreimage.code.tex" 1673816307 6911 f6d4cf5a3fef5cc879d668b810e82868 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorelayers.code.tex" 1601326656 4883 42daaf41e27c3735286e23e48d2d7af9 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreobjects.code.tex" 1601326656 2544 8c06d2a7f0f469616ac9e13db6d2f842 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepathconstruct.code.tex" 1601326656 44195 5e390c414de027626ca5e2df888fa68d ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepathprocessing.code.tex" 1601326656 17311 2ef6b2e29e2fc6a2fc8d6d652176e257 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepathusage.code.tex" 1601326656 21302 788a79944eb22192a4929e46963a3067 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepatterns.code.tex" 1673816307 9691 3d42d89522f4650c2f3dc616ca2b925e ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepoints.code.tex" 1601326656 33335 dd1fa4814d4e51f18be97d88bf0da60c ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorequick.code.tex" 1601326656 2965 4c2b1f4e0826925746439038172e5d6f ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorerdf.code.tex" 1601326656 5196 2cc249e0ee7e03da5f5f6589257b1e5b ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorescopes.code.tex" 1673816307 20821 7579108c1e9363e61a0b1584778804aa ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreshade.code.tex" 1601326656 35249 abd4adf948f960299a4b3d27c5dddf46 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoretransformations.code.tex" 1673816307 22012 81b34a0aa8fa1a6158cc6220b00e4f10 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoretransparency.code.tex" 1601326656 8893 e851de2175338fdf7c17f3e091d94618 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.code.tex" 1673816307 5628 dc0ee4ba7f3e40acae5600067ce833de ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.pathmorphing.code.tex" 1601326656 321 cdd11262840e01e25374a2d458f15e99 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.pathreplacing.code.tex" 1601326656 1319 0b2de5126c6cbc295f0eb77f7344b34d ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibraryplotmarks.code.tex" 1601326656 325 36322b0789619b270aec5993d5a9ed08 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarytopaths.code.tex" 1608933718 11518 738408f795261b70ce8dd47459171309 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/tikz.code.tex" 1673816307 186782 af500404a9edec4d362912fe762ded92 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/decorations/pgflibrarydecorations.pathmorphing.code.tex" 1601326656 8843 5533436db3e30fbad1e0440db6027dac ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/decorations/pgflibrarydecorations.pathreplacing.code.tex" 1601326656 7474 f05a7223b140f230922562ac6a9fede5 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryfpu.code.tex" 1608933718 85938 8e4ba97c5906e1c0d158aea81fe29af7 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryplothandlers.code.tex" 1601326656 32995 ac577023e12c0e4bd8aa420b2e852d1a ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryplotmarks.code.tex" 1673816307 14526 4bc184b12436aa7f6490b2d2036870ef ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfint.code.tex" 1557692582 3063 8c415c68a0f3394e45cfeca0b65f6ee6 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmath.code.tex" 1673816307 949 cea70942e7b7eddabfb3186befada2e6 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathcalc.code.tex" 1673816307 13270 2e54f2ce7622437bf37e013d399743e3 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfloat.code.tex" 1673816307 104717 9b2393fbf004a0ce7fa688dbce423848 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.base.code.tex" 1601326656 10165 cec5fa73d49da442e56efc2d605ef154 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.basic.code.tex" 1601326656 28178 41c17713108e0795aac6fef3d275fbca ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.code.tex" 1673816307 9649 85779d3d8d573bfd2cd4137ba8202e60 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.comparison.code.tex" 1601326656 3865 ac538ab80c5cf82b345016e474786549 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.integerarithmetics.code.tex" 1557692582 3177 27d85c44fbfe09ff3b2cf2879e3ea434 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.misc.code.tex" 1621110968 11024 0179538121bc2dba172013a3ef89519f ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.random.code.tex" 1673816307 7890 0a86dbf4edfd88d022e0d889ec78cc03 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.round.code.tex" 1601326656 3379 781797a101f647bab82741a99944a229 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.trigonometric.code.tex" 1601326656 92405 f515f31275db273f97b9d8f52e1b0736 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathparser.code.tex" 1673816307 37466 97b0a1ba732e306a1a2034f5a73e239f ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathutil.code.tex" 1601326656 8471 c2883569d03f69e8e1cabfef4999cfd7 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmoduledecorations.code.tex" 1673816307 71742 3da44a8be6626eef1c400c68776c7a0f ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmodulematrix.code.tex" 1673816307 21211 1e73ec76bd73964d84197cc3d2685b01 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmoduleplot.code.tex" 1601326656 16121 346f9013d34804439f7436ff6786cef7 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmoduleshapes.code.tex" 1673816307 44792 271e2e1934f34c759f4dedb1e14a5015 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/pgf.revision.tex" 1673816307 114 e6d443369d0673933b38834bf99e422d ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgf.cfg" 1601326656 926 2963ea0dcf6cc6c0a770b69ec46a477b ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-common-pdf.def" 1673816307 5542 32f75a31ea6c3a7e1148cd6d5e93dbb7 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-luatex.def" 1673816307 13255 83878f3f820beccc0dd1c2683dabc65e ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-pdftex.def" 1673816307 12612 7774ba67bfd72e593c4436c2de6201e3 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys.code.tex" 1673816307 61351 bc5f86e0355834391e736e97a61abced ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsysprotocol.code.tex" 1601326656 1896 b8e0ca0ac371d74c0ca05583f6313c91 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsyssoftpath.code.tex" 1601326656 7778 53c8b5623d80238f6a20aa1df1868e63 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgffor.code.tex" 1673816307 24033 d8893a1ec4d1bfa101b172754743d340 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeys.code.tex" 1673816307 39784 414c54e866ebab4b801e2ad81d9b21d8 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeyslibraryfiltered.code.tex" 1673816307 37433 940bc6d409f1ffd298adfdcaf125dd86 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfrcs.code.tex" 1673816307 4385 510565c2f07998c8a0e14f0ec07ff23c ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfutil-common.tex" 1673816307 29239 22e8c7516012992a49873eff0d868fed ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfutil-latex.def" 1673816307 6950 8524a062d82b7afdc4a88a57cb377784 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/pgflibrarypgfplots.surfshading.code.tex" 1452211337 22701 5fab7b8ebb90b053dc067d1bd37e43c2 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/pgfplotslibrary.code.tex" 1422740226 3047 aa82404aec57311271f4991c44bd71dc ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/tikzlibrarypgfplots.colormaps.code.tex" 1452211337 17447 1206d421f876f6cfae45aa2412d04dcb ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/tikzlibrarypgfplots.contourlua.code.tex" 1620507943 2931 5d52092da9e839accd7c9026062fe5c3 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsarray.code.tex" 1496704190 23537 54be8160344d894595f6d145b1311658 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsdeque.code.tex" 1262481251 4288 b8d6247899b21e3bb66bb11b24d30f2c ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsliststructure.code.tex" 1452211337 13828 11d1b09335a4a8baa693dd1e6cac3edf ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsliststructureext.code.tex" 1496704190 24373 6544c1554e5da33118301011eb03058d ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsmatrix.code.tex" 1364427911 18861 7dc35832c8ccea3aa73cdcd75ec0a60b ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/numtable/pgfplotstableshared.code.tex" 1583276309 83469 f77a7d8a23834d4c2472f8dba8e67bff ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/oldpgfcompatib/pgfplotsoldpgfsupp_loader.code.tex" 1583276309 12347 43d867ea29e34d528123d9ef750aa146 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/oldpgfcompatib/pgfplotsoldpgfsupp_pgfutil-common-lists.tex" 1496704190 8008 3bb2d07671e6afab7dcb90dfaec572a4 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.code.tex" 1620507943 485274 aafeb7052fbed4c8aba6fcc36c94ea72 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.errorbars.code.tex" 1452211337 22428 72578a4c9324bc5dfafe23fe64f64024 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.markers.code.tex" 1583276309 12489 859c23df41fb9067128ef5a64b01c0a4 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.paths.code.tex" 1583276309 3533 973f376afa5a4526f16b11630b9931b4 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.revision.tex" 1621284213 520 2a55e10851bbb34fb49a8e1d6b50a09b ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.scaling.code.tex" 1523216742 123680 d33fda4929d7200c3e6f0ec83c006aef ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotscoordprocessing.code.tex" 1583276309 367035 be5ad6faf030b5e07b899b712359f9d2 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotscore.code.tex" 1470951798 19944 7957349fbe31c4e8dea9de4cd41cb086 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsmeshplothandler.code.tex" 1496704190 133871 7247b31742a2240343a6739cb76d6821 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsmeshplotimage.code.tex" 1620507943 25239 bf1615252744653354985789b73e7404 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsplothandlers.code.tex" 1620507943 120954 bdf135670013db80411b2fb0f95876ac ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsstackedplots.code.tex" 1620507943 26393 a7d9bbecdd0db20d652c909dac892e25 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsticks.code.tex" 1583276309 91244 1a0e9e49b7a2d10d1b1a610306ba4f8c ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/sys/pgflibrarypgfplots.surfshading.pgfsys-pdftex.def" 1470951798 5907 9dc460712c23e5b3338820499d47608c ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/sys/pgfplotssysgeneric.code.tex" 1351287374 3095 c82d281b748902a65be2ccca97360b11 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsbinary.code.tex" 1430688073 23050 a369aa910ef860a3621fe0459faa335c ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsbinary.data.code.tex" 1346285630 26859 7a4ee9d206fb0a0daa0d3108445afb57 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotscolor.code.tex" 1380839021 23958 1b96260863091af1669c3a38b1c4c9af ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotscolormap.code.tex" 1496704190 88956 018b2512ef27998e97af72e8b1dcdbd5 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsutil.code.tex" 1620507943 71792 dba1b75b15201895eb36f142f13b3238 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsutil.verb.code.tex" 1312159636 3286 c17079ba50483e1ac1721268ea016041 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/xkeyval/keyval.tex" 1655411236 2725 1a42bd9e7e57e25fc7763c445f4b785b ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/xkeyval/xkeyval.tex" 1655411236 19231 27205ee17aaa2902aea3e0c07a3cfc65 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/generic/xkeyval/xkvutils.tex" 1655411236 7677 9cb1a74d945bc9331f2181c0a59ff34a ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls" 1667332637 20144 d5ecf0a5140c8d8d8b72cbe86e320eff ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/base/size10.clo" 1667332637 8448 c33a4e1cb35cee9b33c2b21033b73e39 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty" 1579991033 13886 d1306dcf79a944f6988e688c1785f9ce ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/color.cfg" 1459978653 1213 620bba36b25224fa9b7e1ccb4ecb76fd ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/graphics.cfg" 1465944070 1224 978390e9c2234eab29404bc21b268d1e ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/graphics-def/pdftex.def" 1663965824 19448 1e988b341dda20961a6b931bcde55519 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty" 1654720880 18387 8f900a490197ebaf93c02ae9476d4b09 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty" 1654720880 8010 a8d949cbdbc5c983593827c9eec252e1 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/graphics/keyval.sty" 1654720880 2671 7e67d78d9b88c845599a85b2d41f2e39 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/graphics/mathcolor.ltx" 1667332637 2885 9c645d672ae17285bba324998918efd8 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty" 1654720880 4023 293ea1c16429fc0c4cf605f4da1791a9 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def" 1673989714 30429 213676d4c7327a21d91ddaed900e7b81 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/latexconfig/epstopdf-sys.cfg" 1279039959 678 4792914a8f45be57bb98413425e4c7af ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty" 1601326656 1090 bae35ef70b3168089ef166db3e66f5b2 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty" 1673816307 373 00b204b1d7d095b892ad31a7494b0373 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty" 1601326656 21013 f4ff83d25bb56552493b030f27c075ae ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty" 1601326656 989 c49c8ae06d96f8b15869da7428047b1e ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty" 1601326656 339 c2e180022e3afdb99c7d0ea5ce469b7d ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty" 1601326656 306 c56a323ca5bf9242f54474ced10fca71 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty" 1601326656 443 8c872229db56122037e86bcda49e14f3 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty" 1601326656 348 ee405e64380c11319f0e249fed57e6c5 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty" 1601326656 274 5ae372b7df79135d240456a1c6f2cf9a ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty" 1601326656 325 f9f16d12354225b7dd52a3321f085955 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty" 1496704190 4904 ee78b44e85d6fccf08cd99370557481e ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/preview/preview.sty" 1645477096 14284 33875263c1014adf16559cae4ff4b8a3 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cfg" 1665433651 1015 ca4a9fdee3211711bd723951f61ec2fe ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls" 1665433651 29032 f9277545472a63d812460310b499511e ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty" 1654720880 4118 0aa319c56935d7d217b6a8bf300b81b7 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty" 1655066402 56148 51a9a8571c07b9921892ae11063ae853 ""
+  "/usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty" 1655411236 4937 4ce600ce9bd4ec84d0250eb6892fcf4f ""
+  "/usr/local/texlive/2023/texmf-dist/web2c/texmf.cnf" 1677365944 40745 87bb86a62d462f93a1efc6b0c65c872e ""
+  "/usr/local/texlive/2023/texmf-var/web2c/pdftex/pdflatex.fmt" 1708507976 7883461 c91c4560868252339d6ff7b560132c19 ""
+  "/usr/local/texlive/2023/texmf.cnf" 1678822455 577 1b2b1af17af2508fb20dd85783af4050 ""
+  "dataAdaptiveErrorElementwise.aux" 1712783396 32 3985256e7290058c681f74d7a3565a19 "pdflatex"
+  "dataAdaptiveErrorElementwise.tex" 1712781368 67062 ce2a5f2f68dab2a8499ae26948b52489 ""
+  (generated)
+  "dataAdaptiveErrorElementwise.aux"
+  "dataAdaptiveErrorElementwise.log"
+  "dataAdaptiveErrorElementwise.pdf"
+  (rewritten before read)
diff --git a/experiments/dataAdaptiveErrorElementwise.fls b/experiments/dataAdaptiveErrorElementwise.fls
new file mode 100644
index 0000000000000000000000000000000000000000..0d74fb08fe023da2460715c741d3874b0cd06722
--- /dev/null
+++ b/experiments/dataAdaptiveErrorElementwise.fls
@@ -0,0 +1,463 @@
+PWD /Users/m/Documents/PhD/gitHub/mooafem/experiments
+INPUT /usr/local/texlive/2023/texmf.cnf
+INPUT /usr/local/texlive/2023/texmf-dist/web2c/texmf.cnf
+INPUT /usr/local/texlive/2023/texmf-var/web2c/pdftex/pdflatex.fmt
+INPUT /Users/m/Documents/PhD/gitHub/mooafem/experiments/dataAdaptiveErrorElementwise.tex
+OUTPUT dataAdaptiveErrorElementwise.log
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/xkeyval/xkeyval.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/xkeyval/xkvutils.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/xkeyval/keyval.tex
+INPUT /dev/null
+INPUT /dev/null
+INPUT /dev/null
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/preview/preview.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/preview/preview.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/size10.clo
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/size10.clo
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/size10.clo
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/base/size10.clo
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfutil-common.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfutil-latex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfrcs.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfrcs.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfrcs.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfrcs.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/pgf.revision.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/pgf.revision.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/keyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/graphics.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/graphics.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/graphics.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/graphics.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-def/pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-def/pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-def/pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-def/pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeys.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeyslibraryfiltered.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgf.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-common-pdf.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsyssoftpath.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsyssoftpath.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsyssoftpath.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsyssoftpath.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsysprotocol.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsysprotocol.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsysprotocol.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsysprotocol.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/keyval.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/color.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/color.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/color.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/color.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/mathcolor.ltx
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/mathcolor.ltx
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/mathcolor.ltx
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/mathcolor.ltx
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcore.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcore.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcore.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcore.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmath.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathutil.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathparser.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.basic.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.trigonometric.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.random.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.comparison.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.base.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.round.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.misc.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.integerarithmetics.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathcalc.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfloat.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfint.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepoints.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepathconstruct.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepathusage.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorescopes.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoregraphicstate.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoretransformations.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorequick.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreobjects.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepathprocessing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorearrows.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreshade.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreimage.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreexternal.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorelayers.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoretransparency.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepatterns.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorerdf.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmoduleshapes.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmoduleplot.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeys.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeys.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeys.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeys.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmath.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmath.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmath.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmath.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgffor.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgffor.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgffor.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgffor.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/tikz.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/tikz.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/tikz.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/tikz.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryplothandlers.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryplothandlers.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmodulematrix.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarytopaths.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarytopaths.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.revision.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.revision.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.revision.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-luatex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-luatex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotscore.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/sys/pgfplotssysgeneric.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/pgfplotslibrary.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/oldpgfcompatib/pgfplotsoldpgfsupp_loader.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryfpu.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryfpu.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryfpu.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/oldpgfcompatib/pgfplotsoldpgfsupp_pgfutil-common-lists.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsutil.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsliststructure.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsliststructureext.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsarray.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsmatrix.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/numtable/pgfplotstableshared.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsdeque.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsbinary.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsbinary.data.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsutil.verb.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/pgflibrarypgfplots.surfshading.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/sys/pgflibrarypgfplots.surfshading.pgfsys-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/sys/pgflibrarypgfplots.surfshading.pgfsys-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotscolormap.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotscolor.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsstackedplots.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsplothandlers.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsmeshplothandler.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsmeshplotimage.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.scaling.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotscoordprocessing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.errorbars.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.markers.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsticks.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.paths.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmoduledecorations.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.pathmorphing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.pathmorphing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/decorations/pgflibrarydecorations.pathmorphing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/decorations/pgflibrarydecorations.pathmorphing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.pathreplacing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.pathreplacing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/decorations/pgflibrarydecorations.pathreplacing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/decorations/pgflibrarydecorations.pathreplacing.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/tikzlibrarypgfplots.contourlua.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/tikzlibrarypgfplots.contourlua.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibraryplotmarks.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibraryplotmarks.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryplotmarks.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryplotmarks.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/tikzlibrarypgfplots.colormaps.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/tikzlibrarypgfplots.colormaps.code.tex
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+INPUT ./dataAdaptiveErrorElementwise.aux
+INPUT dataAdaptiveErrorElementwise.aux
+INPUT dataAdaptiveErrorElementwise.aux
+OUTPUT dataAdaptiveErrorElementwise.aux
+INPUT /usr/local/texlive/2023/texmf-dist/tex/context/base/mkii/supp-pdf.mkii
+INPUT /usr/local/texlive/2023/texmf-dist/tex/context/base/mkii/supp-pdf.mkii
+INPUT /usr/local/texlive/2023/texmf-dist/tex/context/base/mkii/supp-pdf.mkii
+INPUT /usr/local/texlive/2023/texmf-dist/tex/context/base/mkii/supp-pdf.mkii
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/latexconfig/epstopdf-sys.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/latexconfig/epstopdf-sys.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/latexconfig/epstopdf-sys.cfg
+INPUT /usr/local/texlive/2023/texmf-dist/tex/latex/latexconfig/epstopdf-sys.cfg
+OUTPUT dataAdaptiveErrorElementwise.pdf
+INPUT dataAdaptiveErrorElementwise.aux
diff --git a/experiments/dataAdaptiveErrorElementwise.log b/experiments/dataAdaptiveErrorElementwise.log
new file mode 100644
index 0000000000000000000000000000000000000000..54c867f6b48a4da08902969a4a494dbd1b297f40
--- /dev/null
+++ b/experiments/dataAdaptiveErrorElementwise.log
@@ -0,0 +1,363 @@
+This is pdfTeX, Version 3.141592653-2.6-1.40.25 (TeX Live 2023) (preloaded format=pdflatex 2024.2.21)  10 APR 2024 23:09
+entering extended mode
+ restricted \write18 enabled.
+ file:line:error style messages enabled.
+ %&-line parsing enabled.
+**/Users/m/Documents/PhD/gitHub/mooafem/experiments/dataAdaptiveErrorElementwise.tex
+(/Users/m/Documents/PhD/gitHub/mooafem/experiments/dataAdaptiveErrorElementwise.tex
+LaTeX2e <2022-11-01> patch level 1
+L3 programming layer <2023-02-22> (/usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cls
+Document Class: standalone 2022/10/10 v1.3b Class to compile TeX sub-files standalone
+(/usr/local/texlive/2023/texmf-dist/tex/latex/tools/shellesc.sty
+Package: shellesc 2019/11/08 v1.0c unified shell escape interface for LaTeX
+Package shellesc Info: Restricted shell escape enabled on input line 77.
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/iftex/ifluatex.sty
+Package: ifluatex 2019/10/25 v1.5 ifluatex legacy package. Use iftex instead.
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/iftex/iftex.sty
+Package: iftex 2022/02/03 v1.0f TeX engine tests
+)) (/usr/local/texlive/2023/texmf-dist/tex/latex/xkeyval/xkeyval.sty
+Package: xkeyval 2022/06/16 v2.9 package option processing (HA)
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/xkeyval/xkeyval.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/xkeyval/xkvutils.tex
+\XKV@toks=\toks16
+\XKV@tempa@toks=\toks17
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/xkeyval/keyval.tex))
+\XKV@depth=\count185
+File: xkeyval.tex 2014/12/03 v2.7a key=value parser (HA)
+))
+\sa@internal=\count186
+\c@sapage=\count187
+ (/usr/local/texlive/2023/texmf-dist/tex/latex/standalone/standalone.cfg
+File: standalone.cfg 2022/10/10 v1.3b Default configuration file for 'standalone' class
+) (/usr/local/texlive/2023/texmf-dist/tex/latex/base/article.cls
+Document Class: article 2022/07/02 v1.4n Standard LaTeX document class
+(/usr/local/texlive/2023/texmf-dist/tex/latex/base/size10.clo
+File: size10.clo 2022/07/02 v1.4n Standard LaTeX file (size option)
+)
+\c@part=\count188
+\c@section=\count189
+\c@subsection=\count190
+\c@subsubsection=\count191
+\c@paragraph=\count192
+\c@subparagraph=\count193
+\c@figure=\count194
+\c@table=\count195
+\abovecaptionskip=\skip48
+\belowcaptionskip=\skip49
+\bibindent=\dimen140
+)
+\sa@box=\box51
+) (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/frontendlayer/tikz.sty (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgf.sty (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfrcs.sty (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfutil-common.tex
+\pgfutil@everybye=\toks18
+\pgfutil@tempdima=\dimen141
+\pgfutil@tempdimb=\dimen142
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfutil-latex.def
+\pgfutil@abb=\box52
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfrcs.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/pgf.revision.tex)
+Package: pgfrcs 2023-01-15 v3.1.10 (3.1.10)
+))
+Package: pgf 2023-01-15 v3.1.10 (3.1.10)
+ (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/basiclayer/pgfcore.sty (/usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphicx.sty
+Package: graphicx 2021/09/16 v1.2d Enhanced LaTeX Graphics (DPC,SPQR)
+ (/usr/local/texlive/2023/texmf-dist/tex/latex/graphics/graphics.sty
+Package: graphics 2022/03/10 v1.4e Standard LaTeX Graphics (DPC,SPQR)
+ (/usr/local/texlive/2023/texmf-dist/tex/latex/graphics/trig.sty
+Package: trig 2021/08/11 v1.11 sin cos tan (DPC)
+) (/usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/graphics.cfg
+File: graphics.cfg 2016/06/04 v1.11 sample graphics configuration
+)
+Package graphics Info: Driver file: pdftex.def on input line 107.
+ (/usr/local/texlive/2023/texmf-dist/tex/latex/graphics-def/pdftex.def
+File: pdftex.def 2022/09/22 v1.2b Graphics/color driver for pdftex
+))
+\Gin@req@height=\dimen143
+\Gin@req@width=\dimen144
+) (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/systemlayer/pgfsys.sty (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys.code.tex
+Package: pgfsys 2023-01-15 v3.1.10 (3.1.10)
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeys.code.tex
+\pgfkeys@pathtoks=\toks19
+\pgfkeys@temptoks=\toks20
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeyslibraryfiltered.code.tex
+\pgfkeys@tmptoks=\toks21
+))
+\pgf@x=\dimen145
+\pgf@y=\dimen146
+\pgf@xa=\dimen147
+\pgf@ya=\dimen148
+\pgf@xb=\dimen149
+\pgf@yb=\dimen150
+\pgf@xc=\dimen151
+\pgf@yc=\dimen152
+\pgf@xd=\dimen153
+\pgf@yd=\dimen154
+\w@pgf@writea=\write3
+\r@pgf@reada=\read2
+\c@pgf@counta=\count196
+\c@pgf@countb=\count197
+\c@pgf@countc=\count198
+\c@pgf@countd=\count199
+\t@pgf@toka=\toks22
+\t@pgf@tokb=\toks23
+\t@pgf@tokc=\toks24
+\pgf@sys@id@count=\count266
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgf.cfg
+File: pgf.cfg 2023-01-15 v3.1.10 (3.1.10)
+)
+Driver file for pgf: pgfsys-pdftex.def
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-pdftex.def
+File: pgfsys-pdftex.def 2023-01-15 v3.1.10 (3.1.10)
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsys-common-pdf.def
+File: pgfsys-common-pdf.def 2023-01-15 v3.1.10 (3.1.10)
+))) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsyssoftpath.code.tex
+File: pgfsyssoftpath.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgfsyssoftpath@smallbuffer@items=\count267
+\pgfsyssoftpath@bigbuffer@items=\count268
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/systemlayer/pgfsysprotocol.code.tex
+File: pgfsysprotocol.code.tex 2023-01-15 v3.1.10 (3.1.10)
+)) (/usr/local/texlive/2023/texmf-dist/tex/latex/xcolor/xcolor.sty
+Package: xcolor 2022/06/12 v2.14 LaTeX color extensions (UK)
+ (/usr/local/texlive/2023/texmf-dist/tex/latex/graphics-cfg/color.cfg
+File: color.cfg 2016/01/02 v1.6 sample color configuration
+)
+Package xcolor Info: Driver file: pdftex.def on input line 227.
+ (/usr/local/texlive/2023/texmf-dist/tex/latex/graphics/mathcolor.ltx)
+Package xcolor Info: Model `cmy' substituted by `cmy0' on input line 1353.
+Package xcolor Info: Model `hsb' substituted by `rgb' on input line 1357.
+Package xcolor Info: Model `RGB' extended on input line 1369.
+Package xcolor Info: Model `HTML' substituted by `rgb' on input line 1371.
+Package xcolor Info: Model `Hsb' substituted by `hsb' on input line 1372.
+Package xcolor Info: Model `tHsb' substituted by `hsb' on input line 1373.
+Package xcolor Info: Model `HSB' substituted by `hsb' on input line 1374.
+Package xcolor Info: Model `Gray' substituted by `gray' on input line 1375.
+Package xcolor Info: Model `wave' substituted by `hsb' on input line 1376.
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcore.code.tex
+Package: pgfcore 2023-01-15 v3.1.10 (3.1.10)
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmath.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathutil.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathparser.code.tex
+\pgfmath@dimen=\dimen155
+\pgfmath@count=\count269
+\pgfmath@box=\box53
+\pgfmath@toks=\toks25
+\pgfmath@stack@operand=\toks26
+\pgfmath@stack@operation=\toks27
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.basic.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.trigonometric.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.random.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.comparison.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.base.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.round.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.misc.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfunctions.integerarithmetics.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathcalc.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmathfloat.code.tex
+\c@pgfmathroundto@lastzeros=\count270
+)) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfint.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepoints.code.tex
+File: pgfcorepoints.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgf@picminx=\dimen156
+\pgf@picmaxx=\dimen157
+\pgf@picminy=\dimen158
+\pgf@picmaxy=\dimen159
+\pgf@pathminx=\dimen160
+\pgf@pathmaxx=\dimen161
+\pgf@pathminy=\dimen162
+\pgf@pathmaxy=\dimen163
+\pgf@xx=\dimen164
+\pgf@xy=\dimen165
+\pgf@yx=\dimen166
+\pgf@yy=\dimen167
+\pgf@zx=\dimen168
+\pgf@zy=\dimen169
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepathconstruct.code.tex
+File: pgfcorepathconstruct.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgf@path@lastx=\dimen170
+\pgf@path@lasty=\dimen171
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepathusage.code.tex
+File: pgfcorepathusage.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgf@shorten@end@additional=\dimen172
+\pgf@shorten@start@additional=\dimen173
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorescopes.code.tex
+File: pgfcorescopes.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgfpic=\box54
+\pgf@hbox=\box55
+\pgf@layerbox@main=\box56
+\pgf@picture@serial@count=\count271
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoregraphicstate.code.tex
+File: pgfcoregraphicstate.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgflinewidth=\dimen174
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoretransformations.code.tex
+File: pgfcoretransformations.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgf@pt@x=\dimen175
+\pgf@pt@y=\dimen176
+\pgf@pt@temp=\dimen177
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorequick.code.tex
+File: pgfcorequick.code.tex 2023-01-15 v3.1.10 (3.1.10)
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreobjects.code.tex
+File: pgfcoreobjects.code.tex 2023-01-15 v3.1.10 (3.1.10)
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepathprocessing.code.tex
+File: pgfcorepathprocessing.code.tex 2023-01-15 v3.1.10 (3.1.10)
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorearrows.code.tex
+File: pgfcorearrows.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgfarrowsep=\dimen178
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreshade.code.tex
+File: pgfcoreshade.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgf@max=\dimen179
+\pgf@sys@shading@range@num=\count272
+\pgf@shadingcount=\count273
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreimage.code.tex
+File: pgfcoreimage.code.tex 2023-01-15 v3.1.10 (3.1.10)
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoreexternal.code.tex
+File: pgfcoreexternal.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgfexternal@startupbox=\box57
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorelayers.code.tex
+File: pgfcorelayers.code.tex 2023-01-15 v3.1.10 (3.1.10)
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcoretransparency.code.tex
+File: pgfcoretransparency.code.tex 2023-01-15 v3.1.10 (3.1.10)
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorepatterns.code.tex
+File: pgfcorepatterns.code.tex 2023-01-15 v3.1.10 (3.1.10)
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/basiclayer/pgfcorerdf.code.tex
+File: pgfcorerdf.code.tex 2023-01-15 v3.1.10 (3.1.10)
+))) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmoduleshapes.code.tex
+File: pgfmoduleshapes.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgfnodeparttextbox=\box58
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmoduleplot.code.tex
+File: pgfmoduleplot.code.tex 2023-01-15 v3.1.10 (3.1.10)
+) (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-0-65.sty
+Package: pgfcomp-version-0-65 2023-01-15 v3.1.10 (3.1.10)
+\pgf@nodesepstart=\dimen180
+\pgf@nodesepend=\dimen181
+) (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/compatibility/pgfcomp-version-1-18.sty
+Package: pgfcomp-version-1-18 2023-01-15 v3.1.10 (3.1.10)
+)) (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgffor.sty (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/utilities/pgfkeys.sty (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgfkeys.code.tex)) (/usr/local/texlive/2023/texmf-dist/tex/latex/pgf/math/pgfmath.sty (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/math/pgfmath.code.tex)) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/utilities/pgffor.code.tex
+Package: pgffor 2023-01-15 v3.1.10 (3.1.10)
+\pgffor@iter=\dimen182
+\pgffor@skip=\dimen183
+\pgffor@stack=\toks28
+\pgffor@toks=\toks29
+)) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/tikz.code.tex
+Package: tikz 2023-01-15 v3.1.10 (3.1.10)
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryplothandlers.code.tex
+File: pgflibraryplothandlers.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgf@plot@mark@count=\count274
+\pgfplotmarksize=\dimen184
+)
+\tikz@lastx=\dimen185
+\tikz@lasty=\dimen186
+\tikz@lastxsaved=\dimen187
+\tikz@lastysaved=\dimen188
+\tikz@lastmovetox=\dimen189
+\tikz@lastmovetoy=\dimen190
+\tikzleveldistance=\dimen191
+\tikzsiblingdistance=\dimen192
+\tikz@figbox=\box59
+\tikz@figbox@bg=\box60
+\tikz@tempbox=\box61
+\tikz@tempbox@bg=\box62
+\tikztreelevel=\count275
+\tikznumberofchildren=\count276
+\tikznumberofcurrentchild=\count277
+\tikz@fig@count=\count278
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmodulematrix.code.tex
+File: pgfmodulematrix.code.tex 2023-01-15 v3.1.10 (3.1.10)
+\pgfmatrixcurrentrow=\count279
+\pgfmatrixcurrentcolumn=\count280
+\pgf@matrix@numberofcolumns=\count281
+)
+\tikz@expandcount=\count282
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarytopaths.code.tex
+File: tikzlibrarytopaths.code.tex 2023-01-15 v3.1.10 (3.1.10)
+))) (/usr/local/texlive/2023/texmf-dist/tex/latex/pgfplots/pgfplots.sty (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.revision.tex)
+Package: pgfplots 2021/05/15 v1.18.1 Data Visualization (1.18.1)
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotscore.code.tex
+\t@pgfplots@toka=\toks30
+\t@pgfplots@tokb=\toks31
+\t@pgfplots@tokc=\toks32
+\pgfplots@tmpa=\dimen193
+\c@pgfplots@coordindex=\count283
+\c@pgfplots@scanlineindex=\count284
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/sys/pgfplotssysgeneric.code.tex)) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/pgfplotslibrary.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/oldpgfcompatib/pgfplotsoldpgfsupp_loader.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryfpu.code.tex)
+Package pgfplots: loading complementary utilities for your pgf version...
+\t@pgf@toka=\toks33
+\t@pgf@tokb=\toks34
+\t@pgf@tokc=\toks35
+(/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/oldpgfcompatib/pgfplotsoldpgfsupp_pgfutil-common-lists.tex)) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsutil.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsliststructure.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsliststructureext.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsarray.code.tex
+\c@pgfplotsarray@tmp=\count285
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsmatrix.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/numtable/pgfplotstableshared.code.tex
+\c@pgfplotstable@counta=\count286
+\t@pgfplotstable@a=\toks36
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/liststructure/pgfplotsdeque.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsbinary.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsbinary.data.code.tex)) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotsutil.verb.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/pgflibrarypgfplots.surfshading.code.tex
+\c@pgfplotslibrarysurf@no=\count287
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/sys/pgflibrarypgfplots.surfshading.pgfsys-pdftex.def))) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotscolormap.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/util/pgfplotscolor.code.tex)) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsstackedplots.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsplothandlers.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsmeshplothandler.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsmeshplotimage.code.tex))) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.scaling.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotscoordprocessing.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.errorbars.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.markers.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplotsticks.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/pgfplots.paths.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/modules/pgfmoduledecorations.code.tex
+\pgfdecoratedcompleteddistance=\dimen194
+\pgfdecoratedremainingdistance=\dimen195
+\pgfdecoratedinputsegmentcompleteddistance=\dimen196
+\pgfdecoratedinputsegmentremainingdistance=\dimen197
+\pgf@decorate@distancetomove=\dimen198
+\pgf@decorate@repeatstate=\count288
+\pgfdecorationsegmentamplitude=\dimen199
+\pgfdecorationsegmentlength=\dimen256
+)
+\tikz@lib@dec@box=\box63
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.pathmorphing.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/decorations/pgflibrarydecorations.pathmorphing.code.tex)) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibrarydecorations.pathreplacing.code.tex (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/decorations/pgflibrarydecorations.pathreplacing.code.tex)) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/tikzlibrarypgfplots.contourlua.code.tex)
+\pgfplots@numplots=\count289
+\pgfplots@xmin@reg=\dimen257
+\pgfplots@xmax@reg=\dimen258
+\pgfplots@ymin@reg=\dimen259
+\pgfplots@ymax@reg=\dimen260
+\pgfplots@zmin@reg=\dimen261
+\pgfplots@zmax@reg=\dimen262
+) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/frontendlayer/tikz/libraries/tikzlibraryplotmarks.code.tex
+File: tikzlibraryplotmarks.code.tex 2023-01-15 v3.1.10 (3.1.10)
+ (/usr/local/texlive/2023/texmf-dist/tex/generic/pgf/libraries/pgflibraryplotmarks.code.tex
+File: pgflibraryplotmarks.code.tex 2023-01-15 v3.1.10 (3.1.10)
+))) (/usr/local/texlive/2023/texmf-dist/tex/generic/pgfplots/libs/tikzlibrarypgfplots.colormaps.code.tex) (/usr/local/texlive/2023/texmf-dist/tex/latex/l3backend/l3backend-pdftex.def
+File: l3backend-pdftex.def 2023-01-16 L3 backend support: PDF output (pdfTeX)
+\l__color_backend_stack_int=\count290
+\l__pdf_internal_box=\box64
+) (./dataAdaptiveErrorElementwise.aux)
+\openout1 = `dataAdaptiveErrorElementwise.aux'.
+
+LaTeX Font Info:    Checking defaults for OML/cmm/m/it on input line 15.
+LaTeX Font Info:    ... okay on input line 15.
+LaTeX Font Info:    Checking defaults for OMS/cmsy/m/n on input line 15.
+LaTeX Font Info:    ... okay on input line 15.
+LaTeX Font Info:    Checking defaults for OT1/cmr/m/n on input line 15.
+LaTeX Font Info:    ... okay on input line 15.
+LaTeX Font Info:    Checking defaults for T1/cmr/m/n on input line 15.
+LaTeX Font Info:    ... okay on input line 15.
+LaTeX Font Info:    Checking defaults for TS1/cmr/m/n on input line 15.
+LaTeX Font Info:    ... okay on input line 15.
+LaTeX Font Info:    Checking defaults for OMX/cmex/m/n on input line 15.
+LaTeX Font Info:    ... okay on input line 15.
+LaTeX Font Info:    Checking defaults for U/cmr/m/n on input line 15.
+LaTeX Font Info:    ... okay on input line 15.
+ (/usr/local/texlive/2023/texmf-dist/tex/context/base/mkii/supp-pdf.mkii
+[Loading MPS to PDF converter (version 2006.09.02).]
+\scratchcounter=\count291
+\scratchdimen=\dimen263
+\scratchbox=\box65
+\nofMPsegments=\count292
+\nofMParguments=\count293
+\everyMPshowfont=\toks37
+\MPscratchCnt=\count294
+\MPscratchDim=\dimen264
+\MPnumerator=\count295
+\makeMPintoPDFobject=\count296
+\everyMPtoPDFconversion=\toks38
+) (/usr/local/texlive/2023/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty
+Package: epstopdf-base 2020-01-24 v2.11 Base part for package epstopdf
+Package epstopdf-base Info: Redefining graphics rule for `.eps' on input line 485.
+ (/usr/local/texlive/2023/texmf-dist/tex/latex/latexconfig/epstopdf-sys.cfg
+File: epstopdf-sys.cfg 2010/07/13 v1.3 Configuration of (r)epstopdf for TeX Live
+))
+
+Package pgfplots Warning: running in backwards compatibility mode (unsuitable tick labels; missing features). Consider writing \pgfplotsset{compat=1.18} into your preamble.
+ on input line 15.
+
+[1
+
+] (./dataAdaptiveErrorElementwise.aux) ) 
+Here is how much of TeX's memory you used:
+ 23697 strings out of 476025
+ 624936 string characters out of 5790017
+ 1888388 words of memory out of 5000000
+ 43819 multiletter control sequences out of 15000+600000
+ 512287 words of font info for 32 fonts, out of 8000000 for 9000
+ 1141 hyphenation exceptions out of 8191
+ 102i,5n,104p,774b,609s stack positions out of 10000i,1000n,20000p,200000b,200000s
+
+Output written on dataAdaptiveErrorElementwise.pdf (1 page, 4928 bytes).
+PDF statistics:
+ 11 PDF objects out of 1000 (max. 8388607)
+ 7 compressed objects within 1 object stream
+ 0 named destinations out of 1000 (max. 500000)
+ 13 words of extra memory for PDF output out of 10000 (max. 10000000)
+
diff --git a/experiments/dataAdaptiveErrorElementwise.synctex.gz b/experiments/dataAdaptiveErrorElementwise.synctex.gz
new file mode 100644
index 0000000000000000000000000000000000000000..303e2d2bcd302b5d5ac05a0f5b37ff3e81fd4e0a
Binary files /dev/null and b/experiments/dataAdaptiveErrorElementwise.synctex.gz differ
diff --git a/experiments/dataAdaptiveErrorElementwise.tex b/experiments/dataAdaptiveErrorElementwise.tex
new file mode 100644
index 0000000000000000000000000000000000000000..4f8b1bd0d056ee0c99e625ec7fd8c144b9d669f7
--- /dev/null
+++ b/experiments/dataAdaptiveErrorElementwise.tex
@@ -0,0 +1,1116 @@
+\documentclass{standalone}
+
+\usepackage{tikz} 
+ 
+ \usepackage{pgfplots}
+
+\usepackage{xcolor} 
+ 
+ \definecolor{cobalt}{RGB}{0,102,153} 
+
+ \definecolor{cobaltred}{RGB}{255, 255,255}  
+ 
+\usepgfplotslibrary{colormaps} 
+ 
+ \begin{document} 
+
+ \begin{tikzpicture} 
+ 
+\tikzset{meshStyle/.style={very thin, lightgray}}
+
+\coordinate (P1) at (-1,-1);
+\coordinate (P2) at (0,-1);
+\coordinate (P3) at (-0.5,-0.5);
+\coordinate (P4) at (-1,0);
+\coordinate (P5) at (0,0);
+\coordinate (P6) at (1,0);
+\coordinate (P7) at (-0.5,0.5);
+\coordinate (P8) at (0.5,0.5);
+\coordinate (P9) at (-1,1);
+\coordinate (P10) at (0,1);
+\coordinate (P11) at (1,1);
+\coordinate (P12) at (-0.5,-1);
+\coordinate (P13) at (-0.75,-0.75);
+\coordinate (P14) at (-1,-0.5);
+\coordinate (P15) at (-0.25,-0.75);
+\coordinate (P16) at (0,-0.5);
+\coordinate (P17) at (-0.75,-0.25);
+\coordinate (P18) at (-0.25,-0.25);
+\coordinate (P19) at (-0.5,0);
+\coordinate (P20) at (-0.75,0.25);
+\coordinate (P21) at (-1,0.5);
+\coordinate (P22) at (0.5,0);
+\coordinate (P23) at (-0.25,0.25);
+\coordinate (P24) at (0.25,0.25);
+\coordinate (P25) at (0,0.5);
+\coordinate (P26) at (0.75,0.25);
+\coordinate (P27) at (1,0.5);
+\coordinate (P28) at (-0.75,0.75);
+\coordinate (P29) at (-0.25,0.75);
+\coordinate (P30) at (0.25,0.75);
+\coordinate (P31) at (0.75,0.75);
+\coordinate (P32) at (-0.5,1);
+\coordinate (P33) at (0.5,1);
+\coordinate (P34) at (0,-0.25);
+\coordinate (P35) at (-0.125,-0.125);
+\coordinate (P36) at (-0.25,0);
+\coordinate (P37) at (0.25,0);
+\coordinate (P38) at (-0.125,0.125);
+\coordinate (P39) at (0.125,0.125);
+\coordinate (P40) at (0,0.25);
+\coordinate (P41) at (-0.5,-0.25);
+\coordinate (P42) at (-0.5,0.25);
+\coordinate (P43) at (-0.25,0.5);
+\coordinate (P44) at (0.25,0.5);
+\coordinate (P45) at (-0.375,-0.125);
+\coordinate (P46) at (-0.125,0.375);
+\coordinate (P47) at (-0.375,0.125);
+\coordinate (P48) at (0.125,0.375);
+\coordinate (P49) at (0,-0.375);
+\coordinate (P50) at (0,-0.125);
+\coordinate (P51) at (-0.0625,-0.0625);
+\coordinate (P52) at (-0.1875,-0.1875);
+\coordinate (P53) at (-0.375,-0.375);
+\coordinate (P54) at (-0.125,0);
+\coordinate (P55) at (0.125,0);
+\coordinate (P56) at (-0.0625,0.0625);
+\coordinate (P57) at (-0.1875,0.1875);
+\coordinate (P58) at (0.0625,0.0625);
+\coordinate (P59) at (0,0.125);
+\coordinate (P60) at (-0.25,-0.5);
+\coordinate (P61) at (-0.125,-0.375);
+\coordinate (P62) at (-0.125,-0.25);
+\coordinate (P63) at (-0.0625,-0.1875);
+\coordinate (P64) at (-0.25,-0.125);
+\coordinate (P65) at (-0.25,0.125);
+\coordinate (P66) at (-0.125,0.25);
+\coordinate (P67) at (0.125,0.25);
+\coordinate (P68) at (-0.1875,-0.0625);
+\coordinate (P69) at (-0.0625,0.1875);
+\coordinate (P70) at (-0.1875,0.0625);
+\coordinate (P71) at (0.0625,0.1875);
+\coordinate (P72) at (-0.25,-1);
+\coordinate (P73) at (-1,-0.25);
+\coordinate (P74) at (-0.125,-0.875);
+\coordinate (P75) at (-0.375,-0.625);
+\coordinate (P76) at (0,-0.75);
+\coordinate (P77) at (0,-0.0625);
+\coordinate (P78) at (-0.875,-0.125);
+\coordinate (P79) at (-0.03125,-0.03125);
+\coordinate (P80) at (-0.0625,0);
+\coordinate (P81) at (-0.75,0);
+\coordinate (P82) at (-0.625,0.375);
+\coordinate (P83) at (-0.875,0.125);
+\coordinate (P84) at (-1,0.25);
+\coordinate (P85) at (0.0625,0);
+\coordinate (P86) at (0.375,0);
+\coordinate (P87) at (0.75,0);
+\coordinate (P88) at (-0.03125,0.03125);
+\coordinate (P89) at (-0.09375,0.09375);
+\coordinate (P90) at (0.375,0.375);
+\coordinate (P91) at (0.1875,0.1875);
+\coordinate (P92) at (0.03125,0.03125);
+\coordinate (P93) at (0,0.0625);
+\coordinate (P94) at (0,0.75);
+\coordinate (P95) at (0.625,0.375);
+\coordinate (P96) at (1,0.25);
+\coordinate (P97) at (-0.125,0.875);
+\coordinate (P98) at (-0.375,0.625);
+\coordinate (P99) at (0.125,0.875);
+\coordinate (P100) at (-0.25,1);
+\coordinate (P101) at (0.25,1);
+\coordinate (P102) at (-0.5,-0.75);
+\coordinate (P103) at (-0.5,0.75);
+\coordinate (P104) at (-0.75,0.5);
+\coordinate (P105) at (0.5,0.25);
+\coordinate (P106) at (0.75,0.5);
+\coordinate (P107) at (-0.125,-0.625);
+\coordinate (P108) at (-0.625,0.125);
+\coordinate (P109) at (-0.375,0.875);
+\coordinate (P110) at (0.375,0.125);
+\coordinate (P111) at (0.875,0.375);
+\coordinate (P112) at (0.125,0.625);
+\coordinate (P113) at (-0.375,-0.875);
+\coordinate (P114) at (-0.625,-0.125);
+\coordinate (P115) at (-0.125,0.625);
+\coordinate (P116) at (-0.875,0.375);
+\coordinate (P117) at (0.625,0.125);
+\coordinate (P118) at (0.25,0.125);
+\coordinate (P119) at (0.1875,0.0625);
+\coordinate (P120) at (-0.125,-0.0625);
+\coordinate (P121) at (-0.125,0.0625);
+\coordinate (P122) at (-0.0625,0.125);
+\coordinate (P123) at (0.0625,0.125);
+\coordinate (P124) at (-0.09375,-0.03125);
+\coordinate (P125) at (-0.03125,0.09375);
+\coordinate (P126) at (-0.09375,0.03125);
+\coordinate (P127) at (0.03125,0.09375);
+
+\draw[meshStyle, fill=cobalt!8.491053!white] (P13) -- (P12) -- (P102) -- cycle;
+\draw[meshStyle, fill=cobalt!9.722384!white] (P3) -- (P13) -- (P102) -- cycle;
+\draw[meshStyle, fill=cobalt!15.288825!white] (P1) -- (P12) -- (P13) -- cycle;
+\draw[meshStyle, fill=cobalt!0.922383!white] (P72) -- (P15) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!0.695998!white] (P12) -- (P72) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!1.394815!white] (P72) -- (P2) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!1.634300!white] (P15) -- (P72) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!2.951311!white] (P102) -- (P15) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!7.326436!white] (P3) -- (P102) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!0.807473!white] (P102) -- (P12) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!1.652228!white] (P15) -- (P102) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!5.512852!white] (P60) -- (P15) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!5.492995!white] (P16) -- (P60) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!4.974787!white] (P60) -- (P3) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!3.183929!white] (P15) -- (P60) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!1.375170!white] (P76) -- (P15) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!1.181359!white] (P2) -- (P76) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!4.097447!white] (P76) -- (P16) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!4.291259!white] (P15) -- (P76) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!10.073165!white] (P61) -- (P34) -- (P62) -- cycle;
+\draw[meshStyle, fill=cobalt!8.833511!white] (P18) -- (P61) -- (P62) -- cycle;
+\draw[meshStyle, fill=cobalt!5.362248!white] (P61) -- (P16) -- (P49) -- cycle;
+\draw[meshStyle, fill=cobalt!8.735504!white] (P34) -- (P61) -- (P49) -- cycle;
+\draw[meshStyle, fill=cobalt!7.210653!white] (P50) -- (P35) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!5.205007!white] (P34) -- (P50) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!11.370608!white] (P51) -- (P50) -- (P77) -- cycle;
+\draw[meshStyle, fill=cobalt!8.034708!white] (P77) -- (P5) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!10.986971!white] (P51) -- (P77) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!16.338518!white] (P35) -- (P50) -- (P51) -- cycle;
+\draw[meshStyle, fill=cobalt!3.042639!white] (P62) -- (P35) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!4.229262!white] (P18) -- (P62) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!5.207202!white] (P62) -- (P34) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!8.360089!white] (P35) -- (P62) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!8.741842!white] (P60) -- (P18) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!4.134332!white] (P3) -- (P60) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!16.091279!white] (P60) -- (P16) -- (P61) -- cycle;
+\draw[meshStyle, fill=cobalt!16.847849!white] (P18) -- (P60) -- (P61) -- cycle;
+\draw[meshStyle, fill=cobalt!18.296624!white] (P41) -- (P18) -- (P45) -- cycle;
+\draw[meshStyle, fill=cobalt!16.077804!white] (P19) -- (P41) -- (P45) -- cycle;
+\draw[meshStyle, fill=cobalt!9.055621!white] (P41) -- (P3) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!17.819764!white] (P18) -- (P41) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!7.148319!white] (P64) -- (P35) -- (P68) -- cycle;
+\draw[meshStyle, fill=cobalt!7.629561!white] (P36) -- (P64) -- (P68) -- cycle;
+\draw[meshStyle, fill=cobalt!2.526222!white] (P64) -- (P18) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!5.214310!white] (P35) -- (P64) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!1.121486!white] (P120) -- (P51) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!1.499946!white] (P54) -- (P120) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!7.941756!white] (P35) -- (P51) -- (P120) -- cycle;
+\draw[meshStyle, fill=cobalt!13.652102!white] (P80) -- (P51) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!75.592392!white] (P5) -- (P80) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!4.789980!white] (P80) -- (P54) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!4.531658!white] (P51) -- (P80) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!7.885778!white] (P54) -- (P36) -- (P68) -- cycle;
+\draw[meshStyle, fill=cobalt!7.395207!white] (P68) -- (P35) -- (P120) -- cycle;
+\draw[meshStyle, fill=cobalt!6.938049!white] (P54) -- (P68) -- (P120) -- cycle;
+\draw[meshStyle, fill=cobalt!24.877416!white] (P36) -- (P19) -- (P45) -- cycle;
+\draw[meshStyle, fill=cobalt!11.331669!white] (P45) -- (P18) -- (P64) -- cycle;
+\draw[meshStyle, fill=cobalt!21.491716!white] (P36) -- (P45) -- (P64) -- cycle;
+\draw[meshStyle, fill=cobalt!2.056299!white] (P81) -- (P17) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!7.447252!white] (P19) -- (P81) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!2.936599!white] (P81) -- (P4) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!2.343593!white] (P17) -- (P81) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!32.115104!white] (P17) -- (P3) -- (P41) -- cycle;
+\draw[meshStyle, fill=cobalt!15.010582!white] (P41) -- (P19) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!10.515097!white] (P17) -- (P41) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!37.766496!white] (P14) -- (P3) -- (P17) -- cycle;
+\draw[meshStyle, fill=cobalt!3.802453!white] (P73) -- (P17) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!0.015332!white] (P4) -- (P73) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!7.729369!white] (P14) -- (P17) -- (P73) -- cycle;
+\draw[meshStyle, fill=cobalt!11.384914!white] (P14) -- (P1) -- (P13) -- cycle;
+\draw[meshStyle, fill=cobalt!30.003981!white] (P3) -- (P14) -- (P13) -- cycle;
+\draw[meshStyle, fill=cobalt!5.470840!white] (P42) -- (P20) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!6.701113!white] (P19) -- (P42) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!8.660664!white] (P42) -- (P7) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!8.521421!white] (P20) -- (P42) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!2.244809!white] (P81) -- (P20) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!3.528680!white] (P4) -- (P81) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!9.755168!white] (P81) -- (P19) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!3.673351!white] (P20) -- (P81) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!16.436585!white] (P47) -- (P36) -- (P65) -- cycle;
+\draw[meshStyle, fill=cobalt!11.901687!white] (P23) -- (P47) -- (P65) -- cycle;
+\draw[meshStyle, fill=cobalt!25.303540!white] (P19) -- (P36) -- (P47) -- cycle;
+\draw[meshStyle, fill=cobalt!6.219960!white] (P70) -- (P54) -- (P121) -- cycle;
+\draw[meshStyle, fill=cobalt!3.446707!white] (P38) -- (P70) -- (P121) -- cycle;
+\draw[meshStyle, fill=cobalt!10.106166!white] (P36) -- (P54) -- (P70) -- cycle;
+\draw[meshStyle, fill=cobalt!3.889423!white] (P80) -- (P56) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!6.808460!white] (P54) -- (P80) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!100.000000!white] (P80) -- (P5) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!35.398996!white] (P56) -- (P80) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!2.888255!white] (P121) -- (P56) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!1.970253!white] (P38) -- (P121) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!4.692596!white] (P121) -- (P54) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!1.851772!white] (P56) -- (P121) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!3.823246!white] (P65) -- (P38) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!3.364392!white] (P23) -- (P65) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!15.219297!white] (P65) -- (P36) -- (P70) -- cycle;
+\draw[meshStyle, fill=cobalt!9.527346!white] (P38) -- (P65) -- (P70) -- cycle;
+\draw[meshStyle, fill=cobalt!38.865709!white] (P23) -- (P7) -- (P42) -- cycle;
+\draw[meshStyle, fill=cobalt!18.847853!white] (P42) -- (P19) -- (P47) -- cycle;
+\draw[meshStyle, fill=cobalt!23.323464!white] (P23) -- (P42) -- (P47) -- cycle;
+\draw[meshStyle, fill=cobalt!23.110146!white] (P43) -- (P23) -- (P46) -- cycle;
+\draw[meshStyle, fill=cobalt!18.580810!white] (P25) -- (P43) -- (P46) -- cycle;
+\draw[meshStyle, fill=cobalt!38.899931!white] (P7) -- (P23) -- (P43) -- cycle;
+\draw[meshStyle, fill=cobalt!9.379806!white] (P66) -- (P38) -- (P69) -- cycle;
+\draw[meshStyle, fill=cobalt!15.009735!white] (P40) -- (P66) -- (P69) -- cycle;
+\draw[meshStyle, fill=cobalt!3.364537!white] (P66) -- (P23) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!3.824091!white] (P38) -- (P66) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!1.879347!white] (P122) -- (P56) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!4.643390!white] (P59) -- (P122) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!1.971055!white] (P122) -- (P38) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!2.923867!white] (P56) -- (P122) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!35.340964!white] (P93) -- (P56) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!99.893894!white] (P5) -- (P93) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!7.009088!white] (P93) -- (P59) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!3.823356!white] (P56) -- (P93) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!9.881019!white] (P59) -- (P40) -- (P69) -- cycle;
+\draw[meshStyle, fill=cobalt!3.401231!white] (P69) -- (P38) -- (P122) -- cycle;
+\draw[meshStyle, fill=cobalt!6.123676!white] (P59) -- (P69) -- (P122) -- cycle;
+\draw[meshStyle, fill=cobalt!24.920458!white] (P40) -- (P25) -- (P46) -- cycle;
+\draw[meshStyle, fill=cobalt!11.740735!white] (P46) -- (P23) -- (P66) -- cycle;
+\draw[meshStyle, fill=cobalt!16.251597!white] (P40) -- (P46) -- (P66) -- cycle;
+\draw[meshStyle, fill=cobalt!3.623420!white] (P94) -- (P29) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!10.340095!white] (P25) -- (P94) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!3.763183!white] (P94) -- (P10) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!2.153612!white] (P29) -- (P94) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!8.490943!white] (P43) -- (P29) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!8.646098!white] (P7) -- (P43) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!6.571413!white] (P43) -- (P25) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!5.517126!white] (P29) -- (P43) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!1.627512!white] (P103) -- (P29) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!2.881933!white] (P32) -- (P103) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!4.904814!white] (P103) -- (P7) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!5.052183!white] (P29) -- (P103) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!1.304336!white] (P100) -- (P29) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!0.314725!white] (P10) -- (P100) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!1.220403!white] (P100) -- (P32) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!2.323291!white] (P29) -- (P100) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!16.244839!white] (P32) -- (P9) -- (P28) -- cycle;
+\draw[meshStyle, fill=cobalt!9.728191!white] (P28) -- (P7) -- (P103) -- cycle;
+\draw[meshStyle, fill=cobalt!6.838257!white] (P32) -- (P28) -- (P103) -- cycle;
+\draw[meshStyle, fill=cobalt!6.904767!white] (P28) -- (P21) -- (P104) -- cycle;
+\draw[meshStyle, fill=cobalt!9.718814!white] (P7) -- (P28) -- (P104) -- cycle;
+\draw[meshStyle, fill=cobalt!16.260376!white] (P9) -- (P21) -- (P28) -- cycle;
+\draw[meshStyle, fill=cobalt!2.354967!white] (P84) -- (P20) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!1.215208!white] (P21) -- (P84) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!0.312062!white] (P84) -- (P4) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!1.321192!white] (P20) -- (P84) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!5.061634!white] (P104) -- (P20) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!4.922766!white] (P7) -- (P104) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!2.922107!white] (P104) -- (P21) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!1.616286!white] (P20) -- (P104) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!15.335353!white] (P105) -- (P24) -- (P110) -- cycle;
+\draw[meshStyle, fill=cobalt!16.636702!white] (P22) -- (P105) -- (P110) -- cycle;
+\draw[meshStyle, fill=cobalt!4.405598!white] (P105) -- (P8) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!7.005709!white] (P24) -- (P105) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!6.835114!white] (P118) -- (P39) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!5.372661!white] (P37) -- (P118) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!6.106250!white] (P118) -- (P24) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!1.696174!white] (P39) -- (P118) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!19.315089!white] (P55) -- (P39) -- (P58) -- cycle;
+\draw[meshStyle, fill=cobalt!10.768562!white] (P85) -- (P58) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!7.910471!white] (P5) -- (P85) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!12.159878!white] (P55) -- (P58) -- (P85) -- cycle;
+\draw[meshStyle, fill=cobalt!5.292809!white] (P55) -- (P37) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!8.459901!white] (P39) -- (P55) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!7.108371!white] (P110) -- (P37) -- (P86) -- cycle;
+\draw[meshStyle, fill=cobalt!6.261557!white] (P22) -- (P110) -- (P86) -- cycle;
+\draw[meshStyle, fill=cobalt!11.767949!white] (P110) -- (P24) -- (P118) -- cycle;
+\draw[meshStyle, fill=cobalt!8.314243!white] (P37) -- (P110) -- (P118) -- cycle;
+\draw[meshStyle, fill=cobalt!6.138898!white] (P87) -- (P26) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!4.289883!white] (P22) -- (P87) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!10.012450!white] (P6) -- (P26) -- (P87) -- cycle;
+\draw[meshStyle, fill=cobalt!2.383681!white] (P105) -- (P26) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!4.919243!white] (P8) -- (P105) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!6.008568!white] (P105) -- (P22) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!5.234754!white] (P26) -- (P105) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!2.676673!white] (P106) -- (P26) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!1.766352!white] (P27) -- (P106) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!7.382722!white] (P106) -- (P8) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!2.859634!white] (P26) -- (P106) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!8.334976!white] (P26) -- (P6) -- (P96) -- cycle;
+\draw[meshStyle, fill=cobalt!1.396771!white] (P96) -- (P27) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!1.264958!white] (P26) -- (P96) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!15.410698!white] (P27) -- (P11) -- (P31) -- cycle;
+\draw[meshStyle, fill=cobalt!10.161469!white] (P31) -- (P8) -- (P106) -- cycle;
+\draw[meshStyle, fill=cobalt!8.737881!white] (P27) -- (P31) -- (P106) -- cycle;
+\draw[meshStyle, fill=cobalt!30.783399!white] (P33) -- (P8) -- (P31) -- cycle;
+\draw[meshStyle, fill=cobalt!11.483459!white] (P11) -- (P33) -- (P31) -- cycle;
+\draw[meshStyle, fill=cobalt!8.056717!white] (P30) -- (P33) -- (P101) -- cycle;
+\draw[meshStyle, fill=cobalt!0.000000!white] (P101) -- (P10) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!4.000255!white] (P30) -- (P101) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!38.269279!white] (P8) -- (P33) -- (P30) -- cycle;
+\draw[meshStyle, fill=cobalt!10.756670!white] (P44) -- (P30) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!15.403740!white] (P25) -- (P44) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!32.395533!white] (P8) -- (P30) -- (P44) -- cycle;
+\draw[meshStyle, fill=cobalt!2.200289!white] (P94) -- (P30) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!3.167476!white] (P10) -- (P94) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!7.996605!white] (P94) -- (P25) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!1.922313!white] (P30) -- (P94) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!21.502835!white] (P48) -- (P40) -- (P67) -- cycle;
+\draw[meshStyle, fill=cobalt!10.518957!white] (P24) -- (P48) -- (P67) -- cycle;
+\draw[meshStyle, fill=cobalt!24.681125!white] (P25) -- (P40) -- (P48) -- cycle;
+\draw[meshStyle, fill=cobalt!6.397044!white] (P71) -- (P59) -- (P123) -- cycle;
+\draw[meshStyle, fill=cobalt!6.621833!white] (P39) -- (P71) -- (P123) -- cycle;
+\draw[meshStyle, fill=cobalt!7.453914!white] (P40) -- (P59) -- (P71) -- cycle;
+\draw[meshStyle, fill=cobalt!4.681438!white] (P93) -- (P58) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!4.996123!white] (P59) -- (P93) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!75.362049!white] (P93) -- (P5) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!13.680165!white] (P58) -- (P93) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!7.978324!white] (P58) -- (P39) -- (P123) -- cycle;
+\draw[meshStyle, fill=cobalt!1.739519!white] (P123) -- (P59) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!0.657834!white] (P58) -- (P123) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!7.074284!white] (P67) -- (P39) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!2.198364!white] (P24) -- (P67) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!7.433268!white] (P67) -- (P40) -- (P71) -- cycle;
+\draw[meshStyle, fill=cobalt!8.065299!white] (P39) -- (P67) -- (P71) -- cycle;
+\draw[meshStyle, fill=cobalt!17.829876!white] (P44) -- (P24) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!9.085265!white] (P8) -- (P44) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!16.722169!white] (P44) -- (P25) -- (P48) -- cycle;
+\draw[meshStyle, fill=cobalt!18.106212!white] (P24) -- (P44) -- (P48) -- cycle;
+\end{tikzpicture} 
+
+ \end{document} 
+ 
+\documentclass{standalone}
+
+\usepackage{tikz} 
+ 
+ \usepackage{pgfplots}
+
+\usepackage{xcolor} 
+ 
+ \definecolor{cobalt}{RGB}{0,102,153} 
+
+ \definecolor{cobaltred}{RGB}{255, 255,255}  
+ 
+\usepgfplotslibrary{colormaps} 
+ 
+ \begin{document} 
+
+ \begin{tikzpicture} 
+ 
+\tikzset{meshStyle/.style={very thin, lightgray}}
+
+\coordinate (P1) at (-1,-1);
+\coordinate (P2) at (0,-1);
+\coordinate (P3) at (-0.5,-0.5);
+\coordinate (P4) at (-1,0);
+\coordinate (P5) at (0,0);
+\coordinate (P6) at (1,0);
+\coordinate (P7) at (-0.5,0.5);
+\coordinate (P8) at (0.5,0.5);
+\coordinate (P9) at (-1,1);
+\coordinate (P10) at (0,1);
+\coordinate (P11) at (1,1);
+\coordinate (P12) at (-0.5,-1);
+\coordinate (P13) at (-0.75,-0.75);
+\coordinate (P14) at (-1,-0.5);
+\coordinate (P15) at (-0.25,-0.75);
+\coordinate (P16) at (0,-0.5);
+\coordinate (P17) at (-0.75,-0.25);
+\coordinate (P18) at (-0.25,-0.25);
+\coordinate (P19) at (-0.5,0);
+\coordinate (P20) at (-0.75,0.25);
+\coordinate (P21) at (-1,0.5);
+\coordinate (P22) at (0.5,0);
+\coordinate (P23) at (-0.25,0.25);
+\coordinate (P24) at (0.25,0.25);
+\coordinate (P25) at (0,0.5);
+\coordinate (P26) at (0.75,0.25);
+\coordinate (P27) at (1,0.5);
+\coordinate (P28) at (-0.75,0.75);
+\coordinate (P29) at (-0.25,0.75);
+\coordinate (P30) at (0.25,0.75);
+\coordinate (P31) at (0.75,0.75);
+\coordinate (P32) at (-0.5,1);
+\coordinate (P33) at (0.5,1);
+\coordinate (P34) at (0,-0.25);
+\coordinate (P35) at (-0.125,-0.125);
+\coordinate (P36) at (-0.25,0);
+\coordinate (P37) at (0.25,0);
+\coordinate (P38) at (-0.125,0.125);
+\coordinate (P39) at (0.125,0.125);
+\coordinate (P40) at (0,0.25);
+\coordinate (P41) at (-0.5,-0.25);
+\coordinate (P42) at (-0.5,0.25);
+\coordinate (P43) at (-0.25,0.5);
+\coordinate (P44) at (0.25,0.5);
+\coordinate (P45) at (-0.375,-0.125);
+\coordinate (P46) at (-0.125,0.375);
+\coordinate (P47) at (-0.375,0.125);
+\coordinate (P48) at (0.125,0.375);
+\coordinate (P49) at (0,-0.375);
+\coordinate (P50) at (0,-0.125);
+\coordinate (P51) at (-0.0625,-0.0625);
+\coordinate (P52) at (-0.1875,-0.1875);
+\coordinate (P53) at (-0.375,-0.375);
+\coordinate (P54) at (-0.125,0);
+\coordinate (P55) at (0.125,0);
+\coordinate (P56) at (-0.0625,0.0625);
+\coordinate (P57) at (-0.1875,0.1875);
+\coordinate (P58) at (0.0625,0.0625);
+\coordinate (P59) at (0,0.125);
+\coordinate (P60) at (-0.25,-0.5);
+\coordinate (P61) at (-0.125,-0.375);
+\coordinate (P62) at (-0.125,-0.25);
+\coordinate (P63) at (-0.0625,-0.1875);
+\coordinate (P64) at (-0.25,-0.125);
+\coordinate (P65) at (-0.25,0.125);
+\coordinate (P66) at (-0.125,0.25);
+\coordinate (P67) at (0.125,0.25);
+\coordinate (P68) at (-0.1875,-0.0625);
+\coordinate (P69) at (-0.0625,0.1875);
+\coordinate (P70) at (-0.1875,0.0625);
+\coordinate (P71) at (0.0625,0.1875);
+\coordinate (P72) at (-0.25,-1);
+\coordinate (P73) at (-1,-0.25);
+\coordinate (P74) at (-0.125,-0.875);
+\coordinate (P75) at (-0.375,-0.625);
+\coordinate (P76) at (0,-0.75);
+\coordinate (P77) at (0,-0.0625);
+\coordinate (P78) at (-0.875,-0.125);
+\coordinate (P79) at (-0.03125,-0.03125);
+\coordinate (P80) at (-0.0625,0);
+\coordinate (P81) at (-0.75,0);
+\coordinate (P82) at (-0.625,0.375);
+\coordinate (P83) at (-0.875,0.125);
+\coordinate (P84) at (-1,0.25);
+\coordinate (P85) at (0.0625,0);
+\coordinate (P86) at (0.375,0);
+\coordinate (P87) at (0.75,0);
+\coordinate (P88) at (-0.03125,0.03125);
+\coordinate (P89) at (-0.09375,0.09375);
+\coordinate (P90) at (0.375,0.375);
+\coordinate (P91) at (0.1875,0.1875);
+\coordinate (P92) at (0.03125,0.03125);
+\coordinate (P93) at (0,0.0625);
+\coordinate (P94) at (0,0.75);
+\coordinate (P95) at (0.625,0.375);
+\coordinate (P96) at (1,0.25);
+\coordinate (P97) at (-0.125,0.875);
+\coordinate (P98) at (-0.375,0.625);
+\coordinate (P99) at (0.125,0.875);
+\coordinate (P100) at (-0.25,1);
+\coordinate (P101) at (0.25,1);
+\coordinate (P102) at (-0.5,-0.75);
+\coordinate (P103) at (-0.5,0.75);
+\coordinate (P104) at (-0.75,0.5);
+\coordinate (P105) at (0.5,0.25);
+\coordinate (P106) at (0.75,0.5);
+\coordinate (P107) at (-0.125,-0.625);
+\coordinate (P108) at (-0.625,0.125);
+\coordinate (P109) at (-0.375,0.875);
+\coordinate (P110) at (0.375,0.125);
+\coordinate (P111) at (0.875,0.375);
+\coordinate (P112) at (0.125,0.625);
+\coordinate (P113) at (-0.375,-0.875);
+\coordinate (P114) at (-0.625,-0.125);
+\coordinate (P115) at (-0.125,0.625);
+\coordinate (P116) at (-0.875,0.375);
+\coordinate (P117) at (0.625,0.125);
+\coordinate (P118) at (0.25,0.125);
+\coordinate (P119) at (0.1875,0.0625);
+\coordinate (P120) at (-0.125,-0.0625);
+\coordinate (P121) at (-0.125,0.0625);
+\coordinate (P122) at (-0.0625,0.125);
+\coordinate (P123) at (0.0625,0.125);
+\coordinate (P124) at (-0.09375,-0.03125);
+\coordinate (P125) at (-0.03125,0.09375);
+\coordinate (P126) at (-0.09375,0.03125);
+\coordinate (P127) at (0.03125,0.09375);
+
+\draw[meshStyle, fill=cobalt!8.491053!white] (P13) -- (P12) -- (P102) -- cycle;
+\draw[meshStyle, fill=cobalt!9.722384!white] (P3) -- (P13) -- (P102) -- cycle;
+\draw[meshStyle, fill=cobalt!15.288825!white] (P1) -- (P12) -- (P13) -- cycle;
+\draw[meshStyle, fill=cobalt!0.922383!white] (P72) -- (P15) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!0.695998!white] (P12) -- (P72) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!1.394815!white] (P72) -- (P2) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!1.634300!white] (P15) -- (P72) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!2.951311!white] (P102) -- (P15) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!7.326436!white] (P3) -- (P102) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!0.807473!white] (P102) -- (P12) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!1.652228!white] (P15) -- (P102) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!5.512852!white] (P60) -- (P15) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!5.492995!white] (P16) -- (P60) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!4.974787!white] (P60) -- (P3) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!3.183929!white] (P15) -- (P60) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!1.375170!white] (P76) -- (P15) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!1.181359!white] (P2) -- (P76) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!4.097447!white] (P76) -- (P16) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!4.291259!white] (P15) -- (P76) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!10.073165!white] (P61) -- (P34) -- (P62) -- cycle;
+\draw[meshStyle, fill=cobalt!8.833511!white] (P18) -- (P61) -- (P62) -- cycle;
+\draw[meshStyle, fill=cobalt!5.362248!white] (P61) -- (P16) -- (P49) -- cycle;
+\draw[meshStyle, fill=cobalt!8.735504!white] (P34) -- (P61) -- (P49) -- cycle;
+\draw[meshStyle, fill=cobalt!7.210653!white] (P50) -- (P35) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!5.205007!white] (P34) -- (P50) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!11.370608!white] (P51) -- (P50) -- (P77) -- cycle;
+\draw[meshStyle, fill=cobalt!8.034708!white] (P77) -- (P5) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!10.986971!white] (P51) -- (P77) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!16.338518!white] (P35) -- (P50) -- (P51) -- cycle;
+\draw[meshStyle, fill=cobalt!3.042639!white] (P62) -- (P35) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!4.229262!white] (P18) -- (P62) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!5.207202!white] (P62) -- (P34) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!8.360089!white] (P35) -- (P62) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!8.741842!white] (P60) -- (P18) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!4.134332!white] (P3) -- (P60) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!16.091279!white] (P60) -- (P16) -- (P61) -- cycle;
+\draw[meshStyle, fill=cobalt!16.847849!white] (P18) -- (P60) -- (P61) -- cycle;
+\draw[meshStyle, fill=cobalt!18.296624!white] (P41) -- (P18) -- (P45) -- cycle;
+\draw[meshStyle, fill=cobalt!16.077804!white] (P19) -- (P41) -- (P45) -- cycle;
+\draw[meshStyle, fill=cobalt!9.055621!white] (P41) -- (P3) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!17.819764!white] (P18) -- (P41) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!7.148319!white] (P64) -- (P35) -- (P68) -- cycle;
+\draw[meshStyle, fill=cobalt!7.629561!white] (P36) -- (P64) -- (P68) -- cycle;
+\draw[meshStyle, fill=cobalt!2.526222!white] (P64) -- (P18) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!5.214310!white] (P35) -- (P64) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!1.121486!white] (P120) -- (P51) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!1.499946!white] (P54) -- (P120) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!7.941756!white] (P35) -- (P51) -- (P120) -- cycle;
+\draw[meshStyle, fill=cobalt!13.652102!white] (P80) -- (P51) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!75.592392!white] (P5) -- (P80) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!4.789980!white] (P80) -- (P54) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!4.531658!white] (P51) -- (P80) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!7.885778!white] (P54) -- (P36) -- (P68) -- cycle;
+\draw[meshStyle, fill=cobalt!7.395207!white] (P68) -- (P35) -- (P120) -- cycle;
+\draw[meshStyle, fill=cobalt!6.938049!white] (P54) -- (P68) -- (P120) -- cycle;
+\draw[meshStyle, fill=cobalt!24.877416!white] (P36) -- (P19) -- (P45) -- cycle;
+\draw[meshStyle, fill=cobalt!11.331669!white] (P45) -- (P18) -- (P64) -- cycle;
+\draw[meshStyle, fill=cobalt!21.491716!white] (P36) -- (P45) -- (P64) -- cycle;
+\draw[meshStyle, fill=cobalt!2.056299!white] (P81) -- (P17) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!7.447252!white] (P19) -- (P81) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!2.936599!white] (P81) -- (P4) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!2.343593!white] (P17) -- (P81) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!32.115104!white] (P17) -- (P3) -- (P41) -- cycle;
+\draw[meshStyle, fill=cobalt!15.010582!white] (P41) -- (P19) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!10.515097!white] (P17) -- (P41) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!37.766496!white] (P14) -- (P3) -- (P17) -- cycle;
+\draw[meshStyle, fill=cobalt!3.802453!white] (P73) -- (P17) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!0.015332!white] (P4) -- (P73) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!7.729369!white] (P14) -- (P17) -- (P73) -- cycle;
+\draw[meshStyle, fill=cobalt!11.384914!white] (P14) -- (P1) -- (P13) -- cycle;
+\draw[meshStyle, fill=cobalt!30.003981!white] (P3) -- (P14) -- (P13) -- cycle;
+\draw[meshStyle, fill=cobalt!5.470840!white] (P42) -- (P20) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!6.701113!white] (P19) -- (P42) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!8.660664!white] (P42) -- (P7) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!8.521421!white] (P20) -- (P42) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!2.244809!white] (P81) -- (P20) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!3.528680!white] (P4) -- (P81) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!9.755168!white] (P81) -- (P19) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!3.673351!white] (P20) -- (P81) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!16.436585!white] (P47) -- (P36) -- (P65) -- cycle;
+\draw[meshStyle, fill=cobalt!11.901687!white] (P23) -- (P47) -- (P65) -- cycle;
+\draw[meshStyle, fill=cobalt!25.303540!white] (P19) -- (P36) -- (P47) -- cycle;
+\draw[meshStyle, fill=cobalt!6.219960!white] (P70) -- (P54) -- (P121) -- cycle;
+\draw[meshStyle, fill=cobalt!3.446707!white] (P38) -- (P70) -- (P121) -- cycle;
+\draw[meshStyle, fill=cobalt!10.106166!white] (P36) -- (P54) -- (P70) -- cycle;
+\draw[meshStyle, fill=cobalt!3.889423!white] (P80) -- (P56) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!6.808460!white] (P54) -- (P80) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!100.000000!white] (P80) -- (P5) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!35.398996!white] (P56) -- (P80) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!2.888255!white] (P121) -- (P56) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!1.970253!white] (P38) -- (P121) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!4.692596!white] (P121) -- (P54) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!1.851772!white] (P56) -- (P121) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!3.823246!white] (P65) -- (P38) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!3.364392!white] (P23) -- (P65) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!15.219297!white] (P65) -- (P36) -- (P70) -- cycle;
+\draw[meshStyle, fill=cobalt!9.527346!white] (P38) -- (P65) -- (P70) -- cycle;
+\draw[meshStyle, fill=cobalt!38.865709!white] (P23) -- (P7) -- (P42) -- cycle;
+\draw[meshStyle, fill=cobalt!18.847853!white] (P42) -- (P19) -- (P47) -- cycle;
+\draw[meshStyle, fill=cobalt!23.323464!white] (P23) -- (P42) -- (P47) -- cycle;
+\draw[meshStyle, fill=cobalt!23.110146!white] (P43) -- (P23) -- (P46) -- cycle;
+\draw[meshStyle, fill=cobalt!18.580810!white] (P25) -- (P43) -- (P46) -- cycle;
+\draw[meshStyle, fill=cobalt!38.899931!white] (P7) -- (P23) -- (P43) -- cycle;
+\draw[meshStyle, fill=cobalt!9.379806!white] (P66) -- (P38) -- (P69) -- cycle;
+\draw[meshStyle, fill=cobalt!15.009735!white] (P40) -- (P66) -- (P69) -- cycle;
+\draw[meshStyle, fill=cobalt!3.364537!white] (P66) -- (P23) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!3.824091!white] (P38) -- (P66) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!1.879347!white] (P122) -- (P56) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!4.643390!white] (P59) -- (P122) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!1.971055!white] (P122) -- (P38) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!2.923867!white] (P56) -- (P122) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!35.340964!white] (P93) -- (P56) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!99.893894!white] (P5) -- (P93) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!7.009088!white] (P93) -- (P59) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!3.823356!white] (P56) -- (P93) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!9.881019!white] (P59) -- (P40) -- (P69) -- cycle;
+\draw[meshStyle, fill=cobalt!3.401231!white] (P69) -- (P38) -- (P122) -- cycle;
+\draw[meshStyle, fill=cobalt!6.123676!white] (P59) -- (P69) -- (P122) -- cycle;
+\draw[meshStyle, fill=cobalt!24.920458!white] (P40) -- (P25) -- (P46) -- cycle;
+\draw[meshStyle, fill=cobalt!11.740735!white] (P46) -- (P23) -- (P66) -- cycle;
+\draw[meshStyle, fill=cobalt!16.251597!white] (P40) -- (P46) -- (P66) -- cycle;
+\draw[meshStyle, fill=cobalt!3.623420!white] (P94) -- (P29) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!10.340095!white] (P25) -- (P94) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!3.763183!white] (P94) -- (P10) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!2.153612!white] (P29) -- (P94) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!8.490943!white] (P43) -- (P29) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!8.646098!white] (P7) -- (P43) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!6.571413!white] (P43) -- (P25) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!5.517126!white] (P29) -- (P43) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!1.627512!white] (P103) -- (P29) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!2.881933!white] (P32) -- (P103) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!4.904814!white] (P103) -- (P7) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!5.052183!white] (P29) -- (P103) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!1.304336!white] (P100) -- (P29) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!0.314725!white] (P10) -- (P100) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!1.220403!white] (P100) -- (P32) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!2.323291!white] (P29) -- (P100) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!16.244839!white] (P32) -- (P9) -- (P28) -- cycle;
+\draw[meshStyle, fill=cobalt!9.728191!white] (P28) -- (P7) -- (P103) -- cycle;
+\draw[meshStyle, fill=cobalt!6.838257!white] (P32) -- (P28) -- (P103) -- cycle;
+\draw[meshStyle, fill=cobalt!6.904767!white] (P28) -- (P21) -- (P104) -- cycle;
+\draw[meshStyle, fill=cobalt!9.718814!white] (P7) -- (P28) -- (P104) -- cycle;
+\draw[meshStyle, fill=cobalt!16.260376!white] (P9) -- (P21) -- (P28) -- cycle;
+\draw[meshStyle, fill=cobalt!2.354967!white] (P84) -- (P20) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!1.215208!white] (P21) -- (P84) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!0.312062!white] (P84) -- (P4) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!1.321192!white] (P20) -- (P84) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!5.061634!white] (P104) -- (P20) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!4.922766!white] (P7) -- (P104) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!2.922107!white] (P104) -- (P21) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!1.616286!white] (P20) -- (P104) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!15.335353!white] (P105) -- (P24) -- (P110) -- cycle;
+\draw[meshStyle, fill=cobalt!16.636702!white] (P22) -- (P105) -- (P110) -- cycle;
+\draw[meshStyle, fill=cobalt!4.405598!white] (P105) -- (P8) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!7.005709!white] (P24) -- (P105) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!6.835114!white] (P118) -- (P39) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!5.372661!white] (P37) -- (P118) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!6.106250!white] (P118) -- (P24) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!1.696174!white] (P39) -- (P118) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!19.315089!white] (P55) -- (P39) -- (P58) -- cycle;
+\draw[meshStyle, fill=cobalt!10.768562!white] (P85) -- (P58) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!7.910471!white] (P5) -- (P85) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!12.159878!white] (P55) -- (P58) -- (P85) -- cycle;
+\draw[meshStyle, fill=cobalt!5.292809!white] (P55) -- (P37) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!8.459901!white] (P39) -- (P55) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!7.108371!white] (P110) -- (P37) -- (P86) -- cycle;
+\draw[meshStyle, fill=cobalt!6.261557!white] (P22) -- (P110) -- (P86) -- cycle;
+\draw[meshStyle, fill=cobalt!11.767949!white] (P110) -- (P24) -- (P118) -- cycle;
+\draw[meshStyle, fill=cobalt!8.314243!white] (P37) -- (P110) -- (P118) -- cycle;
+\draw[meshStyle, fill=cobalt!6.138898!white] (P87) -- (P26) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!4.289883!white] (P22) -- (P87) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!10.012450!white] (P6) -- (P26) -- (P87) -- cycle;
+\draw[meshStyle, fill=cobalt!2.383681!white] (P105) -- (P26) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!4.919243!white] (P8) -- (P105) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!6.008568!white] (P105) -- (P22) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!5.234754!white] (P26) -- (P105) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!2.676673!white] (P106) -- (P26) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!1.766352!white] (P27) -- (P106) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!7.382722!white] (P106) -- (P8) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!2.859634!white] (P26) -- (P106) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!8.334976!white] (P26) -- (P6) -- (P96) -- cycle;
+\draw[meshStyle, fill=cobalt!1.396771!white] (P96) -- (P27) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!1.264958!white] (P26) -- (P96) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!15.410698!white] (P27) -- (P11) -- (P31) -- cycle;
+\draw[meshStyle, fill=cobalt!10.161469!white] (P31) -- (P8) -- (P106) -- cycle;
+\draw[meshStyle, fill=cobalt!8.737881!white] (P27) -- (P31) -- (P106) -- cycle;
+\draw[meshStyle, fill=cobalt!30.783399!white] (P33) -- (P8) -- (P31) -- cycle;
+\draw[meshStyle, fill=cobalt!11.483459!white] (P11) -- (P33) -- (P31) -- cycle;
+\draw[meshStyle, fill=cobalt!8.056717!white] (P30) -- (P33) -- (P101) -- cycle;
+\draw[meshStyle, fill=cobalt!0.000000!white] (P101) -- (P10) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!4.000255!white] (P30) -- (P101) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!38.269279!white] (P8) -- (P33) -- (P30) -- cycle;
+\draw[meshStyle, fill=cobalt!10.756670!white] (P44) -- (P30) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!15.403740!white] (P25) -- (P44) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!32.395533!white] (P8) -- (P30) -- (P44) -- cycle;
+\draw[meshStyle, fill=cobalt!2.200289!white] (P94) -- (P30) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!3.167476!white] (P10) -- (P94) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!7.996605!white] (P94) -- (P25) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!1.922313!white] (P30) -- (P94) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!21.502835!white] (P48) -- (P40) -- (P67) -- cycle;
+\draw[meshStyle, fill=cobalt!10.518957!white] (P24) -- (P48) -- (P67) -- cycle;
+\draw[meshStyle, fill=cobalt!24.681125!white] (P25) -- (P40) -- (P48) -- cycle;
+\draw[meshStyle, fill=cobalt!6.397044!white] (P71) -- (P59) -- (P123) -- cycle;
+\draw[meshStyle, fill=cobalt!6.621833!white] (P39) -- (P71) -- (P123) -- cycle;
+\draw[meshStyle, fill=cobalt!7.453914!white] (P40) -- (P59) -- (P71) -- cycle;
+\draw[meshStyle, fill=cobalt!4.681438!white] (P93) -- (P58) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!4.996123!white] (P59) -- (P93) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!75.362049!white] (P93) -- (P5) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!13.680165!white] (P58) -- (P93) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!7.978324!white] (P58) -- (P39) -- (P123) -- cycle;
+\draw[meshStyle, fill=cobalt!1.739519!white] (P123) -- (P59) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!0.657834!white] (P58) -- (P123) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!7.074284!white] (P67) -- (P39) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!2.198364!white] (P24) -- (P67) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!7.433268!white] (P67) -- (P40) -- (P71) -- cycle;
+\draw[meshStyle, fill=cobalt!8.065299!white] (P39) -- (P67) -- (P71) -- cycle;
+\draw[meshStyle, fill=cobalt!17.829876!white] (P44) -- (P24) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!9.085265!white] (P8) -- (P44) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!16.722169!white] (P44) -- (P25) -- (P48) -- cycle;
+\draw[meshStyle, fill=cobalt!18.106212!white] (P24) -- (P44) -- (P48) -- cycle;
+\end{tikzpicture} 
+
+ \end{document} 
+ 
+\documentclass{standalone}
+
+\usepackage{tikz} 
+ 
+ \usepackage{pgfplots}
+
+\usepackage{xcolor} 
+ 
+ \definecolor{cobalt}{RGB}{0,102,153} 
+
+ \definecolor{cobaltred}{RGB}{255, 255,255}  
+ 
+\usepgfplotslibrary{colormaps} 
+ 
+ \begin{document} 
+
+ \begin{tikzpicture} 
+ 
+\tikzset{meshStyle/.style={very thin, lightgray}}
+
+\coordinate (P1) at (-1,-1);
+\coordinate (P2) at (0,-1);
+\coordinate (P3) at (-0.5,-0.5);
+\coordinate (P4) at (-1,0);
+\coordinate (P5) at (0,0);
+\coordinate (P6) at (1,0);
+\coordinate (P7) at (-0.5,0.5);
+\coordinate (P8) at (0.5,0.5);
+\coordinate (P9) at (-1,1);
+\coordinate (P10) at (0,1);
+\coordinate (P11) at (1,1);
+\coordinate (P12) at (-0.5,-1);
+\coordinate (P13) at (-0.75,-0.75);
+\coordinate (P14) at (-1,-0.5);
+\coordinate (P15) at (-0.25,-0.75);
+\coordinate (P16) at (0,-0.5);
+\coordinate (P17) at (-0.75,-0.25);
+\coordinate (P18) at (-0.25,-0.25);
+\coordinate (P19) at (-0.5,0);
+\coordinate (P20) at (-0.75,0.25);
+\coordinate (P21) at (-1,0.5);
+\coordinate (P22) at (0.5,0);
+\coordinate (P23) at (-0.25,0.25);
+\coordinate (P24) at (0.25,0.25);
+\coordinate (P25) at (0,0.5);
+\coordinate (P26) at (0.75,0.25);
+\coordinate (P27) at (1,0.5);
+\coordinate (P28) at (-0.75,0.75);
+\coordinate (P29) at (-0.25,0.75);
+\coordinate (P30) at (0.25,0.75);
+\coordinate (P31) at (0.75,0.75);
+\coordinate (P32) at (-0.5,1);
+\coordinate (P33) at (0.5,1);
+\coordinate (P34) at (0,-0.25);
+\coordinate (P35) at (-0.125,-0.125);
+\coordinate (P36) at (-0.25,0);
+\coordinate (P37) at (0.25,0);
+\coordinate (P38) at (-0.125,0.125);
+\coordinate (P39) at (0.125,0.125);
+\coordinate (P40) at (0,0.25);
+\coordinate (P41) at (-0.5,-0.25);
+\coordinate (P42) at (-0.5,0.25);
+\coordinate (P43) at (-0.25,0.5);
+\coordinate (P44) at (0.25,0.5);
+\coordinate (P45) at (-0.375,-0.125);
+\coordinate (P46) at (-0.125,0.375);
+\coordinate (P47) at (-0.375,0.125);
+\coordinate (P48) at (0.125,0.375);
+\coordinate (P49) at (0,-0.375);
+\coordinate (P50) at (0,-0.125);
+\coordinate (P51) at (-0.0625,-0.0625);
+\coordinate (P52) at (-0.1875,-0.1875);
+\coordinate (P53) at (-0.375,-0.375);
+\coordinate (P54) at (-0.125,0);
+\coordinate (P55) at (0.125,0);
+\coordinate (P56) at (-0.0625,0.0625);
+\coordinate (P57) at (-0.1875,0.1875);
+\coordinate (P58) at (0.0625,0.0625);
+\coordinate (P59) at (0,0.125);
+\coordinate (P60) at (-0.25,-0.5);
+\coordinate (P61) at (-0.125,-0.375);
+\coordinate (P62) at (-0.125,-0.25);
+\coordinate (P63) at (-0.0625,-0.1875);
+\coordinate (P64) at (-0.25,-0.125);
+\coordinate (P65) at (-0.25,0.125);
+\coordinate (P66) at (-0.125,0.25);
+\coordinate (P67) at (0.125,0.25);
+\coordinate (P68) at (-0.1875,-0.0625);
+\coordinate (P69) at (-0.0625,0.1875);
+\coordinate (P70) at (-0.1875,0.0625);
+\coordinate (P71) at (0.0625,0.1875);
+\coordinate (P72) at (-0.25,-1);
+\coordinate (P73) at (-1,-0.25);
+\coordinate (P74) at (-0.125,-0.875);
+\coordinate (P75) at (-0.375,-0.625);
+\coordinate (P76) at (0,-0.75);
+\coordinate (P77) at (0,-0.0625);
+\coordinate (P78) at (-0.875,-0.125);
+\coordinate (P79) at (-0.03125,-0.03125);
+\coordinate (P80) at (-0.0625,0);
+\coordinate (P81) at (-0.75,0);
+\coordinate (P82) at (-0.625,0.375);
+\coordinate (P83) at (-0.875,0.125);
+\coordinate (P84) at (-1,0.25);
+\coordinate (P85) at (0.0625,0);
+\coordinate (P86) at (0.375,0);
+\coordinate (P87) at (0.75,0);
+\coordinate (P88) at (-0.03125,0.03125);
+\coordinate (P89) at (-0.09375,0.09375);
+\coordinate (P90) at (0.375,0.375);
+\coordinate (P91) at (0.1875,0.1875);
+\coordinate (P92) at (0.03125,0.03125);
+\coordinate (P93) at (0,0.0625);
+\coordinate (P94) at (0,0.75);
+\coordinate (P95) at (0.625,0.375);
+\coordinate (P96) at (1,0.25);
+\coordinate (P97) at (-0.125,0.875);
+\coordinate (P98) at (-0.375,0.625);
+\coordinate (P99) at (0.125,0.875);
+\coordinate (P100) at (-0.25,1);
+\coordinate (P101) at (0.25,1);
+\coordinate (P102) at (-0.5,-0.75);
+\coordinate (P103) at (-0.5,0.75);
+\coordinate (P104) at (-0.75,0.5);
+\coordinate (P105) at (0.5,0.25);
+\coordinate (P106) at (0.75,0.5);
+\coordinate (P107) at (-0.125,-0.625);
+\coordinate (P108) at (-0.625,0.125);
+\coordinate (P109) at (-0.375,0.875);
+\coordinate (P110) at (0.375,0.125);
+\coordinate (P111) at (0.875,0.375);
+\coordinate (P112) at (0.125,0.625);
+\coordinate (P113) at (-0.375,-0.875);
+\coordinate (P114) at (-0.625,-0.125);
+\coordinate (P115) at (-0.125,0.625);
+\coordinate (P116) at (-0.875,0.375);
+\coordinate (P117) at (0.625,0.125);
+\coordinate (P118) at (0.25,0.125);
+\coordinate (P119) at (0.1875,0.0625);
+\coordinate (P120) at (-0.125,-0.0625);
+\coordinate (P121) at (-0.125,0.0625);
+\coordinate (P122) at (-0.0625,0.125);
+\coordinate (P123) at (0.0625,0.125);
+\coordinate (P124) at (-0.09375,-0.03125);
+\coordinate (P125) at (-0.03125,0.09375);
+\coordinate (P126) at (-0.09375,0.03125);
+\coordinate (P127) at (0.03125,0.09375);
+
+\draw[meshStyle, fill=cobalt!8.491053!white] (P13) -- (P12) -- (P102) -- cycle;
+\draw[meshStyle, fill=cobalt!9.722384!white] (P3) -- (P13) -- (P102) -- cycle;
+\draw[meshStyle, fill=cobalt!15.288825!white] (P1) -- (P12) -- (P13) -- cycle;
+\draw[meshStyle, fill=cobalt!0.922383!white] (P72) -- (P15) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!0.695998!white] (P12) -- (P72) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!1.394815!white] (P72) -- (P2) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!1.634300!white] (P15) -- (P72) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!2.951311!white] (P102) -- (P15) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!7.326436!white] (P3) -- (P102) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!0.807473!white] (P102) -- (P12) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!1.652228!white] (P15) -- (P102) -- (P113) -- cycle;
+\draw[meshStyle, fill=cobalt!5.512852!white] (P60) -- (P15) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!5.492995!white] (P16) -- (P60) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!4.974787!white] (P60) -- (P3) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!3.183929!white] (P15) -- (P60) -- (P75) -- cycle;
+\draw[meshStyle, fill=cobalt!1.375170!white] (P76) -- (P15) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!1.181359!white] (P2) -- (P76) -- (P74) -- cycle;
+\draw[meshStyle, fill=cobalt!4.097447!white] (P76) -- (P16) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!4.291259!white] (P15) -- (P76) -- (P107) -- cycle;
+\draw[meshStyle, fill=cobalt!10.073165!white] (P61) -- (P34) -- (P62) -- cycle;
+\draw[meshStyle, fill=cobalt!8.833511!white] (P18) -- (P61) -- (P62) -- cycle;
+\draw[meshStyle, fill=cobalt!5.362248!white] (P61) -- (P16) -- (P49) -- cycle;
+\draw[meshStyle, fill=cobalt!8.735504!white] (P34) -- (P61) -- (P49) -- cycle;
+\draw[meshStyle, fill=cobalt!7.210653!white] (P50) -- (P35) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!5.205007!white] (P34) -- (P50) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!11.370608!white] (P51) -- (P50) -- (P77) -- cycle;
+\draw[meshStyle, fill=cobalt!8.034708!white] (P77) -- (P5) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!10.986971!white] (P51) -- (P77) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!16.338518!white] (P35) -- (P50) -- (P51) -- cycle;
+\draw[meshStyle, fill=cobalt!3.042639!white] (P62) -- (P35) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!4.229262!white] (P18) -- (P62) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!5.207202!white] (P62) -- (P34) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!8.360089!white] (P35) -- (P62) -- (P63) -- cycle;
+\draw[meshStyle, fill=cobalt!8.741842!white] (P60) -- (P18) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!4.134332!white] (P3) -- (P60) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!16.091279!white] (P60) -- (P16) -- (P61) -- cycle;
+\draw[meshStyle, fill=cobalt!16.847849!white] (P18) -- (P60) -- (P61) -- cycle;
+\draw[meshStyle, fill=cobalt!18.296624!white] (P41) -- (P18) -- (P45) -- cycle;
+\draw[meshStyle, fill=cobalt!16.077804!white] (P19) -- (P41) -- (P45) -- cycle;
+\draw[meshStyle, fill=cobalt!9.055621!white] (P41) -- (P3) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!17.819764!white] (P18) -- (P41) -- (P53) -- cycle;
+\draw[meshStyle, fill=cobalt!7.148319!white] (P64) -- (P35) -- (P68) -- cycle;
+\draw[meshStyle, fill=cobalt!7.629561!white] (P36) -- (P64) -- (P68) -- cycle;
+\draw[meshStyle, fill=cobalt!2.526222!white] (P64) -- (P18) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!5.214310!white] (P35) -- (P64) -- (P52) -- cycle;
+\draw[meshStyle, fill=cobalt!1.121486!white] (P120) -- (P51) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!1.499946!white] (P54) -- (P120) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!7.941756!white] (P35) -- (P51) -- (P120) -- cycle;
+\draw[meshStyle, fill=cobalt!13.652102!white] (P80) -- (P51) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!75.592392!white] (P5) -- (P80) -- (P79) -- cycle;
+\draw[meshStyle, fill=cobalt!4.789980!white] (P80) -- (P54) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!4.531658!white] (P51) -- (P80) -- (P124) -- cycle;
+\draw[meshStyle, fill=cobalt!7.885778!white] (P54) -- (P36) -- (P68) -- cycle;
+\draw[meshStyle, fill=cobalt!7.395207!white] (P68) -- (P35) -- (P120) -- cycle;
+\draw[meshStyle, fill=cobalt!6.938049!white] (P54) -- (P68) -- (P120) -- cycle;
+\draw[meshStyle, fill=cobalt!24.877416!white] (P36) -- (P19) -- (P45) -- cycle;
+\draw[meshStyle, fill=cobalt!11.331669!white] (P45) -- (P18) -- (P64) -- cycle;
+\draw[meshStyle, fill=cobalt!21.491716!white] (P36) -- (P45) -- (P64) -- cycle;
+\draw[meshStyle, fill=cobalt!2.056299!white] (P81) -- (P17) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!7.447252!white] (P19) -- (P81) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!2.936599!white] (P81) -- (P4) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!2.343593!white] (P17) -- (P81) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!32.115104!white] (P17) -- (P3) -- (P41) -- cycle;
+\draw[meshStyle, fill=cobalt!15.010582!white] (P41) -- (P19) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!10.515097!white] (P17) -- (P41) -- (P114) -- cycle;
+\draw[meshStyle, fill=cobalt!37.766496!white] (P14) -- (P3) -- (P17) -- cycle;
+\draw[meshStyle, fill=cobalt!3.802453!white] (P73) -- (P17) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!0.015332!white] (P4) -- (P73) -- (P78) -- cycle;
+\draw[meshStyle, fill=cobalt!7.729369!white] (P14) -- (P17) -- (P73) -- cycle;
+\draw[meshStyle, fill=cobalt!11.384914!white] (P14) -- (P1) -- (P13) -- cycle;
+\draw[meshStyle, fill=cobalt!30.003981!white] (P3) -- (P14) -- (P13) -- cycle;
+\draw[meshStyle, fill=cobalt!5.470840!white] (P42) -- (P20) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!6.701113!white] (P19) -- (P42) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!8.660664!white] (P42) -- (P7) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!8.521421!white] (P20) -- (P42) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!2.244809!white] (P81) -- (P20) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!3.528680!white] (P4) -- (P81) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!9.755168!white] (P81) -- (P19) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!3.673351!white] (P20) -- (P81) -- (P108) -- cycle;
+\draw[meshStyle, fill=cobalt!16.436585!white] (P47) -- (P36) -- (P65) -- cycle;
+\draw[meshStyle, fill=cobalt!11.901687!white] (P23) -- (P47) -- (P65) -- cycle;
+\draw[meshStyle, fill=cobalt!25.303540!white] (P19) -- (P36) -- (P47) -- cycle;
+\draw[meshStyle, fill=cobalt!6.219960!white] (P70) -- (P54) -- (P121) -- cycle;
+\draw[meshStyle, fill=cobalt!3.446707!white] (P38) -- (P70) -- (P121) -- cycle;
+\draw[meshStyle, fill=cobalt!10.106166!white] (P36) -- (P54) -- (P70) -- cycle;
+\draw[meshStyle, fill=cobalt!3.889423!white] (P80) -- (P56) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!6.808460!white] (P54) -- (P80) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!100.000000!white] (P80) -- (P5) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!35.398996!white] (P56) -- (P80) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!2.888255!white] (P121) -- (P56) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!1.970253!white] (P38) -- (P121) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!4.692596!white] (P121) -- (P54) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!1.851772!white] (P56) -- (P121) -- (P126) -- cycle;
+\draw[meshStyle, fill=cobalt!3.823246!white] (P65) -- (P38) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!3.364392!white] (P23) -- (P65) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!15.219297!white] (P65) -- (P36) -- (P70) -- cycle;
+\draw[meshStyle, fill=cobalt!9.527346!white] (P38) -- (P65) -- (P70) -- cycle;
+\draw[meshStyle, fill=cobalt!38.865709!white] (P23) -- (P7) -- (P42) -- cycle;
+\draw[meshStyle, fill=cobalt!18.847853!white] (P42) -- (P19) -- (P47) -- cycle;
+\draw[meshStyle, fill=cobalt!23.323464!white] (P23) -- (P42) -- (P47) -- cycle;
+\draw[meshStyle, fill=cobalt!23.110146!white] (P43) -- (P23) -- (P46) -- cycle;
+\draw[meshStyle, fill=cobalt!18.580810!white] (P25) -- (P43) -- (P46) -- cycle;
+\draw[meshStyle, fill=cobalt!38.899931!white] (P7) -- (P23) -- (P43) -- cycle;
+\draw[meshStyle, fill=cobalt!9.379806!white] (P66) -- (P38) -- (P69) -- cycle;
+\draw[meshStyle, fill=cobalt!15.009735!white] (P40) -- (P66) -- (P69) -- cycle;
+\draw[meshStyle, fill=cobalt!3.364537!white] (P66) -- (P23) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!3.824091!white] (P38) -- (P66) -- (P57) -- cycle;
+\draw[meshStyle, fill=cobalt!1.879347!white] (P122) -- (P56) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!4.643390!white] (P59) -- (P122) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!1.971055!white] (P122) -- (P38) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!2.923867!white] (P56) -- (P122) -- (P89) -- cycle;
+\draw[meshStyle, fill=cobalt!35.340964!white] (P93) -- (P56) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!99.893894!white] (P5) -- (P93) -- (P88) -- cycle;
+\draw[meshStyle, fill=cobalt!7.009088!white] (P93) -- (P59) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!3.823356!white] (P56) -- (P93) -- (P125) -- cycle;
+\draw[meshStyle, fill=cobalt!9.881019!white] (P59) -- (P40) -- (P69) -- cycle;
+\draw[meshStyle, fill=cobalt!3.401231!white] (P69) -- (P38) -- (P122) -- cycle;
+\draw[meshStyle, fill=cobalt!6.123676!white] (P59) -- (P69) -- (P122) -- cycle;
+\draw[meshStyle, fill=cobalt!24.920458!white] (P40) -- (P25) -- (P46) -- cycle;
+\draw[meshStyle, fill=cobalt!11.740735!white] (P46) -- (P23) -- (P66) -- cycle;
+\draw[meshStyle, fill=cobalt!16.251597!white] (P40) -- (P46) -- (P66) -- cycle;
+\draw[meshStyle, fill=cobalt!3.623420!white] (P94) -- (P29) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!10.340095!white] (P25) -- (P94) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!3.763183!white] (P94) -- (P10) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!2.153612!white] (P29) -- (P94) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!8.490943!white] (P43) -- (P29) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!8.646098!white] (P7) -- (P43) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!6.571413!white] (P43) -- (P25) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!5.517126!white] (P29) -- (P43) -- (P115) -- cycle;
+\draw[meshStyle, fill=cobalt!1.627512!white] (P103) -- (P29) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!2.881933!white] (P32) -- (P103) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!4.904814!white] (P103) -- (P7) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!5.052183!white] (P29) -- (P103) -- (P98) -- cycle;
+\draw[meshStyle, fill=cobalt!1.304336!white] (P100) -- (P29) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!0.314725!white] (P10) -- (P100) -- (P97) -- cycle;
+\draw[meshStyle, fill=cobalt!1.220403!white] (P100) -- (P32) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!2.323291!white] (P29) -- (P100) -- (P109) -- cycle;
+\draw[meshStyle, fill=cobalt!16.244839!white] (P32) -- (P9) -- (P28) -- cycle;
+\draw[meshStyle, fill=cobalt!9.728191!white] (P28) -- (P7) -- (P103) -- cycle;
+\draw[meshStyle, fill=cobalt!6.838257!white] (P32) -- (P28) -- (P103) -- cycle;
+\draw[meshStyle, fill=cobalt!6.904767!white] (P28) -- (P21) -- (P104) -- cycle;
+\draw[meshStyle, fill=cobalt!9.718814!white] (P7) -- (P28) -- (P104) -- cycle;
+\draw[meshStyle, fill=cobalt!16.260376!white] (P9) -- (P21) -- (P28) -- cycle;
+\draw[meshStyle, fill=cobalt!2.354967!white] (P84) -- (P20) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!1.215208!white] (P21) -- (P84) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!0.312062!white] (P84) -- (P4) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!1.321192!white] (P20) -- (P84) -- (P83) -- cycle;
+\draw[meshStyle, fill=cobalt!5.061634!white] (P104) -- (P20) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!4.922766!white] (P7) -- (P104) -- (P82) -- cycle;
+\draw[meshStyle, fill=cobalt!2.922107!white] (P104) -- (P21) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!1.616286!white] (P20) -- (P104) -- (P116) -- cycle;
+\draw[meshStyle, fill=cobalt!15.335353!white] (P105) -- (P24) -- (P110) -- cycle;
+\draw[meshStyle, fill=cobalt!16.636702!white] (P22) -- (P105) -- (P110) -- cycle;
+\draw[meshStyle, fill=cobalt!4.405598!white] (P105) -- (P8) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!7.005709!white] (P24) -- (P105) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!6.835114!white] (P118) -- (P39) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!5.372661!white] (P37) -- (P118) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!6.106250!white] (P118) -- (P24) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!1.696174!white] (P39) -- (P118) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!19.315089!white] (P55) -- (P39) -- (P58) -- cycle;
+\draw[meshStyle, fill=cobalt!10.768562!white] (P85) -- (P58) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!7.910471!white] (P5) -- (P85) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!12.159878!white] (P55) -- (P58) -- (P85) -- cycle;
+\draw[meshStyle, fill=cobalt!5.292809!white] (P55) -- (P37) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!8.459901!white] (P39) -- (P55) -- (P119) -- cycle;
+\draw[meshStyle, fill=cobalt!7.108371!white] (P110) -- (P37) -- (P86) -- cycle;
+\draw[meshStyle, fill=cobalt!6.261557!white] (P22) -- (P110) -- (P86) -- cycle;
+\draw[meshStyle, fill=cobalt!11.767949!white] (P110) -- (P24) -- (P118) -- cycle;
+\draw[meshStyle, fill=cobalt!8.314243!white] (P37) -- (P110) -- (P118) -- cycle;
+\draw[meshStyle, fill=cobalt!6.138898!white] (P87) -- (P26) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!4.289883!white] (P22) -- (P87) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!10.012450!white] (P6) -- (P26) -- (P87) -- cycle;
+\draw[meshStyle, fill=cobalt!2.383681!white] (P105) -- (P26) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!4.919243!white] (P8) -- (P105) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!6.008568!white] (P105) -- (P22) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!5.234754!white] (P26) -- (P105) -- (P117) -- cycle;
+\draw[meshStyle, fill=cobalt!2.676673!white] (P106) -- (P26) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!1.766352!white] (P27) -- (P106) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!7.382722!white] (P106) -- (P8) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!2.859634!white] (P26) -- (P106) -- (P95) -- cycle;
+\draw[meshStyle, fill=cobalt!8.334976!white] (P26) -- (P6) -- (P96) -- cycle;
+\draw[meshStyle, fill=cobalt!1.396771!white] (P96) -- (P27) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!1.264958!white] (P26) -- (P96) -- (P111) -- cycle;
+\draw[meshStyle, fill=cobalt!15.410698!white] (P27) -- (P11) -- (P31) -- cycle;
+\draw[meshStyle, fill=cobalt!10.161469!white] (P31) -- (P8) -- (P106) -- cycle;
+\draw[meshStyle, fill=cobalt!8.737881!white] (P27) -- (P31) -- (P106) -- cycle;
+\draw[meshStyle, fill=cobalt!30.783399!white] (P33) -- (P8) -- (P31) -- cycle;
+\draw[meshStyle, fill=cobalt!11.483459!white] (P11) -- (P33) -- (P31) -- cycle;
+\draw[meshStyle, fill=cobalt!8.056717!white] (P30) -- (P33) -- (P101) -- cycle;
+\draw[meshStyle, fill=cobalt!0.000000!white] (P101) -- (P10) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!4.000255!white] (P30) -- (P101) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!38.269279!white] (P8) -- (P33) -- (P30) -- cycle;
+\draw[meshStyle, fill=cobalt!10.756670!white] (P44) -- (P30) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!15.403740!white] (P25) -- (P44) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!32.395533!white] (P8) -- (P30) -- (P44) -- cycle;
+\draw[meshStyle, fill=cobalt!2.200289!white] (P94) -- (P30) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!3.167476!white] (P10) -- (P94) -- (P99) -- cycle;
+\draw[meshStyle, fill=cobalt!7.996605!white] (P94) -- (P25) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!1.922313!white] (P30) -- (P94) -- (P112) -- cycle;
+\draw[meshStyle, fill=cobalt!21.502835!white] (P48) -- (P40) -- (P67) -- cycle;
+\draw[meshStyle, fill=cobalt!10.518957!white] (P24) -- (P48) -- (P67) -- cycle;
+\draw[meshStyle, fill=cobalt!24.681125!white] (P25) -- (P40) -- (P48) -- cycle;
+\draw[meshStyle, fill=cobalt!6.397044!white] (P71) -- (P59) -- (P123) -- cycle;
+\draw[meshStyle, fill=cobalt!6.621833!white] (P39) -- (P71) -- (P123) -- cycle;
+\draw[meshStyle, fill=cobalt!7.453914!white] (P40) -- (P59) -- (P71) -- cycle;
+\draw[meshStyle, fill=cobalt!4.681438!white] (P93) -- (P58) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!4.996123!white] (P59) -- (P93) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!75.362049!white] (P93) -- (P5) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!13.680165!white] (P58) -- (P93) -- (P92) -- cycle;
+\draw[meshStyle, fill=cobalt!7.978324!white] (P58) -- (P39) -- (P123) -- cycle;
+\draw[meshStyle, fill=cobalt!1.739519!white] (P123) -- (P59) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!0.657834!white] (P58) -- (P123) -- (P127) -- cycle;
+\draw[meshStyle, fill=cobalt!7.074284!white] (P67) -- (P39) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!2.198364!white] (P24) -- (P67) -- (P91) -- cycle;
+\draw[meshStyle, fill=cobalt!7.433268!white] (P67) -- (P40) -- (P71) -- cycle;
+\draw[meshStyle, fill=cobalt!8.065299!white] (P39) -- (P67) -- (P71) -- cycle;
+\draw[meshStyle, fill=cobalt!17.829876!white] (P44) -- (P24) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!9.085265!white] (P8) -- (P44) -- (P90) -- cycle;
+\draw[meshStyle, fill=cobalt!16.722169!white] (P44) -- (P25) -- (P48) -- cycle;
+\draw[meshStyle, fill=cobalt!18.106212!white] (P24) -- (P44) -- (P48) -- cycle;
+\end{tikzpicture} 
+
+ \end{document} 
+ 
diff --git a/experiments/saveTikzConformingColor.m b/experiments/saveTikzConformingColor.m
new file mode 100644
index 0000000000000000000000000000000000000000..c78d41db7b8b6b090f8c971d7fce87fd082bf19c
--- /dev/null
+++ b/experiments/saveTikzConformingColor.m
@@ -0,0 +1,53 @@
+function saveTikzConforming(coordinates, elements, additionalData, fileName)
+% saveTikzConforming Save mesh data for later use in TikZ (with LaTeX)
+%
+% Save mesh data in a file suitable for \input{} within a tikzpicture
+% environment in LaTeX.
+% The drawing style is defined in the first line of the output file for
+% convenient manual editing.
+%
+% Usage:
+%   saveTikzConforming(coordinates, elements) Save meshdata in file 'mesh.tex'
+%
+%   saveTikzConforming(coordinates, elements, fileName) Save meshdata in file with custom name
+
+arguments
+    coordinates (:,2) double
+    elements (:,3) double
+    additionalData (:,1) double
+    fileName (1,1) string = 'meshWithData.tex'
+end
+
+minData = min(additionalData);
+maxUpdatedData = max(additionalData - minData);
+additionalDataUpdate = abs((additionalData - minData)/maxUpdatedData)*100; 
+
+%% open file
+fileID = fopen(fileName, 'a');
+assert(fileID ~= -1, 'Cannot open file %s.', fileName)
+
+fprintf(fileID, '\\documentclass{standalone}\n\n');
+
+
+fprintf(fileID, '\\usepackage{tikz} \n \n \\usepackage{pgfplots}\n\n');
+
+fprintf(fileID, '\\usepackage{xcolor} \n \n \\definecolor{cobalt}{RGB}{0,102,153} \n\n \\definecolor{cobaltred}{RGB}{255, 255,255}  \n \n');
+
+fprintf(fileID, '\\usepgfplotslibrary{colormaps} \n \n \\begin{document} \n\n \\begin{tikzpicture} \n \n');
+
+
+fprintf(fileID, '\\tikzset{meshStyle/.style={very thin, lightgray}}\n\n');
+
+%% define coordinates in tikz
+nCoordinates = size(coordinates, 1);
+fprintf(fileID, '\\coordinate (P%d) at (%.4g,%.4g);\n', [(1:nCoordinates)', coordinates]');
+fprintf(fileID, '\n');
+    
+%% draw mesh lines
+fprintf(fileID, '\\draw[meshStyle, fill=cobalt!%f!white] (P%d) -- (P%d) -- (P%d) -- cycle;\n',[additionalDataUpdate, elements]');
+
+fprintf(fileID, '\\end{tikzpicture} \n\n \\end{document} \n \n');
+
+%% close file
+fclose(fileID);
+end