Premature Ventricular Complexes (PVCs)

Premature Ventricular Complexes (PVCs)#

In this demo we try to replicate the experimental setup conducted in [ZLH+21]

First we do the necessary imports

from mpi4py import MPI
import matplotlib.pyplot as plt
from pathlib import Path
import shutil
import adios4dolfinx
import scifem
import numpy as np
import ufl
import beat
import dolfinx
import gotranx
from beat.single_cell import get_steady_state
import beat.postprocess

Next we set the output directory for the results and define the geometry. Here we specify an interval mesh of 200 cells with 0.015 cm between each cell

here = Path.cwd()
outdir = here / "results-pvc"
mesh_unit = "cm"
dx = 0.015
num_cells = 200
L = num_cells * dx
comm = MPI.COMM_WORLD
mesh = dolfinx.mesh.create_interval(comm, num_cells, (0, L))

We will use the tensusscher panfilov model

model_path = Path("tentusscher_panfilov_2006_epi_cell.py")
if not model_path.is_file():
    here = Path.cwd()
    ode = gotranx.load_ode(
        here
        / ".."
        / "odes"
        / "tentusscher_panfilov_2006"
        / "tentusscher_panfilov_2006_epi_cell.ode",
    )
    code = gotranx.cli.gotran2py.get_code(
        ode, scheme=[gotranx.schemes.Scheme.generalized_rush_larsen],
    )
    model_path.write_text(code)
import tentusscher_panfilov_2006_epi_cell
model = tentusscher_panfilov_2006_epi_cell.__dict__
# Change this to run the simulations for longer
end_time = 1000.0

We specify a diffusion coefficient and a membrane capacitance

D = 0.0005 * beat.units.ureg("cm**2 / ms")
Cm = 1.0 * beat.units.ureg("uF/cm**2")

Next we run a single cell model with the to get the correct steady state solutions. We run this for 50 beats with a stimulation every 1000.0 ms

parameters = model["init_parameter_values"](stim_period=1000.0)
dt = 0.01
nbeats = 50
fun = model["generalized_rush_larsen"]
y = get_steady_state(
    fun=fun,
    init_states=model["init_state_values"](),
    parameters=parameters,
    outdir=outdir / "prebeats",
    BCL=500,
    nbeats=nbeats,
    track_indices=[model["state_index"]("V"), model["state_index"]("Ca_i")],
    dt=dt,
)
# -

Now we create the stimulus current which is 0.0 is we stimulate all the cells at once (in which case the stimulation is applied directly to all cells).

time = dolfinx.fem.Constant(mesh, 0.0)
I_s = dolfinx.fem.Constant(mesh, 0.0)

We start the stimulation after 100 ms with period of 1000 ms

parameters = model["init_parameter_values"](stim_start=100.0, stim_period=1000)

Now we would like to change the conductances for the cells in the right most part of the cable. We choose a first order Lagrange space for this, so that we have one set of parameters for each cells, and then we copy over the default parameters

V_ode = dolfinx.fem.functionspace(mesh, ("Lagrange", 1))
parameters_ode = np.zeros(
    (len(parameters), V_ode.dofmap.index_map.size_local), dtype=np.float64,
)
parameters_ode.T[:] = parameters

To set the values of the parameters we first need to get the coordinates of the cells which we can do using the ufl.SpatialCoordinate function

X = ufl.SpatialCoordinate(mesh)

Next we set the values og \(g_Kr\) function

g_Kr_index = model["parameter_index"]("g_Kr")
g_Kr_value = parameters[g_Kr_index]
g_Kr = dolfinx.fem.Function(V_ode)

We interpolate the values to the function space using a conditional expression

g_Kr.interpolate(
    dolfinx.fem.Expression(
        ufl.conditional(ufl.ge(X[0], L / 2), 0.0, g_Kr_value),
        V_ode.element.interpolation_points(),
    ),
)

and set the values in the parameters array

parameters_ode[g_Kr_index, :] = g_Kr.x.array

and similar for the conductance \(g_Ks\)

g_Ks_index = model["parameter_index"]("g_Ks")
g_Ks_value = parameters[g_Ks_index]
g_Ks = dolfinx.fem.Function(V_ode)
g_Ks.interpolate(
    dolfinx.fem.Expression(
        ufl.conditional(ufl.ge(X[0], L / 2), 0.0, g_Ks_value),
        V_ode.element.interpolation_points(),
    ),
)
parameters_ode[g_Ks_index, :] = g_Ks.x.array

Finally we set up the models

pde = beat.MonodomainModel(
    time=time, mesh=mesh, M=D.magnitude, I_s=I_s, C_m=Cm.magnitude,
)
ode = beat.odesolver.DolfinODESolver(
    v_ode=dolfinx.fem.Function(V_ode),
    v_pde=pde.state,
    fun=fun,
    init_states=y,
    parameters=parameters_ode,
    num_states=len(y),
    v_index=model["state_index"]("V"),
)
solver = beat.MonodomainSplittingSolver(pde=pde, ode=ode)

checkpointfname = outdir / "pvc_checkpoint.bp"

shutil.rmtree(checkpointfname, ignore_errors=True)
adios4dolfinx.write_mesh(checkpointfname, mesh)


def save(t):
    v = solver.pde.state.x.array
    print(f"Solve for {t=:.2f}, {v.max() =}, {v.min() =}")
    adios4dolfinx.write_function(checkpointfname, solver.pde.state, time=t, name="v")

and solve it

t = 0.0
save_freq = int(1.0 / dt)
i = 0
done_stimulating = False
while t < end_time + 1e-12:

    if i % save_freq == 0:
        save(t)
    solver.step((t, t + dt))
    i += 1
    t += dt
Solve for t=0.00, v.max() =np.float64(-84.95394240762818), v.min() =np.float64(-84.95394240762818)
Solve for t=1.00, v.max() =np.float64(-84.95704893608189), v.min() =np.float64(-84.95757463069877)
Solve for t=2.00, v.max() =np.float64(-84.96022435088031), v.min() =np.float64(-84.96116931311086)
Solve for t=3.00, v.max() =np.float64(-84.96345058445509), v.min() =np.float64(-84.96472691758095)
Solve for t=4.00, v.max() =np.float64(-84.96671274873088), v.min() =np.float64(-84.9682478576185)
Solve for t=5.00, v.max() =np.float64(-84.96999853188639), v.min() =np.float64(-84.97173255244452)
Solve for t=6.00, v.max() =np.float64(-84.97329777257472), v.min() =np.float64(-84.97518141644447)
Solve for t=7.00, v.max() =np.float64(-84.97660209825484), v.min() =np.float64(-84.97859485909953)
Solve for t=8.00, v.max() =np.float64(-84.97990462401647), v.min() =np.float64(-84.9819732850283)
Solve for t=9.00, v.max() =np.float64(-84.98319970179764), v.min() =np.float64(-84.98531709403773)
Solve for t=10.00, v.max() =np.float64(-84.98648271155052), v.min() =np.float64(-84.98862668116847)
Solve for t=11.00, v.max() =np.float64(-84.98974988736772), v.min() =np.float64(-84.99190243674418)
Solve for t=12.00, v.max() =np.float64(-84.99299817273062), v.min() =np.float64(-84.99514474642258)
Solve for t=13.00, v.max() =np.float64(-84.99622510001737), v.min() =np.float64(-84.99835399124228)
Solve for t=14.00, v.max() =np.float64(-84.99942869022499), v.min() =np.float64(-85.0015305476704)
Solve for t=15.00, v.max() =np.float64(-85.00260736953055), v.min() =np.float64(-85.00467478765452)
Solve for t=16.00, v.max() =np.float64(-85.00575989987409), v.min() =np.float64(-85.007787078667)
Solve for t=17.00, v.max() =np.float64(-85.00888532122508), v.min() =np.float64(-85.01086778375489)
Solve for t=18.00, v.max() =np.float64(-85.01198290357469), v.min() =np.float64(-85.01391726158987)
Solve for t=19.00, v.max() =np.float64(-85.01505210702625), v.min() =np.float64(-85.01693586651609)
Solve for t=20.00, v.max() =np.float64(-85.01809254862484), v.min() =np.float64(-85.01992394859585)
Solve for t=21.00, v.max() =np.float64(-85.02110397480013), v.min() =np.float64(-85.02288185366037)
Solve for t=22.00, v.max() =np.float64(-85.0240862384742), v.min() =np.float64(-85.02580992335463)
Solve for t=23.00, v.max() =np.float64(-85.02703928005818), v.min() =np.float64(-85.02870849518769)
Solve for t=24.00, v.max() =np.float64(-85.0299631116737), v.min() =np.float64(-85.03157790257796)
Solve for t=25.00, v.max() =np.float64(-85.03285780406601), v.min() =np.float64(-85.03441847490255)
Solve for t=26.00, v.max() =np.float64(-85.03572347574524), v.min() =np.float64(-85.03723053754122)
Solve for t=27.00, v.max() =np.float64(-85.03856028398668), v.min() =np.float64(-85.04001441192331)
Solve for t=28.00, v.max() =np.float64(-85.0413684173766), v.min() =np.float64(-85.04277041557661)
Solve for t=29.00, v.max() =np.float64(-85.04414808963392), v.min() =np.float64(-85.04549886217076)
Solve for t=30.00, v.max() =np.float64(-85.04689953450001), v.min() =np.float64(-85.04820006156297)
Solve for t=31.00, v.max() =np.float64(-85.04962300151287), v.min() =np.float64(-85.05087431984475)
Solve for t=32.00, v.max() =np.float64(-85.05231875251205), v.min() =np.float64(-85.05352193938528)
Solve for t=33.00, v.max() =np.float64(-85.05498705875597), v.min() =np.float64(-85.0561432188763)
Solve for t=34.00, v.max() =np.float64(-85.0576281985436), v.min() =np.float64(-85.05873845337788)
Solve for t=35.00, v.max() =np.float64(-85.06024245525529), v.min() =np.float64(-85.06130793436188)
Solve for t=36.00, v.max() =np.float64(-85.06283011573896), v.min() =np.float64(-85.06385194975395)
Solve for t=37.00, v.max() =np.float64(-85.06539146898812), v.min() =np.float64(-85.06637078397777)
Solve for t=38.00, v.max() =np.float64(-85.06792680505629), v.min() =np.float64(-85.0688647179987)
Solve for t=39.00, v.max() =np.float64(-85.0704364141697), v.min() =np.float64(-85.07133402936527)
Solve for t=40.00, v.max() =np.float64(-85.07292058600386), v.min() =np.float64(-85.07377899225057)
Solve for t=41.00, v.max() =np.float64(-85.07537960909633), v.min() =np.float64(-85.07619987749564)
Solve for t=42.00, v.max() =np.float64(-85.07781377036972), v.min() =np.float64(-85.07859695264948)
Solve for t=43.00, v.max() =np.float64(-85.08022335474976), v.min() =np.float64(-85.08097048200975)
Solve for t=44.00, v.max() =np.float64(-85.08260864486064), v.min() =np.float64(-85.08332072666732)
Solve for t=45.00, v.max() =np.float64(-85.08496992077532), v.min() =np.float64(-85.08564794453734)
Solve for t=46.00, v.max() =np.float64(-85.08730745983235), v.min() =np.float64(-85.08795239040876)
Solve for t=47.00, v.max() =np.float64(-85.08962153648402), v.min() =np.float64(-85.09023431597795)
Solve for t=48.00, v.max() =np.float64(-85.09191242218358), v.min() =np.float64(-85.09249396988852)
Solve for t=49.00, v.max() =np.float64(-85.09418038530512), v.min() =np.float64(-85.0947315977723)
Solve for t=50.00, v.max() =np.float64(-85.09642569107866), v.min() =np.float64(-85.09694744228183)
Solve for t=51.00, v.max() =np.float64(-85.09864860155676), v.min() =np.float64(-85.09914174313509)
Solve for t=52.00, v.max() =np.float64(-85.10084937558644), v.min() =np.float64(-85.10131473714739)
Solve for t=53.00, v.max() =np.float64(-85.10302826880014), v.min() =np.float64(-85.10346665826968)
Solve for t=54.00, v.max() =np.float64(-85.10518553361689), v.min() =np.float64(-85.10559773762633)
Solve for t=55.00, v.max() =np.float64(-85.1073214192498), v.min() =np.float64(-85.10770820354946)
Solve for t=56.00, v.max() =np.float64(-85.10943617172303), v.min() =np.float64(-85.10979828161577)
Solve for t=57.00, v.max() =np.float64(-85.11153003389384), v.min() =np.float64(-85.11186819468115)
Solve for t=58.00, v.max() =np.float64(-85.11360324547583), v.min() =np.float64(-85.11391816291449)
Solve for t=59.00, v.max() =np.float64(-85.11565604307185), v.min() =np.float64(-85.11594840383326)
Solve for t=60.00, v.max() =np.float64(-85.11768866020522), v.min() =np.float64(-85.1179591323373)
Solve for t=61.00, v.max() =np.float64(-85.11970132735559), v.min() =np.float64(-85.11995056074302)
Solve for t=62.00, v.max() =np.float64(-85.12169427199474), v.min() =np.float64(-85.12192289881611)
Solve for t=63.00, v.max() =np.float64(-85.12366771862311), v.min() =np.float64(-85.12387635380271)
Solve for t=64.00, v.max() =np.float64(-85.12562188880916), v.min() =np.float64(-85.12581113046389)
Solve for t=65.00, v.max() =np.float64(-85.12755700122905), v.min() =np.float64(-85.12772743110634)
Solve for t=66.00, v.max() =np.float64(-85.12947327170671), v.min() =np.float64(-85.1296254556161)
Solve for t=67.00, v.max() =np.float64(-85.13137091325245), v.min() =np.float64(-85.13150540148753)
Solve for t=68.00, v.max() =np.float64(-85.13325013610243), v.min() =np.float64(-85.13336746385374)
Solve for t=69.00, v.max() =np.float64(-85.13511114775845), v.min() =np.float64(-85.13521183551882)
Solve for t=70.00, v.max() =np.float64(-85.13695415302787), v.min() =np.float64(-85.13703870698663)
Solve for t=71.00, v.max() =np.float64(-85.13877935406481), v.min() =np.float64(-85.13884826649263)
Solve for t=72.00, v.max() =np.float64(-85.1405869504048), v.min() =np.float64(-85.14064070003022)
Solve for t=73.00, v.max() =np.float64(-85.14237713900584), v.min() =np.float64(-85.14241619138141)
Solve for t=74.00, v.max() =np.float64(-85.14415011428589), v.min() =np.float64(-85.14417492214429)
Solve for t=75.00, v.max() =np.float64(-85.14590606816125), v.min() =np.float64(-85.14591707176379)
Solve for t=76.00, v.max() =np.float64(-85.1476363496905), v.min() =np.float64(-85.14765173557176)
Solve for t=77.00, v.max() =np.float64(-85.14934787604079), v.min() =np.float64(-85.14937218930626)
Solve for t=78.00, v.max() =np.float64(-85.15104268471251), v.min() =np.float64(-85.15107684055431)
Solve for t=79.00, v.max() =np.float64(-85.15272120604513), v.min() =np.float64(-85.15276562586146)
Solve for t=80.00, v.max() =np.float64(-85.15438373117146), v.min() =np.float64(-85.15443859572144)
Solve for t=81.00, v.max() =np.float64(-85.15603050952245), v.min() =np.float64(-85.1560958452052)
Solve for t=82.00, v.max() =np.float64(-85.15766176122678), v.min() =np.float64(-85.15773749190363)
Solve for t=83.00, v.max() =np.float64(-85.15927768928223), v.min() =np.float64(-85.15936367461839)
Solve for t=84.00, v.max() =np.float64(-85.16087849425466), v.min() =np.float64(-85.16097452164053)
Solve for t=85.00, v.max() =np.float64(-85.16246435435525), v.min() =np.float64(-85.1625701828157)
Solve for t=86.00, v.max() =np.float64(-85.16403544047719), v.min() =np.float64(-85.16415081133714)
Solve for t=87.00, v.max() =np.float64(-85.16559191652625), v.min() =np.float64(-85.16571656283776)
Solve for t=88.00, v.max() =np.float64(-85.16713394435553), v.min() =np.float64(-85.16726759319936)
Solve for t=89.00, v.max() =np.float64(-85.16866168147489), v.min() =np.float64(-85.16880405659053)
Solve for t=90.00, v.max() =np.float64(-85.17017528121085), v.min() =np.float64(-85.17032610842779)
Solve for t=91.00, v.max() =np.float64(-85.1716748942505), v.min() =np.float64(-85.17183390304952)
Solve for t=92.00, v.max() =np.float64(-85.17316066861379), v.min() =np.float64(-85.1733275936584)
Solve for t=93.00, v.max() =np.float64(-85.17463275091366), v.min() =np.float64(-85.17480733169458)
Solve for t=94.00, v.max() =np.float64(-85.17609128529338), v.min() =np.float64(-85.17627326700945)
Solve for t=95.00, v.max() =np.float64(-85.17753641398272), v.min() =np.float64(-85.1777255480285)
Solve for t=96.00, v.max() =np.float64(-85.1789682774114), v.min() =np.float64(-85.17916432149009)
Solve for t=97.00, v.max() =np.float64(-85.18038701427277), v.min() =np.float64(-85.18058973246345)
Solve for t=98.00, v.max() =np.float64(-85.18179276168235), v.min() =np.float64(-85.1820019242311)
Solve for t=99.00, v.max() =np.float64(-85.18318565504609), v.min() =np.float64(-85.18340103839924)
Solve for t=100.00, v.max() =np.float64(-85.18456582817765), v.min() =np.float64(-85.1847872149025)
Solve for t=101.00, v.max() =np.float64(20.713846993226163), v.min() =np.float64(20.702217058205633)
Solve for t=102.00, v.max() =np.float64(32.74234830254449), v.min() =np.float64(32.49074196622814)
Solve for t=103.00, v.max() =np.float64(24.982450655347428), v.min() =np.float64(24.478169106142698)
Solve for t=104.00, v.max() =np.float64(21.371061675056794), v.min() =np.float64(20.771811691160867)
Solve for t=105.00, v.max() =np.float64(18.84969700535072), v.min() =np.float64(18.154356610698304)
Solve for t=106.00, v.max() =np.float64(16.454845700988084), v.min() =np.float64(15.785752724312403)
Solve for t=107.00, v.max() =np.float64(15.19663379823589), v.min() =np.float64(14.545330239213309)
Solve for t=108.00, v.max() =np.float64(14.646620321263946), v.min() =np.float64(14.003322784216365)
Solve for t=109.00, v.max() =np.float64(14.518580133669472), v.min() =np.float64(13.880314712837274)
Solve for t=110.00, v.max() =np.float64(14.646189695518439), v.min() =np.float64(14.012167376111902)
Solve for t=111.00, v.max() =np.float64(14.926603933129044), v.min() =np.float64(14.295965618150635)
Solve for t=112.00, v.max() =np.float64(15.294719322276462), v.min() =np.float64(14.665765420541355)
Solve for t=113.00, v.max() =np.float64(15.709913540764909), v.min() =np.float64(15.080045053581879)
Solve for t=114.00, v.max() =np.float64(16.147774146491017), v.min() =np.float64(15.51373721614984)
Solve for t=115.00, v.max() =np.float64(16.59436503830598), v.min() =np.float64(15.952581156122397)
Solve for t=116.00, v.max() =np.float64(17.04218792233337), v.min() =np.float64(16.389057684605547)
Solve for t=117.00, v.max() =np.float64(17.487432884555407), v.min() =np.float64(16.81956571971641)
Solve for t=118.00, v.max() =np.float64(17.928213274395034), v.min() =np.float64(17.24257410828869)
Solve for t=119.00, v.max() =np.float64(18.363517435902367), v.min() =np.float64(17.657501009154736)
Solve for t=120.00, v.max() =np.float64(18.79265328751026), v.min() =np.float64(18.06410372206598)
Solve for t=121.00, v.max() =np.float64(19.21501608358338), v.min() =np.float64(18.46220868215632)
Solve for t=122.00, v.max() =np.float64(19.630065442426226), v.min() =np.float64(18.851663744966576)
Solve for t=123.00, v.max() =np.float64(20.037446206941304), v.min() =np.float64(19.23244274643484)
Solve for t=124.00, v.max() =np.float64(20.4372153059075), v.min() =np.float64(19.60486131932125)
Solve for t=125.00, v.max() =np.float64(20.83008731975931), v.min() =np.float64(19.96981880364736)
Solve for t=126.00, v.max() =np.float64(21.217300433013317), v.min() =np.float64(20.328687734159132)
Solve for t=127.00, v.max() =np.float64(21.599091529443275), v.min() =np.float64(20.68188874656782)
Solve for t=128.00, v.max() =np.float64(21.971931524833444), v.min() =np.float64(21.02627293736927)
Solve for t=129.00, v.max() =np.float64(22.32897521980113), v.min() =np.float64(21.355502237807105)
Solve for t=130.00, v.max() =np.float64(22.664469611382284), v.min() =np.float64(21.66417718581598)
Solve for t=131.00, v.max() =np.float64(22.97579622681728), v.min() =np.float64(21.949783260540134)
Solve for t=132.00, v.max() =np.float64(23.26252977640584), v.min() =np.float64(22.21183941532204)
Solve for t=133.00, v.max() =np.float64(23.525280467860302), v.min() =np.float64(22.450829006435804)
Solve for t=134.00, v.max() =np.float64(23.76510238857418), v.min() =np.float64(22.667651760814184)
Solve for t=135.00, v.max() =np.float64(23.98324537559643), v.min() =np.float64(22.863394932021446)
Solve for t=136.00, v.max() =np.float64(24.18104736587129), v.min() =np.float64(23.039235639210986)
Solve for t=137.00, v.max() =np.float64(24.359880657578007), v.min() =np.float64(23.19639326546545)
Solve for t=138.00, v.max() =np.float64(24.521119710568307), v.min() =np.float64(23.336101280338912)
Solve for t=139.00, v.max() =np.float64(24.666118561581694), v.min() =np.float64(23.45958718381054)
Solve for t=140.00, v.max() =np.float64(24.796193533466177), v.min() =np.float64(23.568056562341702)
Solve for t=141.00, v.max() =np.float64(24.91260971366974), v.min() =np.float64(23.662679963999892)
Solve for t=142.00, v.max() =np.float64(25.016570632897853), v.min() =np.float64(23.744582233429448)
Solve for t=143.00, v.max() =np.float64(25.109210836980903), v.min() =np.float64(23.81483419496109)
Solve for t=144.00, v.max() =np.float64(25.191591069555745), v.min() =np.float64(23.874446576754337)
Solve for t=145.00, v.max() =np.float64(25.264695748361344), v.min() =np.float64(23.92436600845146)
Solve for t=146.00, v.max() =np.float64(25.32943238764385), v.min() =np.float64(23.965472866149835)
Solve for t=147.00, v.max() =np.float64(25.386632610719257), v.min() =np.float64(23.998580701937797)
Solve for t=148.00, v.max() =np.float64(25.437054409841412), v.min() =np.float64(24.02443698263484)
Solve for t=149.00, v.max() =np.float64(25.48138533930665), v.min() =np.float64(24.04372486908268)
Solve for t=150.00, v.max() =np.float64(25.520246365701947), v.min() =np.float64(24.057065787312695)
Solve for t=151.00, v.max() =np.float64(25.554196140948246), v.min() =np.float64(24.06502257065018)
Solve for t=152.00, v.max() =np.float64(25.58373550541091), v.min() =np.float64(24.06810298303581)
Solve for t=153.00, v.max() =np.float64(25.60931206730051), v.min() =np.float64(24.066763465456535)
Solve for t=154.00, v.max() =np.float64(25.631324739454485), v.min() =np.float64(24.061412977395648)
Solve for t=155.00, v.max() =np.float64(25.650128144730868), v.min() =np.float64(24.052416832440237)
Solve for t=156.00, v.max() =np.float64(25.666036826569908), v.min() =np.float64(24.040100451056006)
Solve for t=157.00, v.max() =np.float64(25.679329222035292), v.min() =np.float64(24.024752973887804)
Solve for t=158.00, v.max() =np.float64(25.69025137126266), v.min() =np.float64(24.006630695884695)
Solve for t=159.00, v.max() =np.float64(25.69902035024723), v.min() =np.float64(23.985960295339076)
Solve for t=160.00, v.max() =np.float64(25.705827423826083), v.min() =np.float64(23.962941842927048)
Solve for t=161.00, v.max() =np.float64(25.710840923084117), v.min() =np.float64(23.937751584417153)
Solve for t=162.00, v.max() =np.float64(25.71420885669545), v.min() =np.float64(23.91054449725038)
Solve for t=163.00, v.max() =np.float64(25.71606126933268), v.min() =np.float64(23.88145662603844)
Solve for t=164.00, v.max() =np.float64(25.71651236258175), v.min() =np.float64(23.85060720548849)
Solve for t=165.00, v.max() =np.float64(25.715662395095702), v.min() =np.float64(23.81810058162182)
Solve for t=166.00, v.max() =np.float64(25.713599379249104), v.min() =np.float64(23.784027943637614)
Solve for t=167.00, v.max() =np.float64(25.710400591518923), v.min() =np.float64(23.748468879586696)
Solve for t=168.00, v.max() =np.float64(25.706133913374025), v.min() =np.float64(23.71149276931329)
Solve for t=169.00, v.max() =np.float64(25.70085901873364), v.min() =np.float64(23.673160028042407)
Solve for t=170.00, v.max() =np.float64(25.694628423147652), v.min() =np.float64(23.633523213627566)
Solve for t=171.00, v.max() =np.float64(25.687488408837158), v.min() =np.float64(23.59262800992173)
Solve for t=172.00, v.max() =np.float64(25.67947983867271), v.min() =np.float64(23.550514098056986)
Solve for t=173.00, v.max() =np.float64(25.670638871083295), v.min() =np.float64(23.507215926660436)
Solve for t=174.00, v.max() =np.float64(25.660997586838175), v.min() =np.float64(23.4627633912434)
Solve for t=175.00, v.max() =np.float64(25.65058453762432), v.min() =np.float64(23.417182432199056)
Solve for t=176.00, v.max() =np.float64(25.639425225376595), v.min() =np.float64(23.37049556005146)
Solve for t=177.00, v.max() =np.float64(25.62754252041582), v.min() =np.float64(23.322722315837332)
Solve for t=178.00, v.max() =np.float64(25.614957025613734), v.min() =np.float64(23.273879673773482)
Solve for t=179.00, v.max() =np.float64(25.601687393033245), v.min() =np.float64(23.22398239267793)
Solve for t=180.00, v.max() =np.float64(25.587750598789857), v.min() =np.float64(23.173043321974333)
Solve for t=181.00, v.max() =np.float64(25.573162181241212), v.min() =np.float64(23.121073667518388)
Solve for t=182.00, v.max() =np.float64(25.557936447035374), v.min() =np.float64(23.0680832219417)
Solve for t=183.00, v.max() =np.float64(25.54208664902728), v.min() =np.float64(23.014080563711957)
Solve for t=184.00, v.max() =np.float64(25.525625139606394), v.min() =np.float64(22.959073228654155)
Solve for t=185.00, v.max() =np.float64(25.508563502564105), v.min() =np.float64(22.903067857270948)
Solve for t=186.00, v.max() =np.float64(25.490912666252843), v.min() =np.float64(22.84607032082571)
Solve for t=187.00, v.max() =np.float64(25.472683000461753), v.min() =np.float64(22.788085828822332)
Solve for t=188.00, v.max() =np.float64(25.453884399136893), v.min() =np.float64(22.72911902021111)
Solve for t=189.00, v.max() =np.float64(25.43452635081623), v.min() =np.float64(22.66917404038727)
Solve for t=190.00, v.max() =np.float64(25.41461799841495), v.min() =np.float64(22.60825460580208)
Solve for t=191.00, v.max() =np.float64(25.394168189795938), v.min() =np.float64(22.546364057796318)
Solve for t=192.00, v.max() =np.float64(25.37318552038052), v.min() =np.float64(22.483505407072734)
Solve for t=193.00, v.max() =np.float64(25.351678368893804), v.min() =np.float64(22.419681370054896)
Solve for t=194.00, v.max() =np.float64(25.329654927201616), v.min() =np.float64(22.354894398227565)
Solve for t=195.00, v.max() =np.float64(25.307123225071983), v.min() =np.float64(22.289146701419956)
Solve for t=196.00, v.max() =np.float64(25.284091150588214), v.min() =np.float64(22.222440265874873)
Solve for t=197.00, v.max() =np.float64(25.26056646684355), v.min() =np.float64(22.154776867840944)
Solve for t=198.00, v.max() =np.float64(25.236556825467364), v.min() =np.float64(22.08615808333221)
Solve for t=199.00, v.max() =np.float64(25.21206977745824), v.min() =np.float64(22.01658529461651)
Solve for t=200.00, v.max() =np.float64(25.18711278173561), v.min() =np.float64(21.94605969392256)
Solve for t=201.00, v.max() =np.float64(25.16169321176965), v.min() =np.float64(21.874582284791327)
Solve for t=202.00, v.max() =np.float64(25.135818360595064), v.min() =np.float64(21.80215388144009)
Solve for t=203.00, v.max() =np.float64(25.10949544447607), v.min() =np.float64(21.7287751064593)
Solve for t=204.00, v.max() =np.float64(25.0827316054523), v.min() =np.float64(21.654446387117314)
Solve for t=205.00, v.max() =np.float64(25.05553391296273), v.min() =np.float64(21.579167950512712)
Solve for t=206.00, v.max() =np.float64(25.027909364715544), v.min() =np.float64(21.502939817775445)
Solve for t=207.00, v.max() =np.float64(24.999864886950014), v.min() =np.float64(21.42576179749312)
Solve for t=208.00, v.max() =np.float64(24.971407334213318), v.min() =np.float64(21.347633478511916)
Solve for t=209.00, v.max() =np.float64(24.94254348875718), v.min() =np.float64(21.26855422223643)
Solve for t=210.00, v.max() =np.float64(24.913280059644425), v.min() =np.float64(21.188523154536956)
Solve for t=211.00, v.max() =np.float64(24.88362368164018), v.min() =np.float64(21.10753915735259)
Solve for t=212.00, v.max() =np.float64(24.853580913951372), v.min() =np.float64(21.02560086006577)
Solve for t=213.00, v.max() =np.float64(24.823158238867446), v.min() =np.float64(20.942706630707967)
Solve for t=214.00, v.max() =np.float64(24.7923620603479), v.min() =np.float64(20.8588545670488)
Solve for t=215.00, v.max() =np.float64(24.761198702590892), v.min() =np.float64(20.774042487606778)
Solve for t=216.00, v.max() =np.float64(24.72967440861533), v.min() =np.float64(20.688267922614912)
Solve for t=217.00, v.max() =np.float64(24.69779533887912), v.min() =np.float64(20.60152810496502)
Solve for t=218.00, v.max() =np.float64(24.665567569954852), v.min() =np.float64(20.513819961149242)
Solve for t=219.00, v.max() =np.float64(24.632997093276007), v.min() =np.float64(20.425140102209838)
Solve for t=220.00, v.max() =np.float64(24.600089813967386), v.min() =np.float64(20.33548481470685)
Solve for t=221.00, v.max() =np.float64(24.566851549768753), v.min() =np.float64(20.244850051706536)
Solve for t=222.00, v.max() =np.float64(24.53328803005702), v.min() =np.float64(20.153231423790317)
Solve for t=223.00, v.max() =np.float64(24.49940489497169), v.min() =np.float64(20.060624190082553)
Solve for t=224.00, v.max() =np.float64(24.465207694645997), v.min() =np.float64(19.96702324929082)
Solve for t=225.00, v.max() =np.float64(24.430701888545986), v.min() =np.float64(19.872423130752225)
Solve for t=226.00, v.max() =np.float64(24.395892844914652), v.min() =np.float64(19.776817985475493)
Solve for t=227.00, v.max() =np.float64(24.360785840322855), v.min() =np.float64(19.68020157716874)
Solve for t=228.00, v.max() =np.float64(24.325386059322796), v.min() =np.float64(19.582567273240286)
Solve for t=229.00, v.max() =np.float64(24.289698594202402), v.min() =np.float64(19.483908035759274)
Solve for t=230.00, v.max() =np.float64(24.25372844483744), v.min() =np.float64(19.384216412362214)
Solve for t=231.00, v.max() =np.float64(24.21748051863712), v.min() =np.float64(19.2834845270901)
Solve for t=232.00, v.max() =np.float64(24.18095963057975), v.min() =np.float64(19.18170407114012)
Solve for t=233.00, v.max() =np.float64(24.144170503334596), v.min() =np.float64(19.078866293516768)
Solve for t=234.00, v.max() =np.float64(24.107117767464096), v.min() =np.float64(18.974961991564214)
Solve for t=235.00, v.max() =np.float64(24.069805961705335), v.min() =np.float64(18.86998150136392)
Solve for t=236.00, v.max() =np.float64(24.032239533321967), v.min() =np.float64(18.763914687979295)
Solve for t=237.00, v.max() =np.float64(23.994422838525956), v.min() =np.float64(18.65675093552978)
Solve for t=238.00, v.max() =np.float64(23.956360142963064), v.min() =np.float64(18.548479137076495)
Solve for t=239.00, v.max() =np.float64(23.918055622258198), v.min() =np.float64(18.43908768430074)
Solve for t=240.00, v.max() =np.float64(23.87951336261553), v.min() =np.float64(18.328564456956506)
Solve for t=241.00, v.max() =np.float64(23.84073736147158), v.min() =np.float64(18.21689681207905)
Solve for t=242.00, v.max() =np.float64(23.80173152819435), v.min() =np.float64(18.10407157292935)
Solve for t=243.00, v.max() =np.float64(23.762499684827173), v.min() =np.float64(17.990075017655702)
Solve for t=244.00, v.max() =np.float64(23.72304556687207), v.min() =np.float64(17.87489286765313)
Solve for t=245.00, v.max() =np.float64(23.683372824109885), v.min() =np.float64(17.758510275599743)
Solve for t=246.00, v.max() =np.float64(23.643485021453355), v.min() =np.float64(17.640911813151178)
Solve for t=247.00, v.max() =np.float64(23.60338563983059), v.min() =np.float64(17.52208145827233)
Solve for t=248.00, v.max() =np.float64(23.563078077094524), v.min() =np.float64(17.402002582184995)
Solve for t=249.00, v.max() =np.float64(23.522565648956924), v.min() =np.float64(17.280657935911435)
Solve for t=250.00, v.max() =np.float64(23.48185158994348), v.min() =np.float64(17.15802963639191)
Solve for t=251.00, v.max() =np.float64(23.440939054366844), v.min() =np.float64(17.03409915215496)
Solve for t=252.00, v.max() =np.float64(23.399831117316552), v.min() =np.float64(16.908847288518164)
Solve for t=253.00, v.max() =np.float64(23.358530775661748), v.min() =np.float64(16.782254172296792)
Solve for t=254.00, v.max() =np.float64(23.317040949066037), v.min() =np.float64(16.654299235998412)
Solve for t=255.00, v.max() =np.float64(23.27536448101122), v.min() =np.float64(16.52496120147928)
Solve for t=256.00, v.max() =np.float64(23.23350413982892), v.min() =np.float64(16.394218063040125)
Solve for t=257.00, v.max() =np.float64(23.191462619737294), v.min() =np.float64(16.262047069935857)
Solve for t=258.00, v.max() =np.float64(23.149242541882096), v.min() =np.float64(16.12842470827794)
Solve for t=259.00, v.max() =np.float64(23.106846455379497), v.min() =np.float64(15.993326682301063)
Solve for t=260.00, v.max() =np.float64(23.06427683836049), v.min() =np.float64(15.856727894972948)
Solve for t=261.00, v.max() =np.float64(23.021536099013474), v.min() =np.float64(15.718602427920057)
Solve for t=262.00, v.max() =np.float64(22.978626576626198), v.min() =np.float64(15.578923520645565)
Solve for t=263.00, v.max() =np.float64(22.935550542623616), v.min() =np.float64(15.437663549013287)
Solve for t=264.00, v.max() =np.float64(22.89231020160242), v.min() =np.float64(15.294794002974317)
Solve for t=265.00, v.max() =np.float64(22.848907692359), v.min() =np.float64(15.150285463509382)
Solve for t=266.00, v.max() =np.float64(22.805345088912556), v.min() =np.float64(15.004107578764948)
Solve for t=267.00, v.max() =np.float64(22.761624401519914), v.min() =np.float64(14.856229039358468)
Solve for t=268.00, v.max() =np.float64(22.717747577683863), v.min() =np.float64(14.706617552830297)
Solve for t=269.00, v.max() =np.float64(22.67371650315078), v.min() =np.float64(14.555239817220501)
Solve for t=270.00, v.max() =np.float64(22.629533002901212), v.min() =np.float64(14.402061493752587)
Solve for t=271.00, v.max() =np.float64(22.58519884212842), v.min() =np.float64(14.247047178604296)
Solve for t=272.00, v.max() =np.float64(22.5407157272076), v.min() =np.float64(14.0901603737528)
Solve for t=273.00, v.max() =np.float64(22.496085306654482), v.min() =np.float64(13.931363456882101)
Solve for t=274.00, v.max() =np.float64(22.4513091720707), v.min() =np.float64(13.77061765034368)
Solve for t=275.00, v.max() =np.float64(22.406388859078557), v.min() =np.float64(13.607882989170127)
Solve for t=276.00, v.max() =np.float64(22.361325848244064), v.min() =np.float64(13.443118288143925)
Solve for t=277.00, v.max() =np.float64(22.316121565985068), v.min() =np.float64(13.27628110793041)
Solve for t=278.00, v.max() =np.float64(22.270777385468982), v.min() =np.float64(13.107327720295732)
Solve for t=279.00, v.max() =np.float64(22.225294627495995), v.min() =np.float64(12.936213072435926)
Solve for t=280.00, v.max() =np.float64(22.179674561368994), v.min() =np.float64(12.762890750458281)
Solve for t=281.00, v.max() =np.float64(22.13391840575029), v.min() =np.float64(12.587312942066829)
Solve for t=282.00, v.max() =np.float64(22.08802732950447), v.min() =np.float64(12.40943039852156)
Solve for t=283.00, v.max() =np.float64(22.04200245252718), v.min() =np.float64(12.229192395957643)
Solve for t=284.00, v.max() =np.float64(21.995844846559912), v.min() =np.float64(12.046546696171424)
Solve for t=285.00, v.max() =np.float64(21.949555535991472), v.min() =np.float64(11.861439507005763)
Solve for t=286.00, v.max() =np.float64(21.903135498644183), v.min() =np.float64(11.673815442492067)
Solve for t=287.00, v.max() =np.float64(21.856585666546696), v.min() =np.float64(11.483617482938824)
Solve for t=288.00, v.max() =np.float64(21.809906926692726), v.min() =np.float64(11.290786935192129)
Solve for t=289.00, v.max() =np.float64(21.763100121785204), v.min() =np.float64(11.095263393331246)
Solve for t=290.00, v.max() =np.float64(21.71616605096629), v.min() =np.float64(10.896984700108876)
Solve for t=291.00, v.max() =np.float64(21.66910547053354), v.min() =np.float64(10.695886909494144)
Solve for t=292.00, v.max() =np.float64(21.62191909464202), v.min() =np.float64(10.49190425073112)
Solve for t=293.00, v.max() =np.float64(21.574607595991885), v.min() =np.float64(10.28496909438546)
Solve for t=294.00, v.max() =np.float64(21.527171606502748), v.min() =np.float64(10.075011920917929)
Solve for t=295.00, v.max() =np.float64(21.47961171797351), v.min() =np.float64(9.86196129239214)
Solve for t=296.00, v.max() =np.float64(21.43192848272895), v.min() =np.float64(9.645743827999084)
Solve for t=297.00, v.max() =np.float64(21.384122414252552), v.min() =np.float64(9.426284184157376)
Solve for t=298.00, v.max() =np.float64(21.33619398780517), v.min() =np.float64(9.203505040026375)
Solve for t=299.00, v.max() =np.float64(21.288143641031255), v.min() =np.float64(8.97732708934723)
Solve for t=300.00, v.max() =np.float64(21.239971774551233), v.min() =np.float64(8.74766903959743)
Solve for t=301.00, v.max() =np.float64(21.191678752540184), v.min() =np.float64(8.514447619508376)
Solve for t=302.00, v.max() =np.float64(21.14326490329474), v.min() =np.float64(8.277577596042464)
Solve for t=303.00, v.max() =np.float64(21.09473051978627), v.min() =np.float64(8.036971801949543)
Solve for t=304.00, v.max() =np.float64(21.046075860200926), v.min() =np.float64(7.792541175012099)
Solve for t=305.00, v.max() =np.float64(20.997301148468562), v.min() =np.float64(7.544194810034325)
Solve for t=306.00, v.max() =np.float64(20.948406574777415), v.min() =np.float64(7.291840024510174)
Solve for t=307.00, v.max() =np.float64(20.89939229607774), v.min() =np.float64(7.035382438710384)
Solve for t=308.00, v.max() =np.float64(20.85025843657316), v.min() =np.float64(6.774726070627823)
Solve for t=309.00, v.max() =np.float64(20.80100508819992), v.min() =np.float64(6.509773445794767)
Solve for t=310.00, v.max() =np.float64(20.75163231109406), v.min() =np.float64(6.2404257214046455)
Solve for t=311.00, v.max() =np.float64(20.70214013404764), v.min() =np.float64(5.966582823404225)
Solve for t=312.00, v.max() =np.float64(20.652528554953186), v.min() =np.float64(5.688143594237049)
Solve for t=313.00, v.max() =np.float64(20.602797541236995), v.min() =np.float64(5.4050059476864485)
Solve for t=314.00, v.max() =np.float64(20.55294703028107), v.min() =np.float64(5.1170670257566755)
Solve for t=315.00, v.max() =np.float64(20.50297692983473), v.min() =np.float64(4.8242233507250365)
Solve for t=316.00, v.max() =np.float64(20.45288711841491), v.min() =np.float64(4.5263709633878495)
Solve for t=317.00, v.max() =np.float64(20.402677445696607), v.min() =np.float64(4.223405536119724)
Solve for t=318.00, v.max() =np.float64(20.352347732892145), v.min() =np.float64(3.9152224467061103)
Solve for t=319.00, v.max() =np.float64(20.301897773121187), v.min() =np.float64(3.601716796063403)
Solve for t=320.00, v.max() =np.float64(20.251327331769804), v.min() =np.float64(3.2827833500388666)
Solve for t=321.00, v.max() =np.float64(20.200636146840736), v.min() =np.float64(2.958316382642975)
Solve for t=322.00, v.max() =np.float64(20.149823929293028), v.min() =np.float64(2.6282093955127306)
Solve for t=323.00, v.max() =np.float64(20.098890363373208), v.min() =np.float64(2.292354686388995)
Solve for t=324.00, v.max() =np.float64(20.047835106936493), v.min() =np.float64(1.9506427381987776)
Solve for t=325.00, v.max() =np.float64(19.99665779175876), v.min() =np.float64(1.6029614002693797)
Solve for t=326.00, v.max() =np.float64(19.945358023840576), v.min() =np.float64(1.2491948345553443)
Solve for t=327.00, v.max() =np.float64(19.893935383701724), v.min() =np.float64(0.8892222027737638)
Solve for t=328.00, v.max() =np.float64(19.84238942666719), v.min() =np.float64(0.5229160751702462)
Solve for t=329.00, v.max() =np.float64(19.790719683145184), v.min() =np.float64(0.15014054829296786)
Solve for t=330.00, v.max() =np.float64(19.73892565889632), v.min() =np.float64(-0.22925093251401785)
Solve for t=331.00, v.max() =np.float64(19.68700683529611), v.min() =np.float64(-0.6154180405106613)
Solve for t=332.00, v.max() =np.float64(19.63496266958787), v.min() =np.float64(-1.008536308959607)
Solve for t=333.00, v.max() =np.float64(19.582792595129256), v.min() =np.float64(-1.4088001199433433)
Solve for t=334.00, v.max() =np.float64(19.530496021630917), v.min() =np.float64(-1.816425903875717)
Solve for t=335.00, v.max() =np.float64(19.478072335387857), v.min() =np.float64(-2.231655504080614)
Solve for t=336.00, v.max() =np.float64(19.42552089950364), v.min() =np.float64(-2.6547596537219684)
Solve for t=337.00, v.max() =np.float64(19.37284105410772), v.min() =np.float64(-3.086041507445881)
Solve for t=338.00, v.max() =np.float64(19.320032116566065), v.min() =np.float64(-3.52584016739366)
Solve for t=339.00, v.max() =np.float64(19.267093381684706), v.min() =np.float64(-3.974534142492805)
Solve for t=340.00, v.max() =np.float64(19.21402412190821), v.min() =np.float64(-4.432544680542447)
Solve for t=341.00, v.max() =np.float64(19.160823587509906), v.min() =np.float64(-4.900338913731098)
Solve for t=342.00, v.max() =np.float64(19.10749100677791), v.min() =np.float64(-5.378432758846311)
Solve for t=343.00, v.max() =np.float64(19.05402558619406), v.min() =np.float64(-5.867393512482423)
Solve for t=344.00, v.max() =np.float64(19.00042651060818), v.min() =np.float64(-6.3678420780301535)
Solve for t=345.00, v.max() =np.float64(18.946692943405335), v.min() =np.float64(-6.880454754318795)
Solve for t=346.00, v.max() =np.float64(18.892824026669402), v.min() =np.float64(-7.4059645049666365)
Solve for t=347.00, v.max() =np.float64(18.838818881340455), v.min() =np.float64(-7.945161612654603)
Solve for t=348.00, v.max() =np.float64(18.784676607367352), v.min() =np.float64(-8.498893604069776)
Solve for t=349.00, v.max() =np.float64(18.73039628385573), v.min() =np.float64(-9.068064310179773)
Solve for t=350.00, v.max() =np.float64(18.675976969210904), v.min() =np.float64(-9.653631904573558)
Solve for t=351.00, v.max() =np.float64(18.62141770127706), v.min() =np.float64(-10.256605742516998)
Solve for t=352.00, v.max() =np.float64(18.566717497471505), v.min() =np.float64(-10.878041808852354)
Solve for t=353.00, v.max() =np.float64(18.511875354915073), v.min() =np.float64(-11.519036578796584)
Solve for t=354.00, v.max() =np.float64(18.456890250558722), v.min() =np.float64(-12.1807191080818)
Solve for t=355.00, v.max() =np.float64(18.40176114130654), v.min() =np.float64(-12.864241204669947)
Solve for t=356.00, v.max() =np.float64(18.346486964134787), v.min() =np.float64(-13.570765600791868)
Solve for t=357.00, v.max() =np.float64(18.291066636208082), v.min() =np.float64(-14.301452148058742)
Solve for t=358.00, v.max() =np.float64(18.235499054992406), v.min() =np.float64(-15.05744220455223)
Solve for t=359.00, v.max() =np.float64(18.17978309836467), v.min() =np.float64(-15.839841571814548)
Solve for t=360.00, v.max() =np.float64(18.123917624720114), v.min() =np.float64(-16.64970256602214)
Solve for t=361.00, v.max() =np.float64(18.06790147307731), v.min() =np.float64(-17.4880060577115)
Solve for t=362.00, v.max() =np.float64(18.0117334631799), v.min() =np.float64(-18.355644565551405)
Solve for t=363.00, v.max() =np.float64(17.955412395597573), v.min() =np.float64(-19.253407711040694)
Solve for t=364.00, v.max() =np.float64(17.898937051823676), v.min() =np.float64(-20.18197149735071)
Solve for t=365.00, v.max() =np.float64(17.842306194372437), v.min() =np.float64(-21.14189293327405)
Solve for t=366.00, v.max() =np.float64(17.785518566873492), v.min() =np.float64(-22.133611458391517)
Solve for t=367.00, v.max() =np.float64(17.728572894166366), v.min() =np.float64(-23.157458430885466)
Solve for t=368.00, v.max() =np.float64(17.6714678823932), v.min() =np.float64(-24.213675627899043)
Solve for t=369.00, v.max() =np.float64(17.61420221909065), v.min() =np.float64(-25.302443311167398)
Solve for t=370.00, v.max() =np.float64(17.556774573281494), v.min() =np.float64(-26.42391796988701)
Solve for t=371.00, v.max() =np.float64(17.499183595565665), v.min() =np.float64(-27.578279411733046)
Solve for t=372.00, v.max() =np.float64(17.44142791821156), v.min() =np.float64(-28.765786467880474)
Solve for t=373.00, v.max() =np.float64(17.38350615524711), v.min() =np.float64(-29.98684023295816)
Solve for t=374.00, v.max() =np.float64(17.325416902551467), v.min() =np.float64(-31.24205348442585)
Solve for t=375.00, v.max() =np.float64(17.26715873794738), v.min() =np.float64(-32.53232470474361)
Solve for t=376.00, v.max() =np.float64(17.20873022129438), v.min() =np.float64(-33.85891491837235)
Solve for t=377.00, v.max() =np.float64(17.15012989458347), v.min() =np.float64(-35.2235252591653)
Solve for t=378.00, v.max() =np.float64(17.09135628203285), v.min() =np.float64(-36.62837263401286)
Solve for t=379.00, v.max() =np.float64(17.032407890186096), v.min() =np.float64(-38.07625977220995)
Solve for t=380.00, v.max() =np.float64(16.973283208011534), v.min() =np.float64(-39.570633922911675)
Solve for t=381.00, v.max() =np.float64(16.91398070700485), v.min() =np.float64(-41.11562485726631)
Solve for t=382.00, v.max() =np.float64(16.85449884129395), v.min() =np.float64(-42.716046743251795)
Solve for t=383.00, v.max() =np.float64(16.7948360477467), v.min() =np.float64(-44.37733844144482)
Solve for t=384.00, v.max() =np.float64(16.73499074608235), v.min() =np.float64(-46.10540188280699)
Solve for t=385.00, v.max() =np.float64(16.674961338986527), v.min() =np.float64(-47.90627673671856)
Solve for t=386.00, v.max() =np.float64(16.614746212230187), v.min() =np.float64(-49.78556285276716)
Solve for t=387.00, v.max() =np.float64(16.554343734792546), v.min() =np.float64(-51.74747699704387)
Solve for t=388.00, v.max() =np.float64(16.493752258989733), v.min() =np.float64(-53.793427532281925)
Solve for t=389.00, v.max() =np.float64(16.43297012060733), v.min() =np.float64(-55.92005241224015)
Solve for t=390.00, v.max() =np.float64(16.371995639039543), v.min() =np.float64(-58.11685499793118)
Solve for t=391.00, v.max() =np.float64(16.310827117433355), v.min() =np.float64(-60.363931416529496)
Solve for t=392.00, v.max() =np.float64(16.249462842839424), v.min() =np.float64(-62.63072972929617)
Solve for t=393.00, v.max() =np.float64(16.18790108636964), v.min() =np.float64(-64.87699492212909)
Solve for t=394.00, v.max() =np.float64(16.12614010336209), v.min() =np.float64(-67.05658279485377)
Solve for t=395.00, v.max() =np.float64(16.064178133552655), v.min() =np.float64(-69.12358293669095)
Solve for t=396.00, v.max() =np.float64(16.002013401255866), v.min() =np.float64(-71.03889350039111)
Solve for t=397.00, v.max() =np.float64(15.939644115553483), v.min() =np.float64(-72.77508238262398)
Solve for t=398.00, v.max() =np.float64(15.877068470492526), v.min() =np.float64(-74.31829607482977)
Solve for t=399.00, v.max() =np.float64(15.814284645292458), v.min() =np.float64(-75.66733640235978)
Solve for t=400.00, v.max() =np.float64(15.751290804562505), v.min() =np.float64(-76.83091358831533)
Solve for t=401.00, v.max() =np.float64(15.68808509852976), v.min() =np.float64(-77.82425354352766)
Solve for t=402.00, v.max() =np.float64(15.624665663277836), v.min() =np.float64(-78.66594755338703)
Solve for t=403.00, v.max() =np.float64(15.56103062099822), v.min() =np.float64(-79.37551081243711)
Solve for t=404.00, v.max() =np.float64(15.49717808025244), v.min() =np.float64(-79.97176032913328)
Solve for t=405.00, v.max() =np.float64(15.433106136248162), v.min() =np.float64(-80.47190505667373)
Solve for t=406.00, v.max() =np.float64(15.368812871128524), v.min() =np.float64(-80.89115525301067)
Solve for t=407.00, v.max() =np.float64(15.304296354275323), v.min() =np.float64(-81.24266031615446)
Solve for t=408.00, v.max() =np.float64(15.239554642626961), v.min() =np.float64(-81.53762693958836)
Solve for t=409.00, v.max() =np.float64(15.17458578101201), v.min() =np.float64(-81.78551904639974)
Solve for t=410.00, v.max() =np.float64(15.109387802498857), v.min() =np.float64(-81.99428160285117)
Solve for t=411.00, v.max() =np.float64(15.043958728761998), v.min() =np.float64(-82.17055816828727)
Solve for t=412.00, v.max() =np.float64(14.978296570466032), v.min() =np.float64(-82.3198887479958)
Solve for t=413.00, v.max() =np.float64(14.912399327668444), v.min() =np.float64(-82.44688357334854)
Solve for t=414.00, v.max() =np.float64(14.84626499023956), v.min() =np.float64(-82.55537285337509)
Solve for t=415.00, v.max() =np.float64(14.779891538305247), v.min() =np.float64(-82.64853442442083)
Solve for t=416.00, v.max() =np.float64(14.71327694270805), v.min() =np.float64(-82.72900184064527)
Solve for t=417.00, v.max() =np.float64(14.646419165491187), v.min() =np.float64(-82.79895549050886)
Solve for t=418.00, v.max() =np.float64(14.579316160403788), v.min() =np.float64(-82.8601991381562)
Solve for t=419.00, v.max() =np.float64(14.511965873431105), v.min() =np.float64(-82.91422403107794)
Solve for t=420.00, v.max() =np.float64(14.444366243346995), v.min() =np.float64(-82.96226245144814)
Solve for t=421.00, v.max() =np.float64(14.376515202293376), v.min() =np.float64(-83.00533234157072)
Solve for t=422.00, v.max() =np.float64(14.308410676384312), v.min() =np.float64(-83.04427441034778)
Solve for t=423.00, v.max() =np.float64(14.24005058633849), v.min() =np.float64(-83.07978292831174)
Solve for t=424.00, v.max() =np.float64(14.171432848139254), v.min() =np.float64(-83.11243124223292)
Solve for t=425.00, v.max() =np.float64(14.102555373723593), v.min() =np.float64(-83.14269288513749)
Solve for t=426.00, v.max() =np.float64(14.033416071701806), v.min() =np.float64(-83.17095902210215)
Solve for t=427.00, v.max() =np.float64(13.964012848108933), v.min() =np.float64(-83.19755285480755)
Solve for t=428.00, v.max() =np.float64(13.894343607187423), v.min() =np.float64(-83.22274150687723)
Solve for t=429.00, v.max() =np.float64(13.824406252204987), v.min() =np.float64(-83.24674582584736)
Solve for t=430.00, v.max() =np.float64(13.754198686306317), v.min() =np.float64(-83.26974846446085)
Solve for t=431.00, v.max() =np.float64(13.683718813400697), v.min() =np.float64(-83.29190054231988)
Solve for t=432.00, v.max() =np.float64(13.612964539087958), v.min() =np.float64(-83.31332713718284)
Solve for t=433.00, v.max() =np.float64(13.541933771622105), v.min() =np.float64(-83.33413181194302)
Solve for t=434.00, v.max() =np.float64(13.470624422914696), v.min() =np.float64(-83.35440034735099)
Solve for t=435.00, v.max() =np.float64(13.399034409580246), v.min() =np.float64(-83.37420382068102)
Solve for t=436.00, v.max() =np.float64(13.327161654022992), v.min() =np.float64(-83.39360114580951)
Solve for t=437.00, v.max() =np.float64(13.255004085568762), v.min() =np.float64(-83.4126411697777)
Solve for t=438.00, v.max() =np.float64(13.182559641640834), v.min() =np.float64(-83.43136440403778)
Solve for t=439.00, v.max() =np.float64(13.109826268983477), v.min() =np.float64(-83.44980445474849)
Solve for t=440.00, v.max() =np.float64(13.03680192493339), v.min() =np.float64(-83.46798920503448)
Solve for t=441.00, v.max() =np.float64(12.963484578740077), v.min() =np.float64(-83.48594240888646)
Solve for t=442.00, v.max() =np.float64(12.889872212938249), v.min() =np.float64(-83.50368433082691)
Solve for t=443.00, v.max() =np.float64(12.815962824772194), v.min() =np.float64(-83.52123012505322)
Solve for t=444.00, v.max() =np.float64(12.741754427674598), v.min() =np.float64(-83.53859251830599)
Solve for t=445.00, v.max() =np.float64(12.667245052800686), v.min() =np.float64(-83.5557820741116)
Solve for t=446.00, v.max() =np.float64(12.592432750619738), v.min() =np.float64(-83.57280771301481)
Solve for t=447.00, v.max() =np.float64(12.517315592565945), v.min() =np.float64(-83.58967676953152)
Solve for t=448.00, v.max() =np.float64(12.441891672748305), v.min() =np.float64(-83.60639542501802)
Solve for t=449.00, v.max() =np.float64(12.366159109724041), v.min() =np.float64(-83.62296869598207)
Solve for t=450.00, v.max() =np.float64(12.290116048334566), v.min() =np.float64(-83.63940103476978)
Solve for t=451.00, v.max() =np.float64(12.213760661606965), v.min() =np.float64(-83.65569596857556)
Solve for t=452.00, v.max() =np.float64(12.137091152722235), v.min() =np.float64(-83.6718564592512)
Solve for t=453.00, v.max() =np.float64(12.06010575705212), v.min() =np.float64(-83.68788502807607)
Solve for t=454.00, v.max() =np.float64(11.982802744265651), v.min() =np.float64(-83.70378376547812)
Solve for t=455.00, v.max() =np.float64(11.905180420507282), v.min() =np.float64(-83.71955440528687)
Solve for t=456.00, v.max() =np.float64(11.827237130648383), v.min() =np.float64(-83.73519838672466)
Solve for t=457.00, v.max() =np.float64(11.748971260613372), v.min() =np.float64(-83.7507170062891)
Solve for t=458.00, v.max() =np.float64(11.670381239781932), v.min() =np.float64(-83.76611123704812)
Solve for t=459.00, v.max() =np.float64(11.591465543469049), v.min() =np.float64(-83.78138185572516)
Solve for t=460.00, v.max() =np.float64(11.51222269548429), v.min() =np.float64(-83.79652966376572)
Solve for t=461.00, v.max() =np.float64(11.432651270771434), v.min() =np.float64(-83.81155524472965)
Solve for t=462.00, v.max() =np.float64(11.352749898130453), v.min() =np.float64(-83.82645906266137)
Solve for t=463.00, v.max() =np.float64(11.27251726302246), v.min() =np.float64(-83.84124164368052)
Solve for t=464.00, v.max() =np.float64(11.191952110459056), v.min() =np.float64(-83.85590328649218)
Solve for t=465.00, v.max() =np.float64(11.111053247977601), v.min() =np.float64(-83.87044438720939)
Solve for t=466.00, v.max() =np.float64(11.02981954870313), v.min() =np.float64(-83.88486523156664)
Solve for t=467.00, v.max() =np.float64(10.948249954498063), v.min() =np.float64(-83.89916606909793)
Solve for t=468.00, v.max() =np.float64(10.86634347920037), v.min() =np.float64(-83.91334724411938)
Solve for t=469.00, v.max() =np.float64(10.784099211951112), v.min() =np.float64(-83.92740893834112)
Solve for t=470.00, v.max() =np.float64(10.701516320612319), v.min() =np.float64(-83.94135141221648)
Solve for t=471.00, v.max() =np.float64(10.61859405527508), v.min() =np.float64(-83.95517494789534)
Solve for t=472.00, v.max() =np.float64(10.535331751858479), v.min() =np.float64(-83.96887977506447)
Solve for t=473.00, v.max() =np.float64(10.451728835800186), v.min() =np.float64(-83.98246614856163)
Solve for t=474.00, v.max() =np.float64(10.367784825837397), v.min() =np.float64(-83.99593434086385)
Solve for t=475.00, v.max() =np.float64(10.283499337879183), v.min() =np.float64(-84.00928463743685)
Solve for t=476.00, v.max() =np.float64(10.19887208896931), v.min() =np.float64(-84.02251733485986)
Solve for t=477.00, v.max() =np.float64(10.113902901338927), v.min() =np.float64(-84.03563273041259)
Solve for t=478.00, v.max() =np.float64(10.028591706548529), v.min() =np.float64(-84.04863114774034)
Solve for t=479.00, v.max() =np.float64(9.942938549717788), v.min() =np.float64(-84.06151292598783)
Solve for t=480.00, v.max() =np.float64(9.856943593841985), v.min() =np.float64(-84.07427842058107)
Solve for t=481.00, v.max() =np.float64(9.770607124193422), v.min() =np.float64(-84.08692800376953)
Solve for t=482.00, v.max() =np.float64(9.683929552806308), v.min() =np.float64(-84.09946206497914)
Solve for t=483.00, v.max() =np.float64(9.596911423041478), v.min() =np.float64(-84.11188101100157)
Solve for t=484.00, v.max() =np.float64(9.5095534142302), v.min() =np.float64(-84.12418526606281)
Solve for t=485.00, v.max() =np.float64(9.421856346391984), v.min() =np.float64(-84.13637527177706)
Solve for t=486.00, v.max() =np.float64(9.333821185024691), v.min() =np.float64(-84.14845148702057)
Solve for t=487.00, v.max() =np.float64(9.245449045962317), v.min() =np.float64(-84.16041438773594)
Solve for t=488.00, v.max() =np.float64(9.156741200296235), v.min() =np.float64(-84.17226446667215)
Solve for t=489.00, v.max() =np.float64(9.067699079355021), v.min() =np.float64(-84.18400223307816)
Solve for t=490.00, v.max() =np.float64(8.978324279738608), v.min() =np.float64(-84.19562821236133)
Solve for t=491.00, v.max() =np.float64(8.888618568399727), v.min() =np.float64(-84.2071429457057)
Solve for t=492.00, v.max() =np.float64(8.798583887767611), v.min() =np.float64(-84.21854698966878)
Solve for t=493.00, v.max() =np.float64(8.70822236090655), v.min() =np.float64(-84.22984091633681)
Solve for t=494.00, v.max() =np.float64(8.617536296702362), v.min() =np.float64(-84.24102531104755)
Solve for t=495.00, v.max() =np.float64(8.526528195068808), v.min() =np.float64(-84.25210077413793)
Solve for t=496.00, v.max() =np.float64(8.435200752165745), v.min() =np.float64(-84.26306791915943)
Solve for t=497.00, v.max() =np.float64(8.343556865619414), v.min() =np.float64(-84.27392737281129)
Solve for t=498.00, v.max() =np.float64(8.251599639735934), v.min() =np.float64(-84.28467977331641)
Solve for t=499.00, v.max() =np.float64(8.159332390697392), v.min() =np.float64(-84.29532577192626)
Solve for t=500.00, v.max() =np.float64(8.066758651729598), v.min() =np.float64(-84.30586603194128)
Solve for t=501.00, v.max() =np.float64(7.973882178229982), v.min() =np.float64(-84.31630122772086)
Solve for t=502.00, v.max() =np.float64(7.880706952843435), v.min() =np.float64(-84.32663204418883)
Solve for t=503.00, v.max() =np.float64(7.787237190473274), v.min() =np.float64(-84.33685917633886)
Solve for t=504.00, v.max() =np.float64(7.693477343213878), v.min() =np.float64(-84.34698332874018)
Solve for t=505.00, v.max() =np.float64(7.599432105190719), v.min() =np.float64(-84.35700521504491)
Solve for t=506.00, v.max() =np.float64(7.505106417292976), v.min() =np.float64(-84.36692555749585)
Solve for t=507.00, v.max() =np.float64(7.41050547178351), v.min() =np.float64(-84.37674508643953)
Solve for t=508.00, v.max() =np.float64(7.315634716769963), v.min() =np.float64(-84.38646453984163)
Solve for t=509.00, v.max() =np.float64(7.2204998605206105), v.min() =np.float64(-84.39608466280835)
Solve for t=510.00, v.max() =np.float64(7.12510687560761), v.min() =np.float64(-84.40560620711375)
Solve for t=511.00, v.max() =np.float64(7.029462002860061), v.min() =np.float64(-84.41502993073003)
Solve for t=512.00, v.max() =np.float64(6.933571755108695), v.min() =np.float64(-84.42435659736788)
Solve for t=513.00, v.max() =np.float64(6.837442920703715), v.min() =np.float64(-84.43358697602231)
Solve for t=514.00, v.max() =np.float64(6.741082566786666), v.min() =np.float64(-84.4427218405263)
Solve for t=515.00, v.max() =np.float64(6.644498042297155), v.min() =np.float64(-84.45176196911284)
Solve for t=516.00, v.max() =np.float64(6.547696980694793), v.min() =np.float64(-84.46070814398293)
Solve for t=517.00, v.max() =np.float64(6.450687302376828), v.min() =np.float64(-84.4695611508867)
Solve for t=518.00, v.max() =np.float64(6.353477216771388), v.min() =np.float64(-84.47832177870903)
Solve for t=519.00, v.max() =np.float64(6.256075224086662), v.min() =np.float64(-84.48699081906733)
Solve for t=520.00, v.max() =np.float64(6.158490116696299), v.min() =np.float64(-84.495569065918)
Solve for t=521.00, v.max() =np.float64(6.060730980141196), v.min() =np.float64(-84.50405731517023)
Solve for t=522.00, v.max() =np.float64(5.962807193728862), v.min() =np.float64(-84.51245636431324)
Solve for t=523.00, v.max() =np.float64(5.864728430711112), v.min() =np.float64(-84.52076701205223)
Solve for t=524.00, v.max() =np.float64(5.76650465802162), v.min() =np.float64(-84.52899005795167)
Solve for t=525.00, v.max() =np.float64(5.668146135556224), v.min() =np.float64(-84.53712630209264)
Solve for t=526.00, v.max() =np.float64(5.569663414978484), v.min() =np.float64(-84.54517654473817)
Solve for t=527.00, v.max() =np.float64(5.471067338034649), v.min() =np.float64(-84.55314158600785)
Solve for t=528.00, v.max() =np.float64(5.372369034363313), v.min() =np.float64(-84.56102222556663)
Solve for t=529.00, v.max() =np.float64(5.273579918785557), v.min() =np.float64(-84.56881926231743)
Solve for t=530.00, v.max() =np.float64(5.174711688063537), v.min() =np.float64(-84.57653349411)
Solve for t=531.00, v.max() =np.float64(5.075776317116341), v.min() =np.float64(-84.58416571745637)
Solve for t=532.00, v.max() =np.float64(4.976786054683749), v.min() =np.float64(-84.59171672725805)
Solve for t=533.00, v.max() =np.float64(4.877753418430262), v.min() =np.float64(-84.59918731654182)
Solve for t=534.00, v.max() =np.float64(4.778691189483706), v.min() =np.float64(-84.6065782762072)
Solve for t=535.00, v.max() =np.float64(4.679612406404413), v.min() =np.float64(-84.61389039478064)
Solve for t=536.00, v.max() =np.float64(4.5805303585836885), v.min() =np.float64(-84.6211244581822)
Solve for t=537.00, v.max() =np.float64(4.481458579071751), v.min() =np.float64(-84.62828124950224)
Solve for t=538.00, v.max() =np.float64(4.382410836838204), v.min() =np.float64(-84.6353615487842)
Solve for t=539.00, v.max() =np.float64(4.283401128470168), v.min() =np.float64(-84.64236613281928)
Solve for t=540.00, v.max() =np.float64(4.184443669316041), v.min() =np.float64(-84.64929577495066)
Solve for t=541.00, v.max() =np.float64(4.085552884084856), v.min() =np.float64(-84.65615124488373)
Solve for t=542.00, v.max() =np.float64(3.9867433969142834), v.min() =np.float64(-84.66293330850796)
Solve for t=543.00, v.max() =np.float64(3.888030020922614), v.min() =np.float64(-84.66964272772606)
Solve for t=544.00, v.max() =np.float64(3.7894277472627746), v.min() =np.float64(-84.6762802602919)
Solve for t=545.00, v.max() =np.float64(3.6909517336989737), v.min() =np.float64(-84.68284665965717)
Solve for t=546.00, v.max() =np.float64(3.5926172927290647), v.min() =np.float64(-84.68934267482487)
Solve for t=547.00, v.max() =np.float64(3.494439879278292), v.min() =np.float64(-84.69576905021201)
Solve for t=548.00, v.max() =np.float64(3.396435077992443), v.min() =np.float64(-84.70212652551783)
Solve for t=549.00, v.max() =np.float64(3.2986185901608867), v.min() =np.float64(-84.70841583560367)
Solve for t=550.00, v.max() =np.float64(3.2010062203016374), v.min() =np.float64(-84.71463771037597)
Solve for t=551.00, v.max() =np.float64(3.103613862443451), v.min() =np.float64(-84.72079287467649)
Solve for t=552.00, v.max() =np.float64(3.0064574861411626), v.min() =np.float64(-84.72688204818499)
Solve for t=553.00, v.max() =np.float64(2.9095531222623356), v.min() =np.float64(-84.73290594531998)
Solve for t=554.00, v.max() =np.float64(2.812916848585119), v.min() =np.float64(-84.73886527515303)
Solve for t=555.00, v.max() =np.float64(2.7165647752479942), v.min() =np.float64(-84.74476074132743)
Solve for t=556.00, v.max() =np.float64(2.6205130300935937), v.min() =np.float64(-84.75059304198076)
Solve for t=557.00, v.max() =np.float64(2.524777743949133), v.min() =np.float64(-84.75636286967492)
Solve for t=558.00, v.max() =np.float64(2.429375035887176), v.min() =np.float64(-84.76207091133404)
Solve for t=559.00, v.max() =np.float64(2.3343209985101474), v.min() =np.float64(-84.76771784818469)
Solve for t=560.00, v.max() =np.float64(2.239631683302332), v.min() =np.float64(-84.77330435570202)
Solve for t=561.00, v.max() =np.float64(2.145323086092992), v.min() =np.float64(-84.77883110356319)
Solve for t=562.00, v.max() =np.float64(2.05141113267344), v.min() =np.float64(-84.78429875560333)
Solve for t=563.00, v.max() =np.float64(1.9579116646104797), v.min() =np.float64(-84.78970796977863)
Solve for t=564.00, v.max() =np.float64(1.8648404252972757), v.min() =np.float64(-84.79505939813133)
Solve for t=565.00, v.max() =np.float64(1.7722130462818113), v.min() =np.float64(-84.80035368676171)
Solve for t=566.00, v.max() =np.float64(1.6800450339112434), v.min() =np.float64(-84.80559147580284)
Solve for t=567.00, v.max() =np.float64(1.588351756329056), v.min() =np.float64(-84.81077339940063)
Solve for t=568.00, v.max() =np.float64(1.4971484308596623), v.min() =np.float64(-84.81590008569529)
Solve for t=569.00, v.max() =np.float64(1.4064501118132944), v.min() =np.float64(-84.82097215681061)
Solve for t=570.00, v.max() =np.float64(1.316271678741436), v.min() =np.float64(-84.82599022884422)
Solve for t=571.00, v.max() =np.float64(1.226627825170695), v.min() =np.float64(-84.83095491186182)
Solve for t=572.00, v.max() =np.float64(1.1375330478404602), v.min() =np.float64(-84.83586680989302)
Solve for t=573.00, v.max() =np.float64(1.0490016364669403), v.min() =np.float64(-84.84072652093477)
Solve for t=574.00, v.max() =np.float64(0.961047664053268), v.min() =np.float64(-84.84553463695474)
Solve for t=575.00, v.max() =np.float64(0.8736849777626582), v.min() =np.float64(-84.85029174389763)
Solve for t=576.00, v.max() =np.float64(0.7869271903685674), v.min() =np.float64(-84.8549984216941)
Solve for t=577.00, v.max() =np.float64(0.7007876722929292), v.min() =np.float64(-84.85965524427394)
Solve for t=578.00, v.max() =np.float64(0.6152795442405571), v.min() =np.float64(-84.86426277958047)
Solve for t=579.00, v.max() =np.float64(0.5304156704349424), v.min() =np.float64(-84.86882158958828)
Solve for t=580.00, v.max() =np.float64(0.4462086524577429), v.min() =np.float64(-84.87333223032195)
Solve for t=581.00, v.max() =np.float64(0.3626708236915101), v.min() =np.float64(-84.87779525187867)
Solve for t=582.00, v.max() =np.float64(0.2798142443624371), v.min() =np.float64(-84.88221119845063)
Solve for t=583.00, v.max() =np.float64(0.19765069717728428), v.min() =np.float64(-84.886580608352)
Solve for t=584.00, v.max() =np.float64(0.11619168354611974), v.min() =np.float64(-84.89090401404472)
Solve for t=585.00, v.max() =np.float64(0.03544842038013061), v.min() =np.float64(-84.89518194216993)
Solve for t=586.00, v.max() =np.float64(-0.04456816254854742), v.min() =np.float64(-84.8994149135775)
Solve for t=587.00, v.max() =np.float64(-0.12384742470008994), v.min() =np.float64(-84.90360344335875)
Solve for t=588.00, v.max() =np.float64(-0.202379016330457), v.min() =np.float64(-84.90774804087972)
Solve for t=589.00, v.max() =np.float64(-0.28015287954398943), v.min() =np.float64(-84.91184920981783)
Solve for t=590.00, v.max() =np.float64(-0.35715924885567557), v.min() =np.float64(-84.91590744819669)
Solve for t=591.00, v.max() =np.float64(-0.43338865128514387), v.min() =np.float64(-84.91992324842492)
Solve for t=592.00, v.max() =np.float64(-0.5088319060057254), v.min() =np.float64(-84.92389709733557)
Solve for t=593.00, v.max() =np.float64(-0.5834801235730983), v.min() =np.float64(-84.92782947622457)
Solve for t=594.00, v.max() =np.float64(-0.6573247047590103), v.min() =np.float64(-84.9317208608914)
Solve for t=595.00, v.max() =np.float64(-0.7303573390164195), v.min() =np.float64(-84.93557172168306)
Solve for t=596.00, v.max() =np.float64(-0.802570002603059), v.min() =np.float64(-84.93938252353477)
Solve for t=597.00, v.max() =np.float64(-0.8739549563909509), v.min() =np.float64(-84.94315372601343)
Solve for t=598.00, v.max() =np.float64(-0.9445047433898249), v.min() =np.float64(-84.94688578336189)
Solve for t=599.00, v.max() =np.float64(-1.0142121860126094), v.min() =np.float64(-84.95057914454482)
Solve for t=600.00, v.max() =np.float64(-1.0830703831112973), v.min() =np.float64(-84.95423425329197)
Solve for t=601.00, v.max() =np.float64(-1.1510727068115232), v.min() =np.float64(-84.9578515481456)
Solve for t=602.00, v.max() =np.float64(-1.2182127991740759), v.min() =np.float64(-84.96143146250574)
Solve for t=603.00, v.max() =np.float64(-1.2844845687113127), v.min() =np.float64(-84.96497442467818)
Solve for t=604.00, v.max() =np.float64(-1.3498821867862845), v.min() =np.float64(-84.96848085791983)
Solve for t=605.00, v.max() =np.float64(-1.4144000839218411), v.min() =np.float64(-84.97195118048697)
Solve for t=606.00, v.max() =np.float64(-1.478032946046678), v.min() =np.float64(-84.97538580568369)
Solve for t=607.00, v.max() =np.float64(-1.5407757107046618), v.min() =np.float64(-84.97878514190919)
Solve for t=608.00, v.max() =np.float64(-1.602623563253254), v.min() =np.float64(-84.98214959270506)
Solve for t=609.00, v.max() =np.float64(-1.6635719330762742), v.min() =np.float64(-84.98547955680517)
Solve for t=610.00, v.max() =np.float64(-1.7236164898354744), v.min() =np.float64(-84.98877542818344)
Solve for t=611.00, v.max() =np.float64(-1.7827531397848073), v.min() =np.float64(-84.99203759610187)
Solve for t=612.00, v.max() =np.float64(-1.8409780221704921), v.min() =np.float64(-84.99526644515996)
Solve for t=613.00, v.max() =np.float64(-1.8982875057392734), v.min() =np.float64(-84.99846235534406)
Solve for t=614.00, v.max() =np.float64(-1.9546781853765074), v.min() =np.float64(-85.00162570207381)
Solve for t=615.00, v.max() =np.float64(-2.0101468788949584), v.min() =np.float64(-85.00475685625273)
Solve for t=616.00, v.max() =np.float64(-2.0646906239944283), v.min() =np.float64(-85.00785618431539)
Solve for t=617.00, v.max() =np.float64(-2.1183066754116022), v.min() =np.float64(-85.01092404827635)
Solve for t=618.00, v.max() =np.float64(-2.170992502278781), v.min() =np.float64(-85.01396080578064)
Solve for t=619.00, v.max() =np.float64(-2.2227457857091437), v.min() =np.float64(-85.01696681014798)
Solve for t=620.00, v.max() =np.float64(-2.2735644166261144), v.min() =np.float64(-85.0199424104242)
Solve for t=621.00, v.max() =np.float64(-2.3234464938529396), v.min() =np.float64(-85.02288795142749)
Solve for t=622.00, v.max() =np.float64(-2.372390322478435), v.min() =np.float64(-85.02580377379721)
Solve for t=623.00, v.max() =np.float64(-2.4203944125139247), v.min() =np.float64(-85.02869021403968)
Solve for t=624.00, v.max() =np.float64(-2.4674574778559863), v.min() =np.float64(-85.03154760457791)
Solve for t=625.00, v.max() =np.float64(-2.513578435568669), v.min() =np.float64(-85.03437627379641)
Solve for t=626.00, v.max() =np.float64(-2.5587564054986713), v.min() =np.float64(-85.0371765460902)
Solve for t=627.00, v.max() =np.float64(-2.60299071023604), v.min() =np.float64(-85.03994874190937)
Solve for t=628.00, v.max() =np.float64(-2.6462808754326237), v.min() =np.float64(-85.04269317780617)
Solve for t=629.00, v.max() =np.float64(-2.688626630490036), v.min() =np.float64(-85.04541016648086)
Solve for t=630.00, v.max() =np.float64(-2.730027909628246), v.min() =np.float64(-85.0481000168278)
Solve for t=631.00, v.max() =np.float64(-2.7704848533454713), v.min() =np.float64(-85.0507630339801)
Solve for t=632.00, v.max() =np.float64(-2.809997810279955), v.min() =np.float64(-85.05339951935463)
Solve for t=633.00, v.max() =np.float64(-2.8485673394832913), v.min() =np.float64(-85.05600977069784)
Solve for t=634.00, v.max() =np.float64(-2.886194213114967), v.min() =np.float64(-85.05859408212858)
Solve for t=635.00, v.max() =np.float64(-2.9228794195672836), v.min() =np.float64(-85.06115274418305)
Solve for t=636.00, v.max() =np.float64(-2.95862416702969), v.min() =np.float64(-85.06368604385781)
Solve for t=637.00, v.max() =np.float64(-2.9934298875007492), v.min() =np.float64(-85.06619426465288)
Solve for t=638.00, v.max() =np.float64(-3.0272982412565113), v.min() =np.float64(-85.06867768661613)
Solve for t=639.00, v.max() =np.float64(-3.060231121782861), v.min() =np.float64(-85.07113658638274)
Solve for t=640.00, v.max() =np.float64(-3.0922306611799706), v.min() =np.float64(-85.0735712372215)
Solve for t=641.00, v.max() =np.float64(-3.1232992360461957), v.min() =np.float64(-85.07598190907255)
Solve for t=642.00, v.max() =np.float64(-3.1534394738489646), v.min() =np.float64(-85.0783688685906)
Solve for t=643.00, v.max() =np.float64(-3.182654259789645), v.min() =np.float64(-85.08073237918555)
Solve for t=644.00, v.max() =np.float64(-3.2109467441695623), v.min() =np.float64(-85.08307270106383)
Solve for t=645.00, v.max() =np.float64(-3.2383203502638787), v.min() =np.float64(-85.08539009126669)
Solve for t=646.00, v.max() =np.float64(-3.264778782710125), v.min() =np.float64(-85.08768480371081)
Solve for t=647.00, v.max() =np.float64(-3.290326036417905), v.min() =np.float64(-85.08995708922919)
Solve for t=648.00, v.max() =np.float64(-3.314966406006168), v.min() =np.float64(-85.09220719560626)
Solve for t=649.00, v.max() =np.float64(-3.3387044957746603), v.min() =np.float64(-85.0944353676205)
Solve for t=650.00, v.max() =np.float64(-3.361545230215431), v.min() =np.float64(-85.09664184707968)
Solve for t=651.00, v.max() =np.float64(-3.3834938650709403), v.min() =np.float64(-85.0988268728603)
Solve for t=652.00, v.max() =np.float64(-3.4045559989447325), v.min() =np.float64(-85.10099068094267)
Solve for t=653.00, v.max() =np.float64(-3.4247375854708335), v.min() =np.float64(-85.10313350445044)
Solve for t=654.00, v.max() =np.float64(-3.4440449460478613), v.min() =np.float64(-85.10525557368577)
Solve for t=655.00, v.max() =np.float64(-3.4624847831439847), v.min() =np.float64(-85.10735711616337)
Solve for t=656.00, v.max() =np.float64(-3.480064194178917), v.min() =np.float64(-85.1094383566504)
Solve for t=657.00, v.max() =np.float64(-3.496790685988695), v.min() =np.float64(-85.11149951719709)
Solve for t=658.00, v.max() =np.float64(-3.512672189879897), v.min() =np.float64(-85.11354081717529)
Solve for t=659.00, v.max() =np.float64(-3.5277170772790383), v.min() =np.float64(-85.11556247331036)
Solve for t=660.00, v.max() =np.float64(-3.5419341759839504), v.min() =np.float64(-85.11756469971652)
Solve for t=661.00, v.max() =np.float64(-3.5553327870232088), v.min() =np.float64(-85.11954770792926)
Solve for t=662.00, v.max() =np.float64(-3.5679227021307685), v.min() =np.float64(-85.12151170693954)
Solve for t=663.00, v.max() =np.float64(-3.5797142218421354), v.min() =np.float64(-85.12345690322664)
Solve for t=664.00, v.max() =np.float64(-3.590718174219642), v.min() =np.float64(-85.12538350078881)
Solve for t=665.00, v.max() =np.float64(-3.6009459342141747), v.min() =np.float64(-85.12729170117807)
Solve for t=666.00, v.max() =np.float64(-3.610409443671015), v.min() =np.float64(-85.12918170352918)
Solve for t=667.00, v.max() =np.float64(-3.619121231988163), v.min() =np.float64(-85.13105370459279)
Solve for t=668.00, v.max() =np.float64(-3.6270944374358463), v.min() =np.float64(-85.13290789876379)
Solve for t=669.00, v.max() =np.float64(-3.6343428291463886), v.min() =np.float64(-85.13474447811394)
Solve for t=670.00, v.max() =np.float64(-3.6408808297846504), v.min() =np.float64(-85.13656363242302)
Solve for t=671.00, v.max() =np.float64(-3.646723538908984), v.min() =np.float64(-85.13836554920374)
Solve for t=672.00, v.max() =np.float64(-3.651886757035051), v.min() =np.float64(-85.14015041373617)
Solve for t=673.00, v.max() =np.float64(-3.6563870104141047), v.min() =np.float64(-85.14191840909392)
Solve for t=674.00, v.max() =np.float64(-3.660241576539543), v.min() =np.float64(-85.14366971617348)
Solve for t=675.00, v.max() =np.float64(-3.66346851039604), v.min() =np.float64(-85.1454045137212)
Solve for t=676.00, v.max() =np.float64(-3.6660866714672418), v.min() =np.float64(-85.14712297836302)
Solve for t=677.00, v.max() =np.float64(-3.6681157515191294), v.min() =np.float64(-85.14882528463109)
Solve for t=678.00, v.max() =np.float64(-3.6695763031778794), v.min() =np.float64(-85.15051160498997)
Solve for t=679.00, v.max() =np.float64(-3.6704897693227188), v.min() =np.float64(-85.1521821098647)
Solve for t=680.00, v.max() =np.float64(-3.6708785133163455), v.min() =np.float64(-85.15383696766663)
Solve for t=681.00, v.max() =np.float64(-3.6707658500971396), v.min() =np.float64(-85.15547634481952)
Solve for t=682.00, v.max() =np.float64(-3.6701760781602957), v.min() =np.float64(-85.15710040578536)
Solve for t=683.00, v.max() =np.float64(-3.66913451245679), v.min() =np.float64(-85.15870931308956)
Solve for t=684.00, v.max() =np.float64(-3.6676675182425895), v.min() =np.float64(-85.1603032273458)
Solve for t=685.00, v.max() =np.float64(-3.665802545912603), v.min() =np.float64(-85.1618823072811)
Solve for t=686.00, v.max() =np.float64(-3.663568166857888), v.min() =np.float64(-85.16344670976045)
Solve for t=687.00, v.max() =np.float64(-3.660994110387266), v.min() =np.float64(-85.16499658981003)
Solve for t=688.00, v.max() =np.float64(-3.6581113017590714), v.min() =np.float64(-85.1665321006416)
Solve for t=689.00, v.max() =np.float64(-3.6549519013719363), v.min() =np.float64(-85.16805339367556)
Solve for t=690.00, v.max() =np.float64(-3.6515493451684424), v.min() =np.float64(-85.16956061856513)
Solve for t=691.00, v.max() =np.float64(-3.6479383863096095), v.min() =np.float64(-85.17105392321618)
Solve for t=692.00, v.max() =np.float64(-3.644155138183641), v.min() =np.float64(-85.17253345381411)
Solve for t=693.00, v.max() =np.float64(-3.640237118817018), v.min() =np.float64(-85.17399935484234)
Solve for t=694.00, v.max() =np.float64(-3.6362232967621653), v.min() =np.float64(-85.17545176910598)
Solve for t=695.00, v.max() =np.float64(-3.6321541385415648), v.min() =np.float64(-85.17689083775238)
Solve for t=696.00, v.max() =np.float64(-3.6280716577348278), v.min() =np.float64(-85.17831670029351)
Solve for t=697.00, v.max() =np.float64(-3.624019465801688), v.min() =np.float64(-85.17972949462605)
Solve for t=698.00, v.max() =np.float64(-3.6200428247413314), v.min() =np.float64(-85.18112935705328)
Solve for t=699.00, v.max() =np.float64(-3.6161887016957928), v.min() =np.float64(-85.18251642230456)
Solve for t=700.00, v.max() =np.float64(-3.612505825613324), v.min() =np.float64(-85.18389082355489)
Solve for t=701.00, v.max() =np.float64(-3.609044746096144), v.min() =np.float64(-85.18525269244658)
Solve for t=702.00, v.max() =np.float64(-3.605857894565533), v.min() =np.float64(-85.18660215910671)
Solve for t=703.00, v.max() =np.float64(-3.6029996478871222), v.min() =np.float64(-85.18793935216891)
Solve for t=704.00, v.max() =np.float64(-3.60052639460869), v.min() =np.float64(-85.18926439879029)
Solve for t=705.00, v.max() =np.float64(-3.598496603973271), v.min() =np.float64(-85.19057742467241)
Solve for t=706.00, v.max() =np.float64(-3.596970897881393), v.min() =np.float64(-85.19187855407701)
Solve for t=707.00, v.max() =np.float64(-3.5960121259876563), v.min() =np.float64(-85.19316790984732)
Solve for t=708.00, v.max() =np.float64(-3.59568544412857), v.min() =np.float64(-85.19444561342395)
Solve for t=709.00, v.max() =np.float64(-3.596058396291677), v.min() =np.float64(-85.1957117848626)
Solve for t=710.00, v.max() =np.float64(-3.5972010003486714), v.min() =np.float64(-85.19696654285431)
Solve for t=711.00, v.max() =np.float64(-3.5991858377893546), v.min() =np.float64(-85.19821000474032)
Solve for t=712.00, v.max() =np.float64(-3.602088147707424), v.min() =np.float64(-85.19944228652953)
Solve for t=713.00, v.max() =np.float64(-3.6059859253045388), v.min() =np.float64(-85.2006635029153)
Solve for t=714.00, v.max() =np.float64(-3.6109600251948777), v.min() =np.float64(-85.20187376729304)
Solve for t=715.00, v.max() =np.float64(-3.6170942698087902), v.min() =np.float64(-85.20307319177623)
Solve for t=716.00, v.max() =np.float64(-3.624475563211621), v.min() =np.float64(-85.2042618872119)
Solve for t=717.00, v.max() =np.float64(-3.6331940106720815), v.min() =np.float64(-85.20543996319667)
Solve for t=718.00, v.max() =np.float64(-3.643343044333546), v.min() =np.float64(-85.20660752809397)
Solve for t=719.00, v.max() =np.float64(-3.6550195553611373), v.min() =np.float64(-85.20776468904765)
Solve for t=720.00, v.max() =np.float64(-3.668324032958986), v.min() =np.float64(-85.20891155199814)
Solve for t=721.00, v.max() =np.float64(-3.6833607106731594), v.min() =np.float64(-85.21004822169745)
Solve for t=722.00, v.max() =np.float64(-3.700237720418852), v.min() =np.float64(-85.21117480172452)
Solve for t=723.00, v.max() =np.float64(-3.7190672546939365), v.min() =np.float64(-85.21229139449892)
Solve for t=724.00, v.max() =np.float64(-3.739965737465931), v.min() =np.float64(-85.21339810129574)
Solve for t=725.00, v.max() =np.float64(-3.763054004244976), v.min() =np.float64(-85.21449502226146)
Solve for t=726.00, v.max() =np.float64(-3.7884574918818985), v.min() =np.float64(-85.2155822564255)
Solve for t=727.00, v.max() =np.float64(-3.8163064386586463), v.min() =np.float64(-85.21665990171431)
Solve for t=728.00, v.max() =np.float64(-3.8467360952662926), v.min() =np.float64(-85.21772805496789)
Solve for t=729.00, v.max() =np.float64(-3.879886947294973), v.min() =np.float64(-85.21878681195048)
Solve for t=730.00, v.max() =np.float64(-3.9159049498901752), v.min() =np.float64(-85.21983626736446)
Solve for t=731.00, v.max() =np.float64(-3.954941775259538), v.min() =np.float64(-85.2208765148648)
Solve for t=732.00, v.max() =np.float64(-3.997155073744243), v.min() =np.float64(-85.2219076470698)
Solve for t=733.00, v.max() =np.float64(-4.0427087491988924), v.min() =np.float64(-85.22292975557643)
Solve for t=734.00, v.max() =np.float64(-4.091773249451662), v.min() =np.float64(-85.22394293097122)
Solve for t=735.00, v.max() =np.float64(-4.144525872644125), v.min() =np.float64(-85.22494726284314)
Solve for t=736.00, v.max() =np.float64(-4.201151090273935), v.min() =np.float64(-85.22594283979517)
Solve for t=737.00, v.max() =np.float64(-4.261840887783961), v.min() =np.float64(-85.2269297494589)
Solve for t=738.00, v.max() =np.float64(-4.326795123557758), v.min() =np.float64(-85.22790807850308)
Solve for t=739.00, v.max() =np.float64(-4.396221907189557), v.min() =np.float64(-85.22887791264772)
Solve for t=740.00, v.max() =np.float64(-4.470337997897997), v.min() =np.float64(-85.22983933667501)
Solve for t=741.00, v.max() =np.float64(-4.549369223941747), v.min() =np.float64(-85.23079243444059)
Solve for t=742.00, v.max() =np.float64(-4.633550923871198), v.min() =np.float64(-85.23173728888608)
Solve for t=743.00, v.max() =np.float64(-4.723128410408393), v.min() =np.float64(-85.23267398204815)
Solve for t=744.00, v.max() =np.float64(-4.818357457684774), v.min() =np.float64(-85.23360259507014)
Solve for t=745.00, v.max() =np.float64(-4.919504812477364), v.min() =np.float64(-85.23452320821505)
Solve for t=746.00, v.max() =np.float64(-5.0268487299632865), v.min() =np.float64(-85.23543590087398)
Solve for t=747.00, v.max() =np.float64(-5.140679534354327), v.min() =np.float64(-85.23634075157605)
Solve for t=748.00, v.max() =np.float64(-5.26130020457013), v.min() =np.float64(-85.23723783800173)
Solve for t=749.00, v.max() =np.float64(-5.389026984849769), v.min() =np.float64(-85.23812723699051)
Solve for t=750.00, v.max() =np.float64(-5.5241900198820595), v.min() =np.float64(-85.23900902455217)
Solve for t=751.00, v.max() =np.float64(-5.6671340136387265), v.min() =np.float64(-85.23988327587696)
Solve for t=752.00, v.max() =np.float64(-5.818218910613689), v.min() =np.float64(-85.24075006534534)
Solve for t=753.00, v.max() =np.float64(-5.977820597590034), v.min() =np.float64(-85.2416094665363)
Solve for t=754.00, v.max() =np.float64(-6.146331623361056), v.min() =np.float64(-85.24246155223832)
Solve for t=755.00, v.max() =np.float64(-6.324161933006255), v.min() =np.float64(-85.24330639446038)
Solve for t=756.00, v.max() =np.float64(-6.511739612350092), v.min() =np.float64(-85.2441440644379)
Solve for t=757.00, v.max() =np.float64(-6.709511637096337), v.min() =np.float64(-85.24497463264453)
Solve for t=758.00, v.max() =np.float64(-6.91794461981393), v.min() =np.float64(-85.24579816879995)
Solve for t=759.00, v.max() =np.float64(-7.137525546437028), v.min() =np.float64(-85.24661474187917)
Solve for t=760.00, v.max() =np.float64(-7.368762492219517), v.min() =np.float64(-85.24742442012202)
Solve for t=761.00, v.max() =np.float64(-7.612185305142069), v.min() =np.float64(-85.24822727104123)
Solve for t=762.00, v.max() =np.float64(-7.86834624260884), v.min() =np.float64(-85.2490233614317)
Solve for t=763.00, v.max() =np.float64(-8.137820544897526), v.min() =np.float64(-85.24981275737728)
Solve for t=764.00, v.max() =np.float64(-8.42120692627063), v.min() =np.float64(-85.25059552426156)
Solve for t=765.00, v.max() =np.float64(-8.719127961965135), v.min() =np.float64(-85.25137172677478)
Solve for t=766.00, v.max() =np.float64(-9.032230346539487), v.min() =np.float64(-85.25214142892214)
Solve for t=767.00, v.max() =np.float64(-9.361184996400201), v.min() =np.float64(-85.25290469403127)
Solve for t=768.00, v.max() =np.float64(-9.706686966952784), v.min() =np.float64(-85.25366158476199)
Solve for t=769.00, v.max() =np.float64(-10.069455152992264), v.min() =np.float64(-85.25441216311327)
Solve for t=770.00, v.max() =np.float64(-10.450231740053932), v.min() =np.float64(-85.25515649042993)
Solve for t=771.00, v.max() =np.float64(-10.849781374982715), v.min() =np.float64(-85.2558946274108)
Solve for t=772.00, v.max() =np.float64(-11.268890026599989), v.min() =np.float64(-85.25662663411826)
Solve for t=773.00, v.max() =np.float64(-11.70836351285524), v.min() =np.float64(-85.2573525699825)
Solve for t=774.00, v.max() =np.float64(-12.169025680216484), v.min() =np.float64(-85.25807249381033)
Solve for t=775.00, v.max() =np.float64(-12.65171623535757), v.min() =np.float64(-85.2587864637944)
Solve for t=776.00, v.max() =np.float64(-13.157288249599041), v.min() =np.float64(-85.25949453751672)
Solve for t=777.00, v.max() =np.float64(-13.686605384168569), v.min() =np.float64(-85.26019677195744)
Solve for t=778.00, v.max() =np.float64(-14.240538920019345), v.min() =np.float64(-85.26089322350346)
Solve for t=779.00, v.max() =np.float64(-14.81996472009583), v.min() =np.float64(-85.26158394795164)
Solve for t=780.00, v.max() =np.float64(-15.42576030423225), v.min() =np.float64(-85.2622690005206)
Solve for t=781.00, v.max() =np.float64(-16.058802275870832), v.min() =np.float64(-85.26294843585256)
Solve for t=782.00, v.max() =np.float64(-16.719964402773822), v.min() =np.float64(-85.26362230802076)
Solve for t=783.00, v.max() =np.float64(-17.41011671673723), v.min() =np.float64(-85.26429067053992)
Solve for t=784.00, v.max() =np.float64(-18.130126054515905), v.min() =np.float64(-85.26495357636827)
Solve for t=785.00, v.max() =np.float64(-18.88085850751896), v.min() =np.float64(-85.2656110779161)
Solve for t=786.00, v.max() =np.float64(-19.663184275270154), v.min() =np.float64(-85.26626322705104)
Solve for t=787.00, v.max() =np.float64(-20.477985422361012), v.min() =np.float64(-85.26691007510519)
Solve for t=788.00, v.max() =np.float64(-21.326167018602096), v.min() =np.float64(-85.26755167288134)
Solve for t=789.00, v.max() =np.float64(-22.2086720990031), v.min() =np.float64(-85.26818807065781)
Solve for t=790.00, v.max() =np.float64(-23.126500819357087), v.min() =np.float64(-85.26881931819494)
Solve for t=791.00, v.max() =np.float64(-24.08073411274811), v.min() =np.float64(-85.26944546474157)
Solve for t=792.00, v.max() =np.float64(-25.072562080603497), v.min() =np.float64(-85.27006655904037)
Solve for t=793.00, v.max() =np.float64(-26.103317283794162), v.min() =np.float64(-85.27068264933374)
Solve for t=794.00, v.max() =np.float64(-27.174513033360213), v.min() =np.float64(-85.27129378336885)
Solve for t=795.00, v.max() =np.float64(-28.287886704178607), v.min() =np.float64(-85.27190000840449)
Solve for t=796.00, v.max() =np.float64(-29.44544798270342), v.min() =np.float64(-85.27250137121553)
Solve for t=797.00, v.max() =np.float64(-30.64953176689311), v.min() =np.float64(-85.2730979180982)
Solve for t=798.00, v.max() =np.float64(-31.902855089081154), v.min() =np.float64(-85.27368969487732)
Solve for t=799.00, v.max() =np.float64(-33.208576811843706), v.min() =np.float64(-85.27427674690857)
Solve for t=800.00, v.max() =np.float64(-34.57035775746504), v.min() =np.float64(-85.27485911908701)
Solve for t=801.00, v.max() =np.float64(-35.99241705645755), v.min() =np.float64(-85.27543685585039)
Solve for t=802.00, v.max() =np.float64(-37.47957733229508), v.min() =np.float64(-85.27601000118344)
Solve for t=803.00, v.max() =np.float64(-39.03728608776396), v.min() =np.float64(-85.27657859862646)
Solve for t=804.00, v.max() =np.float64(-40.671592154246184), v.min() =np.float64(-85.27714269127516)
Solve for t=805.00, v.max() =np.float64(-42.38904271297328), v.min() =np.float64(-85.27770232179037)
Solve for t=806.00, v.max() =np.float64(-44.19644613502811), v.min() =np.float64(-85.27825753239937)
Solve for t=807.00, v.max() =np.float64(-46.100418114881506), v.min() =np.float64(-85.27880836490375)
Solve for t=808.00, v.max() =np.float64(-48.106594888378154), v.min() =np.float64(-85.27935486068223)
Solve for t=809.00, v.max() =np.float64(-50.218369994861874), v.min() =np.float64(-85.27989706069471)
Solve for t=810.00, v.max() =np.float64(-52.43502327652308), v.min() =np.float64(-85.28043500548922)
Solve for t=811.00, v.max() =np.float64(-54.749229035618136), v.min() =np.float64(-85.28096873520423)
Solve for t=812.00, v.max() =np.float64(-57.144244439459115), v.min() =np.float64(-85.28149828957551)
Solve for t=813.00, v.max() =np.float64(-59.59161789190964), v.min() =np.float64(-85.2820237079374)
Solve for t=814.00, v.max() =np.float64(-62.05080081090261), v.min() =np.float64(-85.28254502923052)
Solve for t=815.00, v.max() =np.float64(-64.4720115364374), v.min() =np.float64(-85.28306229200443)
Solve for t=816.00, v.max() =np.float64(-66.8025265653781), v.min() =np.float64(-85.28357553442135)
Solve for t=817.00, v.max() =np.float64(-68.9946431786781), v.min() =np.float64(-85.28408479426115)
Solve for t=818.00, v.max() =np.float64(-71.01239344814188), v.min() =np.float64(-85.28459010892716)
Solve for t=819.00, v.max() =np.float64(-72.83482297006248), v.min() =np.float64(-85.28509151544687)
Solve for t=820.00, v.max() =np.float64(-74.4555732293575), v.min() =np.float64(-85.28558905047858)
Solve for t=821.00, v.max() =np.float64(-75.88000011165249), v.min() =np.float64(-85.28608275031579)
Solve for t=822.00, v.max() =np.float64(-77.12138873512131), v.min() =np.float64(-85.28657265088822)
Solve for t=823.00, v.max() =np.float64(-78.1973854208006), v.min() =np.float64(-85.28705878776829)
Solve for t=824.00, v.max() =np.float64(-79.12718915853355), v.min() =np.float64(-85.28754119617513)
Solve for t=825.00, v.max() =np.float64(-79.92963048338544), v.min() =np.float64(-85.28801991097724)
Solve for t=826.00, v.max() =np.float64(-80.62204280757838), v.min() =np.float64(-85.28849496669686)
Solve for t=827.00, v.max() =np.float64(-81.21974159788061), v.min() =np.float64(-85.28896639751346)
Solve for t=828.00, v.max() =np.float64(-81.73591539224473), v.min() =np.float64(-85.28943423726719)
Solve for t=829.00, v.max() =np.float64(-82.18176103701217), v.min() =np.float64(-85.28989851946383)
Solve for t=830.00, v.max() =np.float64(-82.5667379924807), v.min() =np.float64(-85.29035927727553)
Solve for t=831.00, v.max() =np.float64(-82.89885794373204), v.min() =np.float64(-85.29081654354908)
Solve for t=832.00, v.max() =np.float64(-83.18495959189343), v.min() =np.float64(-85.29127035080425)
Solve for t=833.00, v.max() =np.float64(-83.43094311416561), v.min() =np.float64(-85.29172073124248)
Solve for t=834.00, v.max() =np.float64(-83.64195551243672), v.min() =np.float64(-85.29216771674515)
Solve for t=835.00, v.max() =np.float64(-83.8225285991668), v.min() =np.float64(-85.2926113388803)
Solve for t=836.00, v.max() =np.float64(-83.97667717401676), v.min() =np.float64(-85.2930516289047)
Solve for t=837.00, v.max() =np.float64(-84.10796723934664), v.min() =np.float64(-85.29348861776815)
Solve for t=838.00, v.max() =np.float64(-84.21956395900239), v.min() =np.float64(-85.29392233611605)
Solve for t=839.00, v.max() =np.float64(-84.31426746663116), v.min() =np.float64(-85.294352814293)
Solve for t=840.00, v.max() =np.float64(-84.39454242308065), v.min() =np.float64(-85.29478008234534)
Solve for t=841.00, v.max() =np.float64(-84.46254503530497), v.min() =np.float64(-85.29520417002495)
Solve for t=842.00, v.max() =np.float64(-84.52014945308413), v.min() =np.float64(-85.29562510679241)
Solve for t=843.00, v.max() =np.float64(-84.56897419503663), v.min() =np.float64(-85.29604292181978)
Solve for t=844.00, v.max() =np.float64(-84.61040849928563), v.min() =np.float64(-85.29645764399312)
Solve for t=845.00, v.max() =np.float64(-84.64563813901026), v.min() =np.float64(-85.29686930191777)
Solve for t=846.00, v.max() =np.float64(-84.6756701582337), v.min() =np.float64(-85.29727792391851)
Solve for t=847.00, v.max() =np.float64(-84.7013560523229), v.min() =np.float64(-85.29768353804361)
Solve for t=848.00, v.max() =np.float64(-84.72341305454403), v.min() =np.float64(-85.29808617206848)
Solve for t=849.00, v.max() =np.float64(-84.74244333953185), v.min() =np.float64(-85.29848585349777)
Solve for t=850.00, v.max() =np.float64(-84.75895108689403), v.min() =np.float64(-85.29888260956845)
Solve for t=851.00, v.max() =np.float64(-84.77335745098544), v.min() =np.float64(-85.29927646725223)
Solve for t=852.00, v.max() =np.float64(-84.78601355439903), v.min() =np.float64(-85.2996674532587)
Solve for t=853.00, v.max() =np.float64(-84.79721166653083), v.min() =np.float64(-85.30005559403816)
Solve for t=854.00, v.max() =np.float64(-84.80719475040239), v.min() =np.float64(-85.30044091578496)
Solve for t=855.00, v.max() =np.float64(-84.81616456667564), v.min() =np.float64(-85.30082344443835)
Solve for t=856.00, v.max() =np.float64(-84.82428851866472), v.min() =np.float64(-85.30120320568714)
Solve for t=857.00, v.max() =np.float64(-84.83170541025012), v.min() =np.float64(-85.30158022497066)
Solve for t=858.00, v.max() =np.float64(-84.83853027305177), v.min() =np.float64(-85.30195452748234)
Solve for t=859.00, v.max() =np.float64(-84.84485840214136), v.min() =np.float64(-85.30232613817303)
Solve for t=860.00, v.max() =np.float64(-84.85076872243079), v.min() =np.float64(-85.30269508175064)
Solve for t=861.00, v.max() =np.float64(-84.85632659155901), v.min() =np.float64(-85.3030613826856)
Solve for t=862.00, v.max() =np.float64(-84.8615861300666), v.min() =np.float64(-85.30342506521278)
Solve for t=863.00, v.max() =np.float64(-84.86659215619473), v.min() =np.float64(-85.30378615333306)
Solve for t=864.00, v.max() =np.float64(-84.8713817907815), v.min() =np.float64(-85.30414467081607)
Solve for t=865.00, v.max() =np.float64(-84.87598578740878), v.min() =np.float64(-85.30450064120205)
Solve for t=866.00, v.max() =np.float64(-84.88042963410466), v.min() =np.float64(-85.30485408780565)
Solve for t=867.00, v.max() =np.float64(-84.88473446533574), v.min() =np.float64(-85.30520503371712)
Solve for t=868.00, v.max() =np.float64(-84.88891781662142), v.min() =np.float64(-85.30555350180575)
Solve for t=869.00, v.max() =np.float64(-84.89299424870528), v.min() =np.float64(-85.30589951472018)
Solve for t=870.00, v.max() =np.float64(-84.89697586367483), v.min() =np.float64(-85.30624309489197)
Solve for t=871.00, v.max() =np.float64(-84.9008727316368), v.min() =np.float64(-85.3065842645384)
Solve for t=872.00, v.max() =np.float64(-84.90469324337259), v.min() =np.float64(-85.30692304566335)
Solve for t=873.00, v.max() =np.float64(-84.90844440177102), v.min() =np.float64(-85.30725946006028)
Solve for t=874.00, v.max() =np.float64(-84.91213206263313), v.min() =np.float64(-85.30759352931442)
Solve for t=875.00, v.max() =np.float64(-84.91576113361877), v.min() =np.float64(-85.30792527480388)
Solve for t=876.00, v.max() =np.float64(-84.91933573859701), v.min() =np.float64(-85.30825471770393)
Solve for t=877.00, v.max() =np.float64(-84.92285935340672), v.min() =np.float64(-85.30858187898635)
Solve for t=878.00, v.max() =np.float64(-84.92633491798972), v.min() =np.float64(-85.30890677942328)
Solve for t=879.00, v.max() =np.float64(-84.92976492900296), v.min() =np.float64(-85.30922943958916)
Solve for t=880.00, v.max() =np.float64(-84.93315151630874), v.min() =np.float64(-85.30954987986298)
Solve for t=881.00, v.max() =np.float64(-84.93649650613855), v.min() =np.float64(-85.30986812042792)
Solve for t=882.00, v.max() =np.float64(-84.93980147325833), v.min() =np.float64(-85.3101841812764)
Solve for t=883.00, v.max() =np.float64(-84.94306778404565), v.min() =np.float64(-85.31049808221209)
Solve for t=884.00, v.max() =np.float64(-84.94629663205819), v.min() =np.float64(-85.31080984284709)
Solve for t=885.00, v.max() =np.float64(-84.94948906740764), v.min() =np.float64(-85.311119482609)
Solve for t=886.00, v.max() =np.float64(-84.9526460210172), v.min() =np.float64(-85.31142702074261)
Solve for t=887.00, v.max() =np.float64(-84.95576832464839), v.min() =np.float64(-85.31173247630811)
Solve for t=888.00, v.max() =np.float64(-84.95885672743962), v.min() =np.float64(-85.31203586818505)
Solve for t=889.00, v.max() =np.float64(-84.96191190956996), v.min() =np.float64(-85.31233721507608)
Solve for t=890.00, v.max() =np.float64(-84.96493449353642), v.min() =np.float64(-85.31263653550378)
Solve for t=891.00, v.max() =np.float64(-84.96792505347359), v.min() =np.float64(-85.31293384781839)
Solve for t=892.00, v.max() =np.float64(-84.97088412285204), v.min() =np.float64(-85.31322917019527)
Solve for t=893.00, v.max() =np.float64(-84.97381220083666), v.min() =np.float64(-85.31352252063778)
Solve for t=894.00, v.max() =np.float64(-84.97670975754421), v.min() =np.float64(-85.31381391698044)
Solve for t=895.00, v.max() =np.float64(-84.97957723838782), v.min() =np.float64(-85.31410337688783)
Solve for t=896.00, v.max() =np.float64(-84.9824150676712), v.min() =np.float64(-85.3143909178593)
Solve for t=897.00, v.max() =np.float64(-84.98522365155962), v.min() =np.float64(-85.3146765572286)
Solve for t=898.00, v.max() =np.float64(-84.98800338054437), v.min() =np.float64(-85.3149603121662)
Solve for t=899.00, v.max() =np.float64(-84.99075463147733), v.min() =np.float64(-85.31524219968152)
Solve for t=900.00, v.max() =np.float64(-84.99347776926405), v.min() =np.float64(-85.31552223662226)
Solve for t=901.00, v.max() =np.float64(-84.99617314826597), v.min() =np.float64(-85.31580043967924)
Solve for t=902.00, v.max() =np.float64(-84.99884111346469), v.min() =np.float64(-85.31607682538619)
Solve for t=903.00, v.max() =np.float64(-85.00148200143309), v.min() =np.float64(-85.31635141012046)
Solve for t=904.00, v.max() =np.float64(-85.00409614114281), v.min() =np.float64(-85.31662421010766)
Solve for t=905.00, v.max() =np.float64(-85.00668385463962), v.min() =np.float64(-85.31689524141808)
Solve for t=906.00, v.max() =np.float64(-85.00924545760813), v.min() =np.float64(-85.31716451997488)
Solve for t=907.00, v.max() =np.float64(-85.0117812598475), v.min() =np.float64(-85.3174320615488)
Solve for t=908.00, v.max() =np.float64(-85.01429156566904), v.min() =np.float64(-85.31769788176466)
Solve for t=909.00, v.max() =np.float64(-85.016776674236), v.min() =np.float64(-85.31796199610002)
Solve for t=910.00, v.max() =np.float64(-85.0192368798496), v.min() =np.float64(-85.31822441988858)
Solve for t=911.00, v.max() =np.float64(-85.02167247219415), v.min() =np.float64(-85.31848516832028)
Solve for t=912.00, v.max() =np.float64(-85.02408373654548), v.min() =np.float64(-85.3187442564417)
Solve for t=913.00, v.max() =np.float64(-85.02647095395419), v.min() =np.float64(-85.3190016991618)
Solve for t=914.00, v.max() =np.float64(-85.02883440140107), v.min() =np.float64(-85.31925751124668)
Solve for t=915.00, v.max() =np.float64(-85.0311743519357), v.min() =np.float64(-85.31951170732701)
Solve for t=916.00, v.max() =np.float64(-85.03349107479816), v.min() =np.float64(-85.31976430189617)
Solve for t=917.00, v.max() =np.float64(-85.03578483552646), v.min() =np.float64(-85.32001530931335)
Solve for t=918.00, v.max() =np.float64(-85.03805589605216), v.min() =np.float64(-85.32026474380251)
Solve for t=919.00, v.max() =np.float64(-85.04030451478774), v.min() =np.float64(-85.32051261945607)
Solve for t=920.00, v.max() =np.float64(-85.04253094670749), v.min() =np.float64(-85.32075895023463)
Solve for t=921.00, v.max() =np.float64(-85.0447354434184), v.min() =np.float64(-85.32100374996931)
Solve for t=922.00, v.max() =np.float64(-85.04691825322878), v.min() =np.float64(-85.32124703236208)
Solve for t=923.00, v.max() =np.float64(-85.0490796212103), v.min() =np.float64(-85.3214888109884)
Solve for t=924.00, v.max() =np.float64(-85.05121978925729), v.min() =np.float64(-85.32172909929695)
Solve for t=925.00, v.max() =np.float64(-85.05333899614173), v.min() =np.float64(-85.32196791061132)
Solve for t=926.00, v.max() =np.float64(-85.05543747756714), v.min() =np.float64(-85.32220525813226)
Solve for t=927.00, v.max() =np.float64(-85.05751546621747), v.min() =np.float64(-85.32244115493712)
Solve for t=928.00, v.max() =np.float64(-85.059573191807), v.min() =np.float64(-85.32267561398288)
Solve for t=929.00, v.max() =np.float64(-85.0616108811254), v.min() =np.float64(-85.32290864810493)
Solve for t=930.00, v.max() =np.float64(-85.06362875808364), v.min() =np.float64(-85.32314027002202)
Solve for t=931.00, v.max() =np.float64(-85.06562704375673), v.min() =np.float64(-85.32337049233242)
Solve for t=932.00, v.max() =np.float64(-85.06760595642648), v.min() =np.float64(-85.32359932752)
Solve for t=933.00, v.max() =np.float64(-85.0695657116235), v.min() =np.float64(-85.32382678795192)
Solve for t=934.00, v.max() =np.float64(-85.07150652216588), v.min() =np.float64(-85.32405288588113)
Solve for t=935.00, v.max() =np.float64(-85.07342859820015), v.min() =np.float64(-85.32427763344823)
Solve for t=936.00, v.max() =np.float64(-85.07533214723762), v.min() =np.float64(-85.32450104267991)
Solve for t=937.00, v.max() =np.float64(-85.07721737419392), v.min() =np.float64(-85.32472312549393)
Solve for t=938.00, v.max() =np.float64(-85.07908448142551), v.min() =np.float64(-85.32494389369516)
Solve for t=939.00, v.max() =np.float64(-85.08093366876582), v.min() =np.float64(-85.32516335898352)
Solve for t=940.00, v.max() =np.float64(-85.08276513356016), v.min() =np.float64(-85.32538153294747)
Solve for t=941.00, v.max() =np.float64(-85.08457907070152), v.min() =np.float64(-85.32559842707002)
Solve for t=942.00, v.max() =np.float64(-85.0863756726655), v.min() =np.float64(-85.3258140527285)
Solve for t=943.00, v.max() =np.float64(-85.08815512954273), v.min() =np.float64(-85.32602842119458)
Solve for t=944.00, v.max() =np.float64(-85.08991762907382), v.min() =np.float64(-85.32624154363793)
Solve for t=945.00, v.max() =np.float64(-85.0916633566807), v.min() =np.float64(-85.32645343112351)
Solve for t=946.00, v.max() =np.float64(-85.09339249549936), v.min() =np.float64(-85.32666409461507)
Solve for t=947.00, v.max() =np.float64(-85.09510522641212), v.min() =np.float64(-85.32687354497635)
Solve for t=948.00, v.max() =np.float64(-85.09680172807857), v.min() =np.float64(-85.32708179296934)
Solve for t=949.00, v.max() =np.float64(-85.0984821769659), v.min() =np.float64(-85.32728884926009)
Solve for t=950.00, v.max() =np.float64(-85.10014674738022), v.min() =np.float64(-85.32749472441388)
Solve for t=951.00, v.max() =np.float64(-85.10179561149553), v.min() =np.float64(-85.32769942890037)
Solve for t=952.00, v.max() =np.float64(-85.10342893938305), v.min() =np.float64(-85.32790297309316)
Solve for t=953.00, v.max() =np.float64(-85.10504689904131), v.min() =np.float64(-85.32810536726953)
Solve for t=954.00, v.max() =np.float64(-85.10664965642415), v.min() =np.float64(-85.32830662161422)
Solve for t=955.00, v.max() =np.float64(-85.10823737546801), v.min() =np.float64(-85.32850674621783)
Solve for t=956.00, v.max() =np.float64(-85.10981021812032), v.min() =np.float64(-85.32870575107782)
Solve for t=957.00, v.max() =np.float64(-85.11136834436712), v.min() =np.float64(-85.32890364610128)
Solve for t=958.00, v.max() =np.float64(-85.11291191225976), v.min() =np.float64(-85.3291004411042)
Solve for t=959.00, v.max() =np.float64(-85.11444107794033), v.min() =np.float64(-85.32929614581143)
Solve for t=960.00, v.max() =np.float64(-85.1159559956698), v.min() =np.float64(-85.32949076986175)
Solve for t=961.00, v.max() =np.float64(-85.11745681785193), v.min() =np.float64(-85.32968432280323)
Solve for t=962.00, v.max() =np.float64(-85.11894369505825), v.min() =np.float64(-85.32987681409666)
Solve for t=963.00, v.max() =np.float64(-85.12041677605538), v.min() =np.float64(-85.33006825311855)
Solve for t=964.00, v.max() =np.float64(-85.12187620782777), v.min() =np.float64(-85.33025864915795)
Solve for t=965.00, v.max() =np.float64(-85.12332213560154), v.min() =np.float64(-85.330448011419)
Solve for t=966.00, v.max() =np.float64(-85.12475470286954), v.min() =np.float64(-85.33063634902332)
Solve for t=967.00, v.max() =np.float64(-85.12617405141425), v.min() =np.float64(-85.330823671008)
Solve for t=968.00, v.max() =np.float64(-85.1275803213306), v.min() =np.float64(-85.33100998632752)
Solve for t=969.00, v.max() =np.float64(-85.12897365104983), v.min() =np.float64(-85.33119530385646)
Solve for t=970.00, v.max() =np.float64(-85.13035417735986), v.min() =np.float64(-85.33137963238622)
Solve for t=971.00, v.max() =np.float64(-85.13172203543101), v.min() =np.float64(-85.33156298062997)
Solve for t=972.00, v.max() =np.float64(-85.13307735883318), v.min() =np.float64(-85.33174535722081)
Solve for t=973.00, v.max() =np.float64(-85.13442027956062), v.min() =np.float64(-85.33192677071311)
Solve for t=974.00, v.max() =np.float64(-85.1357509280525), v.min() =np.float64(-85.33210722958275)
Solve for t=975.00, v.max() =np.float64(-85.13706943321245), v.min() =np.float64(-85.33228674222973)
Solve for t=976.00, v.max() =np.float64(-85.13837592243064), v.min() =np.float64(-85.33246531697769)
Solve for t=977.00, v.max() =np.float64(-85.13967052160294), v.min() =np.float64(-85.3326429620727)
Solve for t=978.00, v.max() =np.float64(-85.14095335515145), v.min() =np.float64(-85.33281968568818)
Solve for t=979.00, v.max() =np.float64(-85.14222454604356), v.min() =np.float64(-85.33299549592245)
Solve for t=980.00, v.max() =np.float64(-85.14348421581245), v.min() =np.float64(-85.3331704008004)
Solve for t=981.00, v.max() =np.float64(-85.14473248457334), v.min() =np.float64(-85.3333444082724)
Solve for t=982.00, v.max() =np.float64(-85.14596947104624), v.min() =np.float64(-85.33351752621941)
Solve for t=983.00, v.max() =np.float64(-85.14719529257079), v.min() =np.float64(-85.33368976244947)
Solve for t=984.00, v.max() =np.float64(-85.14841006512734), v.min() =np.float64(-85.33386112469933)
Solve for t=985.00, v.max() =np.float64(-85.1496139033525), v.min() =np.float64(-85.33403162063591)
Solve for t=986.00, v.max() =np.float64(-85.15080692055813), v.min() =np.float64(-85.33420125785794)
Solve for t=987.00, v.max() =np.float64(-85.15198922874835), v.min() =np.float64(-85.33437004389323)
Solve for t=988.00, v.max() =np.float64(-85.15316093863753), v.min() =np.float64(-85.33453798620226)
Solve for t=989.00, v.max() =np.float64(-85.15432215966607), v.min() =np.float64(-85.33470509217895)
Solve for t=990.00, v.max() =np.float64(-85.15547300001748), v.min() =np.float64(-85.33487136914947)
Solve for t=991.00, v.max() =np.float64(-85.15661356663362), v.min() =np.float64(-85.33503682437214)
Solve for t=992.00, v.max() =np.float64(-85.15774396523408), v.min() =np.float64(-85.33520146504188)
Solve for t=993.00, v.max() =np.float64(-85.15886430032923), v.min() =np.float64(-85.3353652982882)
Solve for t=994.00, v.max() =np.float64(-85.15997467523617), v.min() =np.float64(-85.33552833117554)
Solve for t=995.00, v.max() =np.float64(-85.16107519209484), v.min() =np.float64(-85.33569057070417)
Solve for t=996.00, v.max() =np.float64(-85.16216595188425), v.min() =np.float64(-85.33585202381144)
Solve for t=997.00, v.max() =np.float64(-85.16324705443493), v.min() =np.float64(-85.33601269737248)
Solve for t=998.00, v.max() =np.float64(-85.16431859844614), v.min() =np.float64(-85.33617259819985)
Solve for t=999.00, v.max() =np.float64(-85.16538068149954), v.min() =np.float64(-85.33633173304507)
Solve for t=1000.00, v.max() =np.float64(-85.16643340007334), v.min() =np.float64(-85.33649010859779)
def post_process(dx, outdir):
    mesh = adios4dolfinx.read_mesh(comm=comm, filename=checkpointfname)
    V = dolfinx.fem.functionspace(mesh, ("P", 1))
    v = dolfinx.fem.Function(V)
    times = beat.postprocess.read_timestamps(comm, checkpointfname, "v")

    cellnr = [0, 25, 50, 75, 100, 125, 150, 175, 200]
    cellnr = np.arange(0, 200, 10)

    p1 = 25 * dx
    p2 = 175 * dx
    dp = 150 * dx * beat.units.ureg("cm")
    tp1 = np.inf
    tp2 = np.inf

    points = cellnr * dx
    p1p2 = [p1, p2]

    if not (outdir / "traces.npy").is_file():
        traces = np.zeros((len(times), len(cellnr)))

        for i, ti in enumerate(times):
            adios4dolfinx.read_function(checkpointfname, v, time=ti, name="v")

            traces[i, :] = scifem.evaluate_function(
                v, np.expand_dims(points, 1),
            ).squeeze()
            vp1p2 = scifem.evaluate_function(v, np.expand_dims(p1p2, 1)).squeeze()

            if vp1p2[0] > 0.0 and tp1 == np.inf:
                tp1 = ti
            if vp1p2[0] > 0.0 and tp2 == np.inf:
                tp2 = ti

        np.save(outdir / "traces.npy", traces)
        np.save(outdir / "times.npy", times)
        (outdir / "cv.text").write_text(f"{tp1} {tp2}")

    traces = np.load(outdir / "traces.npy")
    t = np.load(outdir / "times.npy")
    tp1, tp2 = np.loadtxt(outdir / "cv.text")
    tp1 *= beat.units.ureg("ms")
    tp2 *= beat.units.ureg("ms")

    if not np.isclose(tp1, tp2):
        cv = dp / (tp2 - tp1)
        print(
            f"Conduction velocity:: {cv.to('cm/ms').magnitude} cm/ms "
            f"= {cv.to('m/s').magnitude} m/s",
        )

    # Plot 3D plot for all traces
    fig, ax = plt.subplots()
    for i, cell_index in enumerate(cellnr):
        color = "k" if cell_index < 100 else "m"
        ax.plot(t, cell_index / 3 * np.ones_like(t) + traces[:, i], color=color)
    ax.set_xlabel("Time (ms)")
    ax.set_yticks([-22, -55, -85])
    ax.set_yticklabels([200, 100, 1])
    fig.text(x=0.03, y=0.17, s="Cell number", rotation=90)

    ax.set_ylim(-90, 120)
    fig.savefig(outdir / "V_3d.png")
post_process(dx, outdir)
../_images/f7bbff6baf99c0af4ddf2b929f40bda1c3512e86dea4e49567980aa30acf1fb8.png