Applications, Examples and Libraries

Share your work here

Hi, 

In a recent post  (Monte Carlo Integration) Radaar shared its work about the numerical integration, with the Monte Carlo method, of a function defined in polar coordinates.
Radaar used a raw strategy based on a sampling in cartesian coordinates plus an ad hoc transformation.
Radaar obtained reasonably good results, but I posted a comment to show how Monte Carlo summation in polar coordinates can be done in a much simpler way. Behind this is the choice of a "good" sampling distribution which makes the integration problem as simple as Monte Carlo integration over a 2D rectangle with sides parallel to the co-ordinate axis.

This comment I sent pushed me to share the present work on Monte Carlo integration over simple polygons ("simple" means that two sides do not intersect).
Here again one can use raw Monte Carlo integration on the rectangle this polygon is inscribed in. But as in Radaar's post, a specific sampling distribution can be used that makes the summation method more elegant.

This work relies on three main ingredients:

  1. The Dirichlet distribution, whose one form enables sampling the 2D simplex in a uniform way.
  2. The construction of a 1-to-1 mapping from this simplex into any non degenerated triangle (a mapping whose jacobian is a constant equal to the ratio of the areas of the two triangles).
  3. A tesselation into triangles of the polygon to integrate over.


This work has been carried out in Maple 2015, which required the development of a module to do the tesselation. Maybe more recent Maple's versions contain internal procedures to do that.
 

Monte_Carlo_Integration.mw

 

Hi. My name is Eugenio and I’m a Professor at the Departamento de Didáctica de las Ciencias Experimentales, Sociales y Matemáticas at the Facultad de Educación of the Universidad Complutense de Madrid (UCM) and a member of the Instituto de Matemática Interdisciplinar (IMI) of the UCM.

I have a 14-year-old son. In the beginning of the pandemic, a confinement was ordered in Spain. It is not easy to make a kid understand that we shouldn't meet our friends and relatives for some time and that we should all stay at home in the first stage. So, I developed a simplified explanation of virus propagation for kids, firstly in Scratch and later in Maple, the latter using an implementation of turtle geometry that we developed long ago and has a much better graphic resolution (E. Roanes-Lozano and E. Roanes-Macías. An Implementation of “Turtle Graphics” in Maple V. MapleTech. Special Issue, 1994, 82-85). A video (in Spanish) of the Scratch version is available from the Instituto de Matemática Interdisciplinar (IMI) web page: https://www.ucm.es/imi/other-activities

Introduction

Surely you are uncomfortable being locked up at home, so I will try to justify that, although we are all looking forward going out, it is good not to meet your friends and family with whom you do not live.

I firstly need to mention a fractal is. A fractal is a geometric object whose structure is repeated at any scale. An example in nature is Romanesco broccoli, that you perhaps have eaten (you can search for images on the Internet). You can find a simple fractal in the following image (drawn with Maple):

Notice that each branch is divided into two branches, always forming the same angle and decreasing in size in the same proportion.

We can say that the tree in the previous image is of “depth 7” because there are 7 levels of branches.

It is quite easy to create this kind of drawing with the so called “turtle geometry” (with a recursive procedure, that is, a procedure that calls itself). Perhaps you have used Scratch programming language at school (or Logo, if you are older), which graphics are based in turtle geometry.

All drawings along these pages have been created with Maple. We can easily reform the code that generated the previous tree so that it has three, four, five,… branches at each level, instead of two.

But let’s begin with a tale that explains in a much simplified way how the spread of a disease works.

- o O o -

Let's suppose that a cat returns sick to Catland suffering from a very contagious disease and he meets his friends and family, since he has missed them so much.

We do not know very well how many cats each sick cat infects in average (before the order to STAY AT HOME arrives, as cats in Catland are very obedient and obey right away). Therefore, we’ll analyze different scenarios:

  1. Each sick cat infects two other cats.
  2. Each sick cat infects three other cats.
  3. Each sick cat infects five other cats

 

1. Each Sick Cat Infects Two Cats

In all the figures that follow, the cat initially sick is in the center of the image. The infected cats are represented by a red square.

· Before everyone gets confined at home, it only takes time for that first sick cat to see his friends, but then confinement is ordered (depth 1)

As you can see, with the cat meeting his friends and family, we already have 3 sick cats.

· Before all cats confine themselves at home, the first cat meets his friends, and these in turn have time to meet their friends (depth 2)

In this case, the number of sick cats is 7.

· Before every cat is confined at home, there is time for the initially sick cat to meet his friends, for these to meet their friends, and for the latter (friends of the friends of the first sick cat) to meet their friends (depth 3).

There are already 15 sick cats...

· Depth 4: 31 sick cats.

· Depth 5: 63 sick cats.

Next we’ll see what would happen if each sick cat infected three cats, instead of two.

 

2. Every Sick Cat Infects Three Cats

· Now we speed up, as you’ve got the idea.

The first sick cat has infected three friends or family before confining himself at home. So there are 4 infected cats.

· If each of the recently infected cats in the previous figure have in turn contact with their friends and family, we move on to the following situation, with 13 sick cats:

· And if each of these 13 infected cats lives a normal life, the disease spreads even more, and we already have 40!

· At the next step we have 121 sick cats:

· And, if they keep seeing friends and family, there will be 364 sick cats (the image reminds of what is called a Sierpinski triangle):

 

4. Every Sick Cat Infects Five Cats

· In this case already at depth 2 we already have 31 sick cats.

 

5. Conclusion

This is an example of exponential growth. And the higher the number of cats infected by each sick cat, the worse the situation is.

Therefore, avoiding meeting friends and relatives that do not live with you is hard, but good for stopping the infection. So, it is hard, but I stay at home at the first stage too!

Monte Carlo integration uses random sampling unlike classical techniques like the trapezoidal or Simpson's rule in evaluating the integration numerically.

restart; ff := proc (rho, phi) return exp(rho*cos(phi))*rho end proc; aa := 0; bb := 1; cc := 0; dd := 2*Pi; alfa := 5; nrun := 15000; sum1 := 0; sum2 := 0; X := Statistics:-RandomVariable(Uniform(0, 1)); SX := Statistics:-Sample(X); for ii to nrun do u1 := SX(1)[1]; u2 := SX(1)[1]; xx1 := aa+(bb-aa)*u1; xx2 := cc+(dd-cc)*u2; xx3 := (bb-aa)*(1-u1); xx4 := (dd-cc)*(1-u2); sum1 := sum1+evalf(ff(xx1, xx2)); sum2 := sum2+evalf(ff(xx1, xx2))+evalf(ff(xx1, xx4))+evalf(ff(xx3, xx2))+evalf(ff(xx3, xx4)) end do; area1 := (bb-aa)*(dd-cc)*sum1/nrun; area2 := (bb-aa)*(dd-cc)*sum2/(4*nrun); area2

HFloat(3.5442090450428574)

(1)

evalf(Int(exp(rho*cos(phi))*rho, rho = 0 .. 1, phi = 0 .. 2*Pi))

3.550999378

(2)

NULL


 

Download MONTE_CARLO_INTEGRATION1.mw

 

 

The purpose of this document is:

a) to correct the physics that was used in the document "Minimal Road Radius for Highway Superelevation" recently submitted to the Maple Applications Center;

b) to confirm the values found in the manual for the American Association of State Highway and Transportation Officials (AASHTO) that engineers use to design and build these banked curves are physically sound. 

c) to highlight the pedagogical value inherent in the Maple language to distinguish between assignment ( := )  and equivalence (  =  );

d) but most importantly, to demonstrate the pedagogical value Maple has in thinking about solving a problem involving a physical process. Given Maple's symbolic mathematics capabilities, one can implement a top-down approach to the physics and the mathematics, working from the general principle to the specific example. This allows one to avoid the types of errors that occur when translating the problem into a bottom up approach, from specific values of the example to the general principle, an approach that is required by most other computational systems.

I hope that others are willing to continue to engage in discussions related to the pedagogical value of Maple beyond mathematics.

I was asked to post this document to both here and the Maple Applications Center

[Document edited for typos.]

Minimum_Road_Radius.mw

Maple's pdsolve() is quite capable of solving the PDE that describes the motion of a single-span Euler beam.  As far as I have been able to ascertain, there is no obvious way of applying pdsolve() to solve multi-span beams.  The worksheet attached to this post provides tools for solving multi-span Euler beams.  Shown below are a few demos.  The worksheet contains more demos.

 

A module for solving the Euler beam with the method of lines

beamsolve

 

The beamsolve proc solves a (possibly multi-span) Euler beam equation:``

"rho ((∂)^2u)/((∂)^( )t^2)+ ((∂)^2)/((∂)^( )x^2)(EI ((∂)^(2)u)/((∂)^( )x^(2)))=f"

subject to initial and boundary conditions.  The solution u = u(x, t) is the

transverse deflection of the beam at point x at time t, subject to the load
density (i.e., load per unit length) given by f = f(x, t). The coefficient rho 

is the beam's mass density (mass per unit length), E is the Young's modulus of

the beam's material, and I is the beam's cross-sectional moment of inertia

about the neutral axis.  The figure below illustrates a 3-span beam (drawn in green)
supported on four supports, and loaded by a variable density load (drawn in gray)
which may vary in time.  The objective is to determine the deformed shape of the
beam as a function of time.


The number of spans, their lengths, and the nature of the supports may be specified

as arguments to beamsolve.

 

In this worksheet we assume that rho, E, I are constants for simplicity. Since only
the product of the coefficients E and I enters the calculations, we lump the two

together into a single variable which we indicate with the two-letter symbol EI.

Commonly, EI is referred to as the beam's rigidity.

 

The PDE needs to be supplied with boundary conditions, two at each end, each

condition prescribing a value (possibly time-dependent) for one of u, u__x, u__xx, u__xxx 
(that's 36 possible combinations!) where I have used subscripts to indicate

derivatives.  Thus, for a single-span beam of length L, the following is an admissible

set of boundary conditions:
u(0, t) = 0, u__xx(0, t) = 0, u__xx(L, t) = 0, u__xxx(t) = sin*t.   (Oops, coorection, that last
condition was meant to be uxxx(L,t) = sin t.)

Additionally, the PDE needs to be supplied with initial conditions which express

the initial displacement and the initial velocity:
"u(x,0)=phi(x),   `u__t`(x,0)=psi(x)."

 

The PDE is solved through the Method of Lines.  Thus, each span is subdivided into

subintervals and the PDE's spatial derivatives are approximated through finite differences.

The time derivatives, however, are not discretized.  This reduces the PDE into a set of

ODEs which are solved with Maple's dsolve().  

 

Calling sequence:

        beamsolve(L, n, options)

 

Parameters:

        L:  List of span lengths, in order from left to right, as in [L__1, L__2 .. (), `L__ν`].

        n The number of subintervals in the shortest span (for the finite difference approximation)

 

Notes:

• 

It is assumed that the spans are laid back-to-back along the x axis, with the left end
of the overall beam at x = 0.

• 

The interior supports, that is, those supports where any two spans meet, are assumed
to be of the so-called simple type.  A simple support is immobile and it doesn't exert
a bending moment on the beam.  Supports at the far left and far right of the beam can
be of general type; see the BC_left and BC_right options below.

• 

If the beam consists of a single span, then the argument L may be entered as a number
rather than as a list. That is, L__1 is equivalent to [L__1].

 

Options:

        All options are of the form option_name=value, and have built-in default values.

        Only options that are other than the defaults need be specified.

 

        rho: the beam's (constant) mass density per unit length (default: rho = 1)

        EI: the beam's (constant) rigidity (default: EI = 1)

        T: solve the PDE over the time interval 0 < t and t < T (default: T = 1)

        F: an expression in x and t that describes the applied force f(x, t)  (default: F = 0)
        IC: the list [u(x, 0), u__t(x, 0)]of the initial displacement and velocity,  as
                expressions in x (default: IC = [0,0])

        BC_left: a list consisting of a pair of boundary conditions at the left end of
                the overall (possibly multi-span beam.  These can be any two of
                u = alpha(t), u_x = beta(t), u_xx = gamma(t), u_xxx = delta(t). The right-hand sides of these equations

                can be any expression in t.  The left-hand sides should be entered literally as indicated.

                If a right-hand side is omitted, it is taken to be zero.   (default: BC_left = [u, u_xx] which

                corresponds to a simple support).

        BC_right: like BC_left, but for the right end of the overall beam (default: BC_right = "[u,u_xx])"

 

The returned module:

        A call to beamsolve returns a module which presents three methods.  The methods are:

 

        plot (t, refine=val, options)

                plots the solution u(x, t) at time t.  If the discretization in the x direction

                is too coarse and the graph looks non-smooth, the refine option

                (default: refine=1) may be specified to smooth out the graph by introducing

                val number of intermediate points within each discretized subinterval.

                All other options are assumed to be plot options and are passed to plots:-display.

 

        plot3d (m=val, options)

                plots the surface u(x, t).  The optional m = val specification requests

                a grid consisting of val subintervals in the time direction (default: "m=25)"

                Note that this grid is for plotting purposes only; the solution is computed

                as a continuous (not discrete) function of time. All other options are assumed

                to be plot3d options and are passed to plots:-display.

 

        animate (frames=val, refine=val, options)

                produces an animation of the beam's motion.  The frames option (default = 50)

                specifies the number of animation frames.  The refine option is passed to plot
                (see the description above. All other options are assumed to be plot options and
                are passed to plots:-display.

Note:

        In specifying the boundary conditions, the following reminder can be helpful.  If the beam

        is considered to be horizontal, then u is the vertical displacement, `u__x ` is the slope,  EI*u__xx

        is the bending moment, and EI*u__xxx is the transverse shear force.

 

A single-span simply-supported beam with initial velocity

 

The function u(x, t) = sin(Pi*x)*sin(Pi^2*t) is an exact solution of a simply supported beam with

"u(x,0)=0,   `u__t`(x,0)=Pi^(2)sin(Pi x)."  The solution is periodic in time with period 2/Pi.

sol := beamsolve(1, 25, 'T'=2/Pi, 'IC'=[0, Pi^2*sin(Pi*x)]):
sol:-animate(size=[600,250]);

The initial condition u(x, 0) = 0, u__t(x, 0) = 1  does not lead to a separable form, and

therefore the motion is more complex.

sol := beamsolve(1, 25, 'T'=2/Pi, 'IC'=[0, 1]):
sol:-animate(frames=200, size=[600,250]);


 

A single-span cantilever beam

 

A cantilever beam with initial condition "u(x,0)=g(x),  `u__t`(x,0)=0," where g(x) is the
first eigenmode of its free vibration (calculated in another spreadsheet).  The motion is
periodic in time, with period "1.787018777."

g := 0.5*cos(1.875104069*x) - 0.5*cosh(1.875104069*x) - 0.3670477570*sin(1.875104069*x) + 0.3670477570*sinh(1.875104069*x):
sol := beamsolve(1, 25, 'T'=1.787018777, 'BC_left'=[u,u_x], 'BC_right'=[u_xx,u_xxx], 'IC'=[g, 0]):
sol:-animate(size=[600,250]);

If the initial condition is not an eigenmode, then the solution is rather chaotic.

sol := beamsolve(1, 25, 'T'=3.57, 'BC_left'=[u,u_x], 'BC_right'=[u_xx,u_xxx], 'IC'=[-x^2, 0]):
sol:-animate(size=[600,250], frames=100);


 

A single-span cantilever beam with a weight hanging from its free end

 

sol := beamsolve(1, 25, 'T'=3.57, 'BC_left'=[u,u_x], 'BC_right'=[u_xx,u_xxx=1]):
sol:-animate(size=[600,250], frames=100);


 

A single-span cantilever beam with oscillating support

 

sol := beamsolve(1, 25, 'T'=Pi, 'BC_left'=[u=0.1*sin(10*t),u_x], 'BC_right'=[u_xx,u_xxx]):
sol:-animate(size=[600,250], frames=100);


 

A dual-span simply-supported beam with moving load

 

Load moves across a dual-span beam.

The beam continues oscillating after the load leaves.

d := 0.4:  T := 4:  nframes := 100:
myload := - max(0, -6*(x - t)*(d + x - t)/d^3):
sol := beamsolve([1,1], 20, 'T'=T, 'F'=myload):
sol:-animate(frames=nframes):
plots:-animate(plot, [2e-3*myload(x,t), x=0..2, thickness=1, filled=[color="Green"]], t=0..T, frames=nframes):
plots:-display([%%,%], size=[600,250]);


 

A triple-span simply-supported beam with moving load

 

Load moves across a triple-span beam.

The beam continues oscillating after the load leaves.

d := 0.4:  T := 6: nframes := 100:
myload := - max(0, -6*(x - t)*(d + x - t)/d^3):
sol := beamsolve([1,1,1], 20, 'T'=T, 'F'=myload):
sol:-plot3d(m=50);
sol:-animate(frames=nframes):
plots:-animate(plot, [2e-3*myload(x,t), x=0..3, thickness=1, filled=[color="Green"]], t=0..T, frames=nframes):
plots:-display([%%,%], size=[600,250]);

z3d;


 

A triple-span beam, moving load falling off the cantilever end

 

In this demo the load move across a multi-span beam with a cantilever section at the right.

As it skips past the cantilever end, the beam snaps back violently.

d := 0.4:  T := 8: nframes := 200:
myload := - max(0, -6*(x - t/2)*(d + x - t/2)/d^3):
sol := beamsolve([1,1,1/2], 10, 'T'=T, 'F'=myload, BC_right=[u_xx, u_xxx]):
sol:-animate(frames=nframes):
plots:-animate(plot, [1e-2*myload(x,t), x=0..3, thickness=1, filled=[color="Green"]], t=0..T, frames=nframes):
plots:-display([%%,%], size=[600,250]);


 


Download worksheet: euler-beam-with-method-of-lines.mw

 

This is my attempt to produce a subplot within a larger plot for magnifying data in a small region, and putting that subplot into the white space of the figure.
Based on the questions: How to insert a plot into another plot? and Inset figure in Maple, I wrote a couple of procedures that create sub-plots and allow the user to place the subplot window as he/she chooses. This avoids the graininess issues mentioned by acer in the second link (and experienced by me).

So far, I only have this completed for point plots, but using acer's method of piecewise functions posted in the plotin2b.mw of the second article, with the subplot function being defined only if it satisfies your conditions, would allow the subplot generating procedure to be generalized easily enough. But the data I'm working with all point plots, so that's the example here.

The basic idea  is to use one procedure to create boxes, make tickmarks on the expanded region, and make tickmark labels, combine all of those into one graph. Then create scaled and shifted versions of the data series, then make graphs of those. Lastly, combine them all into one picture.

Hope this helps someone who has to do the same.

Mapleprimes isn't inserting the contents, but here is the download of the file: SubPlotBoxesandVectorDataSeries.mw

 

Here is a little cute demo that shows how a cube may be paritioned into three congruent pyramids.  This was inspired by a Mathematica demo that I found in the web but I think this one's better :-)

A Cube as a union of three right pyramids

Here is an animated demo of the well-known fact that a cube may be partitioned

into three congruent right pyramids.

 

2020-05-21

restart;

with(plots):

with(plottools):

A proc to plot a general polyhedron.
V = [[x, y, z], [x, y, z], () .. (), [x, y, z]]                list of vertices
F = [[n__1, n__2, () .. ()], [n__1, n__2, () .. ()], () .. (), [n__1, n__2, () .. ()]]  list of faces

An entry "[`n__1`,`n__2`. ...]" in Fdescribes a face made of the vertices "V[`n__1`], V[`n__2`], ...," etc.

polyhedron := proc(V::list, F::list)
  seq(plottools:-polygon([seq( V[F[i][j]], j=1..nops(F[i]))]), i=1..nops(F));
  plots:-display(%);
end proc:

Define the vertices and faces of a pyramid:

v := [[0,0,0],[1,0,0],[1,1,0],[0,1,0],[0,0,1]];
f := [ [1,2,3,4], [5,2,3], [5,3,4], [1,5,4], [1,2,5] ];

[[0, 0, 0], [1, 0, 0], [1, 1, 0], [0, 1, 0], [0, 0, 1]]

[[1, 2, 3, 4], [5, 2, 3], [5, 3, 4], [1, 5, 4], [1, 2, 5]]

Build three such pyramids:

P1 := polyhedron(v, f):
P2 := reflect(P1, [[1,0,0],[1,1,0],[1,0,1]]):
P3 := reflect(P1, [[0,1,0],[1,1,0],[0,1,1]]):

This is what we have so far:

display(P1,P2,P3, scaling=constrained);

Define an animation frame.  The parameter t goes from 0 to 1.

Any extra options are assumed to be plot3d options and are

passed to plots:-display.

frame := proc(t)
  plots:-display(
    P1,

    rotate(P2, Pi/2*t, [[1,1,0],[1,0,0]]),
    rotate(P3, Pi/2*t, [[0,1,0],[1,1,0]]),
    color=["Red", "Green", "Blue"], _rest);
end proc:

Animate:

display(frame(0) $40, seq(frame(t), t=0..1, 0.01), frame(1) $40,
  insequence, scaling=constrained, axes=none,
  orientation=[45,0,120], viewpoint=circleleft);

 

Download square-partitioned-into-pyramids.mw

 

 

The equations of motion in curvilinear coordinates, tensor notation and Coriolis force

``

 

The formulation of the equations of motion of a particle is simple in Cartesian coordinates using vector notation. However, depending on the problem, for example when describing the motion of a particle as seen from a non-inertial system of references (e.g. a rotating planet, like earth), there is advantage in using curvilinear coordinates and also tensor notation. When the particle's movement is observed from such a rotating referential, we also see "acceleration" that is not due to any force but to the fact that the referential itself is accelerated. The material below discusses and formulates these topics, and derives the expression for the Coriolis and centripetal force in cylindrical coordinates as seen from a rotating system of references.

 

The computation below is reproducible in Maple 2020 using the Maplesoft Physics Updates v.681 or newer.

 

Vector notation

 

Generally speaking the equations of motion of a particle are easy to formulate: the position vector is a function of time, the velocity is its first derivative and the acceleration is its second derivative. For instance, in Cartesian coordinates

with(Physics); with(Vectors)

r_(t) = x(t)*_i+y(t)*_j+z(t)*_k

r_(t) = x(t)*_i+y(t)*_j+z(t)*_k

(1)

diff(r_(t) = x(t)*_i+y(t)*_j+z(t)*_k, t)

diff(r_(t), t) = (diff(x(t), t))*_i+(diff(y(t), t))*_j+(diff(z(t), t))*_k

(2)

diff(diff(r_(t), t) = (diff(x(t), t))*_i+(diff(y(t), t))*_j+(diff(z(t), t))*_k, t)

diff(diff(r_(t), t), t) = (diff(diff(x(t), t), t))*_i+(diff(diff(y(t), t), t))*_j+(diff(diff(z(t), t), t))*_k

(3)

Newton's 2nd law, that in an inertial system of references when there is force there is acceleration and viceversa, is then given by

F_(t) = m*lhs(diff(diff(r_(t), t), t) = (diff(diff(x(t), t), t))*_i+(diff(diff(y(t), t), t))*_j+(diff(diff(z(t), t), t))*_k)

F_(t) = m*(diff(diff(r_(t), t), t))

(4)

where `#mover(mi("F"),mo("&rarr;"))`(t) = F__x(t)*`#mover(mi("i"),mo("&and;"))`+F__y(t)*`#mover(mi("j"),mo("&and;"))`+F__z(t)*`#mover(mi("k"),mo("&and;"))` represents the total force acting on the particle. This vectorial equation represents three second order differential equations which, for given initial conditions, can be integrated to arrive at a closed form expression for `#mover(mi("r"),mo("&rarr;"))`(t) as a function of t.

 

Tensor notation

 

In Cartesian coordinates, the tensorial form of the equations (4) is also straightforward. In a flat spacetime - Galilean system of references - the three space coordinates x, y, z form a 3D tensor, and so does its first derivate and the second one. Set the spacetime to be 3-dimensional and Euclidean and use lowercaselatin indices for the corresponding tensors

Setup(coordinates = cartesian, metric = Euclidean, dimension = 3, spacetimeindices = lowercaselatin)

`The dimension and signature of the tensor space are set to `[3, `+ + +`]

 

`Systems of spacetime coordinates are:`*{X = (x, y, z)}

 

_______________________________________________________

 

`The Euclidean metric in coordinates `*[x, y, z]

 

_______________________________________________________

 

Physics:-g_[mu, nu] = Matrix(%id = 18446744078329083054)

 

_______________________________________________________

(5)

The position, velocity and acceleration vectors are expressed in tensor notation as done in (1), (2) and (3)

X[j](t)

(X)[j](t)

(6)

diff((X)[j](t), t)

Physics:-Vectors:-diff((Physics:-SpaceTimeVector[j](X))(t), t)

(7)

diff(Physics[Vectors]:-diff((Physics[SpaceTimeVector][j](X))(t), t), t)

Physics:-Vectors:-diff(Physics:-Vectors:-diff((Physics:-SpaceTimeVector[j](X))(t), t), t)

(8)

Setting a tensor F__j(t) to represent the three Cartesian components of the force

Define(F[j] = [F__x(t), F__y(t), F__z(t)])

`Defined objects with tensor properties`

 

{Physics:-Dgamma[a], F[j], Physics:-Psigma[a], Physics:-d_[a], Physics:-g_[a, b], Physics:-LeviCivita[a, b, c], Physics:-SpaceTimeVector[a](X)}

(9)

Newton's 2nd law (4), now expressed in tensorial notation, is given by

F[j] = m*Physics[Vectors]:-diff(Physics[Vectors]:-diff((Physics[SpaceTimeVector][j](X))(t), t), t)

F[j] = m*(diff(diff((Physics:-SpaceTimeVector[j](X))(t), t), t))

(10)

The three differential equations behind this tensorial form of (4) are as expected

TensorArray(F[j] = m*(diff(diff((Physics[SpaceTimeVector][j](X))(t), t), t)), output = setofequations)

{F__x(t) = m*(diff(diff(x(t), t), t)), F__y(t) = m*(diff(diff(y(t), t), t)), F__z(t) = m*(diff(diff(z(t), t), t))}

(11)

Things are straightforward in Cartesian coordinates because the components of the line element `#mover(mi("dr"),mo("&rarr;"))` = dx*`#mover(mi("i"),mo("&and;"))`+dy*`#mover(mi("j"),mo("&and;"))`+dz*`#mover(mi("k"),mo("&and;"))` are exactly the components of the tensor d(X[j])

TensorArray(d_(X[j]))

Array(%id = 18446744078354237310)

(12)

and so, the form factors (see related Mapleprimes post) are all equal to 1.

 

In the case of no external forces, `#mover(mi("F"),mo("&rarr;"))`(t) = 0 and 0 = F[j] and the equations of motion, whose solution are the trajectory, can be formulated as the path of minimal length between two points, a geodesic. In the case under consideration, because the spacetime is flat (Galilean) those two points lie on a plane, we are talking about Euclidean geometry, that information is encoded in the metric (the 3x3 identity matrix (5)), and the geodesic is a straight line. The differential equations of this geodesic are thus the equations of motion (11) with  `#mover(mi("F"),mo("&rarr;"))`(t) = 0, and can be computed using Geodesics

 

Geodesics(t)

[diff(diff(z(t), t), t) = 0, diff(diff(y(t), t), t) = 0, diff(diff(x(t), t), t) = 0]

(13)

 

Curvilinear coordinates

 

Vector notation

 

The form of these equations in the case of curvilinear coordinates, for example in cylindrical or spherical variables, is obtained performing a change of coordinates.

tr := `~`[`=`]([X], ChangeCoordinates([X], cylindrical))

[x = rho*cos(phi), y = rho*sin(phi), z = z]

(14)

This change keeps the z axis unchanged, so the corresponding unit vector `#mover(mi("k"),mo("&and;"))` remains unchanged.

Changing the basis and coordinates used to represent the position vector `#mover(mi("r"),mo("&rarr;"))`(t) = x(t)*`#mover(mi("i"),mo("&and;"))`+y(t)*`#mover(mi("j"),mo("&and;"))`+z(t)*`#mover(mi("k"),mo("&and;"))`, it becomes

r_(t) = ChangeBasis(rhs(r_(t) = x(t)*_i+y(t)*_j+z(t)*_k), cylindrical, alsocomponents)

r_(t) = z(t)*_k+rho(t)*_rho(t)

(15)

where since in (1) the coordinates (x, y, z) depend on t, in (15), not just rho(t) and z(t) but also the unit vector `#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`(t)depends on t. The velocity is computed as usual, differentiating

diff(r_(t) = z(t)*_k+rho(t)*_rho(t), t)

diff(r_(t), t) = (diff(z(t), t))*_k+(diff(rho(t), t))*_rho(t)+rho(t)*(diff(phi(t), t))*_phi(t)

(16)

The second term is due to the dependency of `#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))` on the coordinate phi together with the chain rule diff(`#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`(t), t) = (diff(`#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`, phi))*(diff(phi(t), t)) and (diff(`#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`, phi))*(diff(phi(t), t)) = `#mover(mi("&phi;",fontstyle = "normal"),mo("&and;"))`(t)*(diff(phi(t), t)). The dependency of curvilinear unit vectors on the coordinates is automatically taken into account when differentiating due to the Setup setting geometricdifferentiation = true.

 

For the acceleration,

diff(diff(r_(t), t) = (diff(z(t), t))*_k+(diff(rho(t), t))*_rho(t)+rho(t)*(diff(phi(t), t))*_phi(t), t)

diff(diff(r_(t), t), t) = _rho(t)*(diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2)+_phi(t)*(2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k

(17)

where the term involving (diff(phi(t), t))^2 comes from differentiating `#mover(mi("&phi;",fontstyle = "normal"),mo("&and;"))`(t) in (16) taking into account the dependency of `#mover(mi("&phi;",fontstyle = "normal"),mo("&and;"))` on the coordinate "phi." This result can also be obtained by directly changing variables in the acceleration diff(`#mover(mi("r"),mo("&rarr;"))`(t), t, t), in equation (3)

lhs(diff(diff(r_(t), t), t) = (diff(diff(x(t), t), t))*_i+(diff(diff(y(t), t), t))*_j+(diff(diff(z(t), t), t))*_k) = ChangeBasis(rhs(diff(diff(r_(t), t), t) = (diff(diff(x(t), t), t))*_i+(diff(diff(y(t), t), t))*_j+(diff(diff(z(t), t), t))*_k), cylindrical, alsocomponents)

diff(diff(r_(t), t), t) = _rho(t)*(diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2)+_phi(t)*(2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k

(18)

 

Newton's 2nd law becomes

F_(t) = m*rhs(diff(diff(r_(t), t), t) = _rho(t)*(diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2)+_phi(t)*(2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k)

F_(t) = m*(_rho(t)*(diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2)+_phi(t)*(2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k)

(19)

In the absence of external forces, equating to 0 the vector components (coefficients of the unit vectors) of the acceleration diff(`#mover(mi("r"),mo("&rarr;"))`(t), t, t)we get the system of differential equations in cylindrical coordinates whose solution is the trajectory of the particle expressed in the ("rho(t),phi(t),z(t))"

`~`[`=`]({coeffs(rhs(diff(diff(r_(t), t), t) = _rho(t)*(diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2)+_phi(t)*(2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k), [`#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`(t), `#mover(mi("&phi;",fontstyle = "normal"),mo("&and;"))`(t), `#mover(mi("k"),mo("&and;"))`])}, 0)

{2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)) = 0, diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2 = 0, diff(diff(z(t), t), t) = 0}

(20)

solve({2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)) = 0, diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2 = 0, diff(diff(z(t), t), t) = 0}, {diff(phi(t), t, t), diff(rho(t), t, t), diff(z(t), t, t)})

{diff(diff(phi(t), t), t) = -2*(diff(rho(t), t))*(diff(phi(t), t))/rho(t), diff(diff(rho(t), t), t) = rho(t)*(diff(phi(t), t))^2, diff(diff(z(t), t), t) = 0}

(21)

In this formulation (21) with `#mover(mi("F"),mo("&rarr;"))`(t) = 0, although diff(z(t), t, t) = 0, no acceleration in the `#mover(mi("k"),mo("&and;"))` direction, is naturally expected, the same cannot be said about the other two equations for diff(phi(t), t, t) and diff(rho(t), t, t). Those two equations are discussed below under Coriolis and Centripetal forces. The key observation at this point, however, is that the right-hand sides of both unexpected equations involve diff(phi(t), t), rotation around the z axis.

 

Tensor notation

 

The same equations (19) and (21) result when using tensor notation. For that purpose, one can transform the position, velocity and acceleration tensors (6), (7), (8), but since they are expressed as functions of a parameter (the time), it is simpler to transform only the underlying metric using TransformCoordinates. That has the advantage that all the geometrical subtleties of curvilinear coordinates, like scale factors and dependency of unit vectors on curvilinear coordinates, get automatically, very succinctly, encoded in the metric:

TransformCoordinates(tr, g_[j, k], [rho, phi, z], setmetric)

_______________________________________________________

 

`Coordinates: `[rho, phi, z]*`. Signature: `(`+ + +`)

 

_______________________________________________________

 

Physics:-g_[a, b] = Matrix(%id = 18446744078263848958)

 

_______________________________________________________

(22)

The computation of geodesics assumes that the coordinates (rho, phi, z) depend on a parameter. That parameter is passed as the first argument to Geodesics

Geodesics(t)

[diff(diff(rho(t), t), t) = rho(t)*(diff(phi(t), t))^2, diff(diff(phi(t), t), t) = -2*(diff(rho(t), t))*(diff(phi(t), t))/rho(t), diff(diff(z(t), t), t) = 0]

(23)

These equations of motion (23) are the same as the equations (21) computed using standard vector notation, differentiating and taking into account the dependency of curvilinear unit vectors on the curvilinear coordinates in (16) and (17).  One of the interesting features of computing with tensors is, as said, that all those geometrical algebraic subtleties of curvilinear coordinates are automatically encoded in the metric (22).

 

To understand how are the geodesic equations computed in one go in (23), one can perform the calculation in steps:

1. 

Make rho be a function of t directly in the metric

2. 

Compute - not the final form of the equations (23) - but the intermediate form expressing the geodesic equation using tensor notation, in terms of Christoffel symbols

3. 

Compute the components of that tensorial equation for the geodesic (using TensorArray)

 

For step 1, we have

subs(rho = rho(t), g_[])

Physics:-g_[a, b] = Matrix(%id = 18446744078354237910)

(24)

Set this metric where `&equiv;`(rho, rho(t))

"Setup(?):"

_______________________________________________________

 

`Coordinates: `[rho, phi, z]*`. Signature: `(`+ + +`)

 

_______________________________________________________

 

Physics:-g_[a, b] = Matrix(%id = 18446744078342604430)

 

_______________________________________________________

(25)

Step 2, the geodesic equations in tensor notation with the coordinates depending on the time t are computed passing the optional argument tensornotation

Geodesics(t, tensornotation)

diff(diff((Physics:-SpaceTimeVector[`~a`](X))(t), t), t)+Physics:-Christoffel[`~a`, b, c]*(diff((Physics:-SpaceTimeVector[`~b`](X))(t), t))*(diff((Physics:-SpaceTimeVector[`~c`](X))(t), t)) = 0

(26)

Step 3: compute the components of this tensorial equation

TensorArray(diff(diff((Physics[SpaceTimeVector][`~a`](X))(t), t), t)+Physics[Christoffel][`~a`, b, c]*(diff((Physics[SpaceTimeVector][`~b`](X))(t), t))*(diff((Physics[SpaceTimeVector][`~c`](X))(t), t)) = 0, output = listofequations)

[diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2 = 0, diff(diff(phi(t), t), t)+2*(diff(rho(t), t))*(diff(phi(t), t))/rho(t) = 0, diff(diff(z(t), t), t) = 0]

(27)

These are the same equations (23).

 

Having the tensorial equation (26) is also useful to formulate the equations of motion in tensorial form in the presence of force. For that purpose, redefine the contravariant tensor F^j to represent the force in the cylindrical basis

Define(F[`~j`] = [`F__&rho;`(t), `F__&phi;`(t), F__z(t)])

`Defined objects with tensor properties`

 

{Physics:-D_[a], Physics:-Dgamma[a], F[j], Physics:-Psigma[a], Physics:-Ricci[a, b], Physics:-Riemann[a, b, c, d], Physics:-Weyl[a, b, c, d], Physics:-d_[a], Physics:-g_[a, b], Physics:-Christoffel[a, b, c], Physics:-Einstein[a, b], Physics:-LeviCivita[a, b, c], Physics:-SpaceTimeVector[a](X)}

(28)

 

Newton's 2nd law (19)

F_(t) = m*(_rho(t)*(diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2)+_phi(t)*(2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k)

F_(t) = m*(_rho(t)*(diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2)+_phi(t)*(2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k)

(29)

now using tensorial notation, becomes

F[`~a`] = m*lhs(diff(diff((Physics[SpaceTimeVector][`~a`](X))(t), t), t)+Physics[Christoffel][`~a`, b, c]*(diff((Physics[SpaceTimeVector][`~b`](X))(t), t))*(diff((Physics[SpaceTimeVector][`~c`](X))(t), t)) = 0)

F[`~a`] = m*(diff(diff((Physics:-SpaceTimeVector[`~a`](X))(t), t), t)+Physics:-Christoffel[`~a`, b, c]*(diff((Physics:-SpaceTimeVector[`~b`](X))(t), t))*(diff((Physics:-SpaceTimeVector[`~c`](X))(t), t)))

(30)

TensorArray(F[`~a`] = m*(diff(diff((Physics[SpaceTimeVector][`~a`](X))(t), t), t)+Physics[Christoffel][`~a`, b, c]*(diff((Physics[SpaceTimeVector][`~b`](X))(t), t))*(diff((Physics[SpaceTimeVector][`~c`](X))(t), t))))

Array(%id = 18446744078329063774)

(31)

where we recall (see related Mapleprimes post) that to obtain the vector components entering `#mover(mi("F"),mo("&rarr;"))`(t) from these tensor components F[`~a`]we need to multiply the latter by the scale factors (1, rho(t), 1), the component of `#mover(mi("F"),mo("&rarr;"))`(t) in the direction of `#mover(mi("&phi;",fontstyle = "normal"),mo("&and;"))` is given by rho(t)*m*(diff(phi(t), t, t)+2*(diff(rho(t), t))*(diff(phi(t), t))/rho(t)).

 

Coriolis force and centripetal force

 

After changing variables the position vector of the particle got expressed in (15) as

 

`#mover(mi("r"),mo("&rarr;"))`(t) = z(t)*`#mover(mi("k"),mo("&and;"))`+`#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`(t)*rho(t)

 

A distinction needs to be made here, according to whether the unit vector `#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))` depends or not on the time t, the former being the general case. When `#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))` is a constant, the value of the coordinate phi - the angle between `#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))` and the x axis - does not change, there is no rotation around the z axis. On the other hand, when `&equiv;`(`#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`, `#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`(t)), the orientation of `#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))` and so the coordinate phi changes with time, so either the force `#mover(mi("F"),mo("&rarr;"))`(t)acting on the particle has a component in the `#mover(mi("&phi;",fontstyle = "normal"),mo("&and;"))` direction that produces rotation around the z axis, or the system of references - itself - is rotating around the z axis.

 

Likewise, the expression (15)  can represent the position vector measured in the original Galilean (inertial) system of references, where a force `#mover(mi("F"),mo("&rarr;"))`(t)is producing rotation around the z axis, or it can represent the position of the particle measured in a rotating, non-inertial system references. Hence the transformation (14) can also be interpreted in two different ways, as representing a choice of different functions (generalized coordinates) to represent the position of the particle in the original inertial system of references, or it can represent a transformation from an inertial to another rotating, non-inertial, system of references.

 

This equivalence between the trajectory of a particle subject to an external force, as observed in an inertial system of references, and the same trajectory observed from a non-inertial accelerated system of references where there is no external force, actually at the root of the formulation of general relativity, is also well known in classical mechanics. The (apparent) forces observed in the rotating non-inertial system of references, due only to its acceleration, are called Coriolis and centripetal forces.

 

To see that the equations

 

diff(rho(t), t, t) = (diff(phi(t), t))^2*rho(t), diff(phi(t), t, t) = -2*(diff(phi(t), t))*(diff(rho(t), t))/rho(t)

 

that appeared in (27) when in the inertial system of references `#mover(mi("F"),mo("&rarr;"))`(t) = m*(diff(`#mover(mi("r"),mo("&rarr;"))`(t), t, t)) and m*(diff(`#mover(mi("r"),mo("&rarr;"))`(t), t, t)) = 0, are related to the Coriolis and centripetal forces in the non-inertial referencial, following [1] introduce a vector `#mover(mi("&omega;",fontstyle = "normal"),mo("&rarr;"))`representing the rotation of that referencial around the z axis (when, in the inertial system of references, the non-inertial system rotates clockwise, in the non-inertial system phi increases in value in the anti-clockwise direction)

`#mover(mi("&omega;",fontstyle = "normal"),mo("&rarr;"))` = -(diff(phi(t), t))*`#mover(mi("k"),mo("&and;"))`

omega_ = -(diff(phi(t), t))*_k

(32)

According to [1], (39.7), the acceleration diff(`#mover(mi("r"),mo("&rarr;"))`(t), t, t)in the inertial system is expressed in terms of the quantities in the non-inertial rotating system by the sum of the following three vectorial terms.

First, the components of the acceleration `#mover(mi("a"),mo("&rarr;"))`(t)measured in the non-inertial system are given by the second derivatives of the coordinates (rho(t), phi(t), z(t)) multiplied by the scale factors, which in this case are given by (1, rho(t), 1) (see this post in Mapleprimes)

`#mover(mi("a"),mo("&rarr;"))`(t) = (diff(rho(t), t, t))*`#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`(t)+rho(t)*(diff(phi(t), t, t))*`#mover(mi("&phi;",fontstyle = "normal"),mo("&and;"))`(t)+(diff(z(t), t, t))*`#mover(mi("k"),mo("&and;"))`

a_(t) = (diff(diff(rho(t), t), t))*_rho(t)+rho(t)*(diff(diff(phi(t), t), t))*_phi(t)+(diff(diff(z(t), t), t))*_k

(33)

Second, the Coriolis force divided by the mass, by definition given by

2*`&x`(diff(r_(t), t) = (diff(z(t), t))*_k+(diff(rho(t), t))*_rho(t)+rho(t)*(diff(phi(t), t))*_phi(t), omega_ = -(diff(phi(t), t))*_k)

2*Physics:-Vectors:-`&x`(diff(r_(t), t), omega_) = -2*rho(t)*(diff(phi(t), t))^2*_rho(t)+2*(diff(rho(t), t))*(diff(phi(t), t))*_phi(t)

(34)

Third the centripetal force divided by the mass, defined by

`&x`(omega_ = -(diff(phi(t), t))*_k, `&x`(r_(t) = z(t)*_k+rho(t)*_rho(t), omega_ = -(diff(phi(t), t))*_k))

Physics:-Vectors:-`&x`(omega_, Physics:-Vectors:-`&x`(r_(t), omega_)) = rho(t)*(diff(phi(t), t))^2*_rho(t)

(35)

Adding these three terms,

(a_(t) = (diff(diff(rho(t), t), t))*_rho(t)+rho(t)*(diff(diff(phi(t), t), t))*_phi(t)+(diff(diff(z(t), t), t))*_k)+(2*Physics[Vectors][`&x`](diff(r_(t), t), omega_) = -2*rho(t)*(diff(phi(t), t))^2*_rho(t)+2*(diff(rho(t), t))*(diff(phi(t), t))*_phi(t))+(Physics[Vectors][`&x`](omega_, Physics[Vectors][`&x`](r_(t), omega_)) = rho(t)*(diff(phi(t), t))^2*_rho(t))

a_(t)+2*Physics:-Vectors:-`&x`(diff(r_(t), t), omega_)+Physics:-Vectors:-`&x`(omega_, Physics:-Vectors:-`&x`(r_(t), omega_)) = _rho(t)*(diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2)+_phi(t)*(2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k

(36)

So that

diff(`#mover(mi("r"),mo("&rarr;"))`(t), t, t) = lhs(a_(t)+2*Physics[Vectors][`&x`](diff(r_(t), t), omega_)+Physics[Vectors][`&x`](omega_, Physics[Vectors][`&x`](r_(t), omega_)) = _rho(t)*(diff(diff(rho(t), t), t)-(diff(phi(t), t))^2*rho(t))+_phi(t)*(2*(diff(phi(t), t))*(diff(rho(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k)

diff(diff(r_(t), t), t) = a_(t)+2*Physics:-Vectors:-`&x`(diff(r_(t), t), omega_)+Physics:-Vectors:-`&x`(omega_, Physics:-Vectors:-`&x`(r_(t), omega_))

(37)

and where the right-hand side of (36) is, actually, the result computed lines above in (18)

diff(diff(r_(t), t), t) = _rho(t)*(diff(diff(rho(t), t), t)-(diff(phi(t), t))^2*rho(t))+_phi(t)*(2*(diff(phi(t), t))*(diff(rho(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k

diff(diff(r_(t), t), t) = _rho(t)*(diff(diff(rho(t), t), t)-rho(t)*(diff(phi(t), t))^2)+_phi(t)*(2*(diff(rho(t), t))*(diff(phi(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k

(38)

rhs(a_(t)+2*Physics[Vectors][`&x`](diff(r_(t), t), omega_)+Physics[Vectors][`&x`](omega_, Physics[Vectors][`&x`](r_(t), omega_)) = _rho(t)*(diff(diff(rho(t), t), t)-(diff(phi(t), t))^2*rho(t))+_phi(t)*(2*(diff(phi(t), t))*(diff(rho(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k)-rhs(diff(diff(r_(t), t), t) = _rho(t)*(diff(diff(rho(t), t), t)-(diff(phi(t), t))^2*rho(t))+_phi(t)*(2*(diff(phi(t), t))*(diff(rho(t), t))+rho(t)*(diff(diff(phi(t), t), t)))+(diff(diff(z(t), t), t))*_k)

0

(39)

From (37), in the absence of external forces diff(`#mover(mi("r"),mo("&rarr;"))`(t), t, t) = 0 and so the acceleration `#mover(mi("a"),mo("&rarr;"))`(t) measured in the rotating system is given by the sum of the Coriolis and centripetal accelerations

isolate(rhs(diff(diff(r_(t), t), t) = a_(t)+2*Physics[Vectors][`&x`](diff(r_(t), t), omega_)+Physics[Vectors][`&x`](omega_, Physics[Vectors][`&x`](r_(t), omega_))), `#mover(mi("a"),mo("&rarr;"))`(t))

a_(t) = -2*Physics:-Vectors:-`&x`(diff(r_(t), t), omega_)-Physics:-Vectors:-`&x`(omega_, Physics:-Vectors:-`&x`(r_(t), omega_))

(40)

In other words: in the absence of external forces, the acceleration of a particle observed in a rotating (non-inertial) system of references is not zero.

 

Expressing this equation (40) in terms of (rho(t), phi(t), z(t)) we get

subs(a_(t) = (diff(diff(rho(t), t), t))*_rho(t)+rho(t)*(diff(diff(phi(t), t), t))*_phi(t)+(diff(diff(z(t), t), t))*_k, -(2*Physics[Vectors][`&x`](diff(r_(t), t), omega_) = -2*rho(t)*(diff(phi(t), t))^2*_rho(t)+2*(diff(rho(t), t))*(diff(phi(t), t))*_phi(t)), Physics[Vectors][`&x`](omega_, Physics[Vectors][`&x`](r_(t), omega_)) = rho(t)*(diff(phi(t), t))^2*_rho(t), a_(t) = -2*Physics[Vectors][`&x`](diff(r_(t), t), omega_)-Physics[Vectors][`&x`](omega_, Physics[Vectors][`&x`](r_(t), omega_)))

(diff(diff(rho(t), t), t))*_rho(t)+rho(t)*(diff(diff(phi(t), t), t))*_phi(t)+(diff(diff(z(t), t), t))*_k = rho(t)*(diff(phi(t), t))^2*_rho(t)-2*(diff(rho(t), t))*(diff(phi(t), t))*_phi(t)

(41)

resulting in the three equations

((diff(diff(rho(t), t), t))*_rho(t)+rho(t)*(diff(diff(phi(t), t), t))*_phi(t)+(diff(diff(z(t), t), t))*_k = rho(t)*(diff(phi(t), t))^2*_rho(t)-2*(diff(rho(t), t))*(diff(phi(t), t))*_phi(t)).`#mover(mi("&rho;",fontstyle = "normal"),mo("&and;"))`(t)

diff(diff(rho(t), t), t) = rho(t)*(diff(phi(t), t))^2

(42)

((diff(diff(rho(t), t), t))*_rho(t)+rho(t)*(diff(diff(phi(t), t), t))*_phi(t)+(diff(diff(z(t), t), t))*_k = rho(t)*(diff(phi(t), t))^2*_rho(t)-2*(diff(rho(t), t))*(diff(phi(t), t))*_phi(t)).`#mover(mi("&phi;",fontstyle = "normal"),mo("&and;"))`(t)

rho(t)*(diff(diff(phi(t), t), t)) = -2*(diff(rho(t), t))*(diff(phi(t), t))

(43)

((diff(diff(rho(t), t), t))*_rho(t)+rho(t)*(diff(diff(phi(t), t), t))*_phi(t)+(diff(diff(z(t), t), t))*_k = rho(t)*(diff(phi(t), t))^2*_rho(t)-2*(diff(rho(t), t))*(diff(phi(t), t))*_phi(t)).`#mover(mi("k"),mo("&and;"))`

diff(diff(z(t), t), t) = 0

(44)

which are the equations returned by Geodesics in (23)

[diff(diff(rho(t), t), t) = rho(t)*(diff(phi(t), t))^2, diff(diff(phi(t), t), t) = -2*(diff(rho(t), t))*(diff(phi(t), t))/rho(t), diff(diff(z(t), t), t) = 0]

[diff(diff(rho(t), t), t) = rho(t)*(diff(phi(t), t))^2, diff(diff(phi(t), t), t) = -2*(diff(rho(t), t))*(diff(phi(t), t))/rho(t), diff(diff(z(t), t), t) = 0]

(45)

``

References

[1] L.D. Landau, E.M. Lifchitz, Mechanics, Course of Theoretical Physics, Volume 1, third edition, Elsevier.


 

Download The_equations_of_motion_in_curvilinear_coordinates.mw

Edgardo S. Cheb-Terrab
Physics, Differential Equations and Mathematical Functions, Maplesoft

 

Research work

The fractal structure’s researching.

Modeling of the fractal sets in the Maple program.

Municipal Budget Educational Establishment “School # 57” of Kirov district of Kazan

    Author:  Ibragimova Evelina

    Scientific advisor:  Alsu Gibadullina - mathematics teacher

    Translator:  Aigul Gibadullina

In Russian

ИбрагимоваЭ_Фракталы.docx

In English

Fractals_researching.doc

 

     ( Images - in attached files )

Table of contents:

Introduction

I. Studying of principles of fractals construction

II. Applied meaning of fractals

III. Researching of computer programs of fractals construction

Conclusion

Introduction

We don’t usually think about main point of things, which we have to do with every day. Environmental systems are many-sided, ever–changing and compli­cated, but they are formed by a little number of rules. Fractals are apt example of this – they are complicated, but based on simple regulations. Self – similarity is the main attribute of them.  Just one fractal element contains genetically information about all system.  This information have a forming role for all system. But some­times self – similarity is partial.

Hypothesis of the research. Fractals and various elements of the Universe have general principles of structural organization. It is a reason why the theory of frac­tals is instrument for cognition of the world.

Purpose of the research. Studying  of genetic analogy  between fractals and alive and non-living Universe systems with computer-based mathematical mod­eling in the Mapel’s computer space.

Problems of the research. 

  1. studying of principles of fractal’s construction;
  2. Detection of  general fractal content of physical, biological and artificial sys­tems;
  3. Researching of applied meaning of fractals;
  4. Searching of computer programs which can generate all of known fractals;
  5. Researching of fractals witch was assigned by complex variables;
  6. Formation of innovative ideas of using of fractals in different spaces;

The object of research.  Fractal structures, nature and society objects.

The subject of research. Manifestation of fractality in different objects of the Universe.

Methods of the researching.

  1. Studying and analysis of literature of research’s problem;
  2. Searching of computer programs which can generate fractals and experimenta­tion with them;
  3. Comparative analysis of principles of generating of fractals and structural or­ganizations of physical, biological and artificial systems;
  4. Generation and formulation of innovation ways to applied significance of fractals.

Applied significance.

Researching of universality of fractals gives general academic way of cognition of nature and society.

 

I. Studying of principles of fractal construction

We can see fractal constructions everywhere – from crystals and different accu­mulations (clouds, rivers, mountains, stars etc.) to complex ecosystems and bio­logical objects like fern leafs or human brain. Actually, the idea that frac­tal principles are genetic code of our Universe has been discussed for about fifteen years. The first attempt of modeling of the process of the Universe construction was done by A.D. Linde. We also know that young Andrey Saharov had solved “fractal” calculation problem – it was already half a century ago.

Now therefore, fractal picture of the world was intuitively anticipated by human genius and it inevitably manifested in its activity.

Fractals are divided into four groups in the traditional way: geometric (constructive), algebraical (dynamical), stochastical and natural.

The first group of fractals is geometric. It is the most demonstrative type of fractals, because we can instantly observe the self-similarity in it. This type of fractals is constructed in the basis of original figure by her fragmentation and real­izing of different transformations. Geometrical fractals ensue on repeating of this procedure. They are using in computer-generated graphics for generating the pic­tures of leafs, bush, dimensional structures, etc.

The second large group of fractals -  algebraical. This fractals are constructed by iteration of nonlinear displays, which set by simple formulas. There are two types of algebraical fractals – linear and nonlinear. The first of them are determined by first order equates (linear equates), and the second by nonlinear equates, their na­ture significantly brighter, richer and more diverse than first order equates.

The third known group of fractals – stochastical. It is generated by method of random modification of options in iterative process. Therefore, we get an objects which is similar to nature fractals – asymmetrical trees, rugged coasts, mountain scenery etc. Such fractals are useful in modeling of land topography, sea–surface and electrolysis process etc.

The fourth group of fractals is nature, they are dominate in our life. The main difference of such fractals is that they can’t demonstrate infinite self-similarity. There is “physical fractals” term in the classification concept for nature fractals, this term notes their naturalness. These fractals are created with two simple opera­tions: copy and scaling. We can indefinitely list examples of nature fractals: hu­man’s circulatory system, crowns and leafs of trees, lungs, etc.  It is impossible to show all diversity of nature fractals.

 

II. Applied meaning of fractals

Fractals are having incredibly widespread application nowadays.

In the medicine. Human’s organism is consists from fractal structures: circulatory system, bronchus, muscle, neuron system, etc. So it’s naturally that fractal algorithms are useful in the medicine. For example, assessment of rhythm of fractal dimension while electric diagrams analyzing allows to make more infor­mative and accurate view on the beginning of specific illnesses. Also fractals are using for high–quality processing of  X–ray images (in the experimental way). There are designing of new methods in the gastroenterology which allows to ex­plore gastrointestinal tract organs qualitative and painlessly. Actually, there are discoveries of application of fractal methods for diagnosis and treatment of cancer.

In the science. There are no scientific and technical areas without fractal calcu­lations nowadays. It happens due to the fact that majority of nature objects have fractal structures and dimension: coasts of the continents; natural resources alloca­tion; magnetic field anomaly; dissemination of surges and vibrations in an elastic environments; porous, solid and fungal bodies; crystals; turbulence; dynamic of complicated systems in general, etc. Fractals are useful in geology, geophysics, in the oil sciences… It’s impossible to list all the spaces of adaptability.

Modeling of chaotic processes, particularly, in description of population models.

In telecommunications. It’s naturally that fractals are popular in this area too. Natan Coen is person, who had started to use fractal antennas. Fractal antenna has very compact form which provides high productivity. Due to this, such antennas are used in marine and air transport, in personal devises. The theory of fractal an­tennas has become an independent, well-developed apparatus of synthesis and analysis of electric small antenna (ESA) nowadays. There are developments of possibility of fractal compression of the traffic which is transmitted through the web. The goal of this is more effective transfer of information.

In the visual effects. The theory of fractals has penetrated area of formation of different kinds of visualizations and creation of special effects in the computer graphics soon. This theory are very useful in modeling of nature landscapes in computer games. The film industry also has not been without fractal geometry. All the special effects are based in fractal structure: mountain landscape, lava, flame, fog, large flows and the same. In the modern level of the cinema creation of the special effects is impossible without modeling of fractals.

In the economics. The Veirshtrass’s function is famous example of stochastic fractals. Analysis of graph of the function in interactive mathematic environment Maple allows to make sure in fractal structure of function by way of entry of dif­ferent ranges of graphic visualization. In any indefinitely small area of the part graph of the function absolutely looks like area of this part in the all . The property of function is used in analysis of stock markets.

In the architect. Notably, fractal structures have become useful in the architect more earlier than B. Mandelbrode had discovered them. S.B. Pomorov, Doctor of Architecture, Professor, member of Russian Architect Union, talks about applica­tion of fractal theory in the architect in his article. Let’s see on the part of this arti­cle:

“Fractal structures were found in configuration of African tribal villages, in an­cient Vavilon’s ziggurats, in iconic buildings of ancient India and China, in gothic temples of ancient Russia .

We can see the high fractal level in Malevich’s Architectons. But they were cre­ated long before emergence of the notion of fractals in the architect. People started to use fractal algorithms on the architect morphogenesis consciously after Mandel­brot’s publications. It was made possible to use fractal geometry for analyzing of architectural forms.

Fractals had become available to the majority of specialists due to the comput­erization.  They had been incredibly attractive for architectors, designers and town planners in aesthetic, philosophical and psychological way. Fractal theory was per­ceived on emotional, sensual level in the first phase. The constant repression lead­ing to loss of sensuality.

Application of fractal structures is effective on the microenvironment designing level: interior, household items and their elements. Fractal structures introduction allows creating a new surroundings for people with fractal properties on all levels. It corresponds to nesting spaces.

Fractal formations are not a panacea or a new era in the architect history. But it’s a new way to design architect forms which enriches the architectural theory and practice language. The understanding of na­ture fractal impacts on architectural view of urban environment. An attempt to de­velop the method of architectural designing which will base in an in-depth fractal forms is especially interesting. Will this method base only on mathematics? Will it be different methods and features symbiosis? The practice experiments and re­searches will show us. It’s safe to say that modern fractal approach can be useful not only for analysis, but also for harmonic order and nature’s chaos, architect which may be semantic dominant in nature and historic context.”

Computer systems. Fractal data compression is the most useful fractal applica­tion in the computer science. This kind of compression is based on the fact that it’s easy to describe the real world by fractal geometry. Nevertheless, pictures are compressed better than by other methods (like jpeg or gif). Another one advantage is that picture isn’t pixelateing while compressing. Often picture looks better after increase in fractal compressing.

Basic concept for fractal computer graphics is “Fractal triangle”. Also there are “Fractal figure”, “Fractal object”, “Fractal line”, “Fractal composition”, “Parent object” and “Heir object”. However, it should be noted that fractal computer graphics has recently received as a kind of computer graphics of 21th century.

 The opportunities of fractal computer graphics cannot be overemphasized. It allows creating abstract compositions where we can realize a lot of moves: hori­zontal and vertical, diagonal directions, symmetry and asymmetry etc. Only a few programmers from all over the world know about fractal graphics today.  To what can we compare fractal picture? For example, with complex structure of crystal or with snowflake, the elements of which line up in the one complex composition. This property of fractal object can be useful in ornament creating or designing of decorative composition. Algorithms of synthesis of fractal rates which allows to reproduce copy of any picture too close to the original are developed today.

 

III. Researching of computer programs of fractal construction

Strict algorithms of fractals are really good for programming. There are a lot of computer programs which introduce fractals nowadays. Computer mathematic systems are stand out from over programs, especially, Maple. Computer mathe­matics is mathematic modeling tool. So programming represents genetic structure of fractal in these systems and we can see precise submission of fractal structure in the picture while we enter a number of iterations . This is the reason why mathematic fractals should be studied with computer mathematics.  The last dis­covery in fractal geometry has been made possible by powerful, modern com­puters. Fractal property researching is almost completely based on computer cal­culations. It allows making computer experiments which reproduce processes and phenomenon which we can’t experiment in the real world with.

Our school has been worked with computer mathematics Maple package more than 10 years. So we have unique opportunity to experiment with mathematic fractals, thanks to that we can understand how initial values impact on outcome   (it is stochastic fractal). For example, we have understood the meaning of the fact that color is the fourth dimension: color changing leads to changing of physical char­acteristics. That is what astrophysics mean talking about “multicolored” of the Universe. While fractal constructing in interactive mathematic environment we re­ceived graphic models which was like A. D. Linde’s model of the Universe. Perhaps, it demonstrates that Universe has fractal structure.

 

Conclusion

Scientists and philosophers argue, can we talk about universality of fractals in recent years. There are two groups of two opposite positions. We agree with the fact that fractals are universal. Due to the fact that movement is inherent property of material also we always have fractals wherever we have movement.  

We are convinced that fractal is genetic property of the Universe, but it is not mean that all the Universe elements to the one fractal organization. In deployment process fractal structure is undergoing a lot of fluctuations (deviations) and a lot of points of bifurcation (branching) lead grate number of fractal development varie­ties.  

Therefore, we think that fractals are general academic method of real world re­searching. Fractals give the methodology of nature and community researching.

In transitional, chaotic period of society development social life become harder. Different social systems clash. Ancient values are exchanged for new values literally in all spaces. So it’s vitally important for science to develop behavior strategies which allow to avoid tragic mistakes. We think that fractals play important role in developing of such technologies. And – synergy is theory of evolving systems self- organization. But evolution happens on fractal principles, as we know now.

 

P.S.  Images - in attached files

 

This is still a work in progress, but might be of use to anybody interested in Maxwell's Equations :-)

Examining_Maxwells_Equations.mw

 

Since we are getting many questions on how to create Math apps to add to the Maple Cloud. I wanted to go over the different GUI aspects of how you go about creating a Math App in Maple. The following Document also includes some code examples that are used in the the Math App but doesn't go into them in detail. For more details on the type of coding you do in a Math App see the DocumentTools package help page.

Some of the graphical features of the Math app don't display on Maple Primes so I'd recommend downloading this worksheet from here: HowToMathApp.mw to follow along.


 

NULL

How to make a Math App (An example of using the Document Tools).

 

This Document will provide a beginners guide on one way to make a Math app in Maple.

It will contain some coding examples as well as where to find different options in the user interface.

Step 1 Insert a Table

 

 

• 

When making a Math App in Maple I often start with a table. You can enter a table by going to Insert > Table...

  

 

• 

I often make the table 1 x 2 to start with as this gives an area for input and an area for the output (such as plots).

NULL

 

Add a plot component to one of the cells of the table

 

 

• 

From the Components  Palette you can add a Plot Component . Add it to the table by clicking and dragging it over.

 

 

NULL

NULL

Add another table inside the other cell

 

 

• 

In the other cell of the table I'll add another table to organize my use of buttons, sliders, and other components.
NULL

NULL

Add some components to the new table

 

 

• 

From the Components Palette I'll add a slider, or dial, or something else for interaction.

 

• 

You may also want a Math region for an area to enter functions and a button to tell Maple to do something with it.

 

NULL

NULL

Arrange the Components to look nice

 

 

• 

You can change how the components are placed either by resizing the tables or changing the text orientation of the contents of the cells.

 

NULL

Write some code for the interaction of the buttons.

 

 

• 

Using the DocumentTools  package there are lots of ways you can use the components. I often will start writing my code using a code edit region  as it provides better visualization for syntax. On MaplePrimes these display as collapsed so I will also include code blocks for the code.

 

NULL

NULL

Let's write something that takes the value of the slider and applies it to the dial

 

 

• 

Note that the names of the components will change in each section as they are copies of the previous section.

 

with(DocumentTools):

14

with(DocumentTools):
sv:=GetProperty('Slider2',value);
SetProperty('Dial2',value,sv);
• 

This code will only execute when run using the  button. Change the value of the slider below then run the code above to see what happens.

 

NULL

NULL

Move the code 'inside' the slider

 

 

• 

Instead of putting the code inside the code edit region where it needs to be executed, we'll next add the code to the value changed code of the slider.

 

• 

Right click the Slider then select "Edit Value Changed Code".

 

 

• 

This will open the code editor for the Slider

 

 

• 

Enter your code (ensuring you're using the correct name for the slider and dial).

 

• 

Notice that you don't need to use the with(DocumentTools): command as "use DocumentTools in ... end use;" is already filled in for you.

 

• 

Save the code in the Slider and hit the  button inside it once.

• 

Now move the slider.

 

• 

On future uses of the App you won't need to hit  as the code will be run on startup.

``

NULL

NULL

Add some more details to your App

 

 

• 

Let's make this app do something a bit more interesting than change the contents of a dial when a slider moves.

 

• 

The plan in the next few steps is to make this app allow a user to explore parameters changing in a sinusoidal expression.

 

• 

I'm going to add a second Math Component, put the expression A*sin(t*theta+phi)into both then uncheck the box in the context panel that says "Editable".

 

• 

To make the Math containers fit nicely I'll check the Auto-fit container box and set the Minimum Width Pixels to 200.

 

``

Add code to change the value of phi in the second Math Container when the Slider changes

 

 

Note: Maple uses Radians for trigonometric functions so we should convert the value of phi to Radians.

use DocumentTools in

 

use DocumentTools in 
phi_s:=GetProperty(Slider5,value);
expr:= GetProperty(MathContainer6,expression);
new_expr:=algsubs(phi=phi_s*Pi/180,expr);

SetProperty(MathContainer7,expression,new_expr);
end use:

``

``

Make the Dial go from 0 to 360°

 

 

• 

Click the Dial and look at the options in the context panel on the right.

 

• 

Update the values in the Dial so that the highest position is 360 and the spacing makes sense for the app.

  NULL

``

Have the Dial update the theta value of the expression

 

 

• 

Add the following code to the Dial

 

use DocumentTools in
use DocumentTools in 
theta_d:=GetProperty(Dial7,value);
phi_s:=GetProperty(Slider7,value); #This is added so that phi also has the value updated

expr:= GetProperty(MathContainer10,expression);
new_expr0:=algsubs(theta=theta_d*Pi/180,expr);
new_expr:=algsubs(phi=phi_s*Pi/180,new_expr0);  #This is added so that phi also has the value updated

SetProperty(MathContainer11,expression,new_expr);
end use:

 

• 

Update the value in the slider to include the value from the dial

 

use DocumentTools in

 

use DocumentTools in 

theta_d:=GetProperty(Dial7,value); #This is added so that theta also has the value updated
phi_s:=GetProperty(Slider7,value); 

expr:= GetProperty(MathContainer10,expression);
new_expr0:=algsubs(theta=theta_d*Pi/180,expr); #This is added so that theta also has the value updated
new_expr:=algsubs(phi=phi_s*Pi/180,new_expr0);  

SetProperty(MathContainer11,expression,new_expr);

end use:

 

``

``

Notice that the code in the Dial and Slider are the same

 

 

• 

Since the code in the Dial and Slider are the same it makes sense to put the code into a procedure that can be called from multiple places.

 

Note: The changes in the code such as local and the single quotes are not needed but make the code easier to read and less likely to run into errors if edited in the future (for example if you create a variable called dial8 it won't interfere now that the names are in quotes).

 

 

UpdateMath:=proc() 

UpdateMath:=proc()
local theta_d, phi_s, expr, new_expr, new_expr0;
use DocumentTools in 
theta_d:=GetProperty('Dial8','value'); #Get value of theta from Dial
phi_s:=GetProperty('Slider8','value'); #Get value of phi from slider

expr:= GetProperty('MathContainer12','expression');
new_expr0:=algsubs('theta'=theta_d*Pi/180,expr);  # Put value of theta in expression
new_expr:=algsubs('phi'=phi_s*Pi/180,new_expr0);  # Put value of phi in expression
SetProperty('MathContainer13','expression',new_expr); # Update expression
end use:
end proc:

 

• 

Now change the code in the components to call the function using UpdateMath().

 

• 

Since the code above is only defined there it will need to be run once (but only once) before moving the components. Instead of leaving it here you can add it to the Startup code by clicking  or going to Edit > Startup code.  This code will run every time you open the Math App ensuring that it works right away.

 

• 

The startup code isn't defined in this document to allow progression of these steps.

 

``

Make the button initialize the app

 

 

• 

Since the startup code isn't defined in this document we are going to move this function into the button.

 

UpdateMath:=proc()

 

UpdateMath:=proc()
local theta_d, phi_s, expr, new_expr, new_expr0;
use DocumentTools in 
theta_d:=GetProperty('Dial9','value'); #Get value of theta from Dial
phi_s:=GetProperty('Slider9','value'); #Get value of phi from slider

expr:= GetProperty('MathContainer14','expression');
new_expr0:=algsubs('theta'=theta_d*Pi/180,expr);  # Put value of theta in expression
new_expr:=algsubs('phi'=phi_s*Pi/180,new_expr0);  # Put value of phi in expression
SetProperty('MathContainer15','expression',new_expr); # Update expression
end use:
end proc:
• 

First click the button to rename it, you'll see the  option in the context panel on the right. Then add the code above to the button in the same way as the Slider an Dial (Right click and select Edit Click Code).

 

``

``

Now it is easy to add new components

 

 

• 

Now if we want to add new components we just have to change the one procedure.  Let's add a Volume Gauge to change the value of A.

 

• 

Click in the cell containing the Dial, the context panel will show the option to Insert a row below the Dial.

• 

Now drag a Volume Gauge into the new cell.

 

• 

Click in the cell and choose the alignment (from the context panel) that looks best to you. In this case I chose center:

 

``

 

NULL

``

Update the procedure code for the Gauge

 

 

• 

Add two lines for the volume gauge to get the value and sub it into the expression

UpdateMath:=proc()

UpdateMath:=proc()
local theta_d, phi_s, expr, new_expr, new_expr0;
use DocumentTools in 
theta_d:=GetProperty('Dial11','value'); #Get value of theta from the Dial
phi_s:=GetProperty('Slider11','value'); #Get value of phi from the Slider
A_g:=GetProperty('VolumeGauge1','value'); #Get value of A from the Guage

expr:= GetProperty('MathContainer18','expression');
new_expr0:=algsubs('theta'=theta_d*Pi/180,expr);  # Put value of theta in expression
new_expr1:=algsubs('phi'=phi_s*Pi/180,new_expr0);  # Put value of phi in expression
new_expr:=algsubs('A'=A_g,new_expr1);  # Put value of A in expression

SetProperty('MathContainer19','expression',new_expr); # Update expression
end use:
end proc:
• 

Now add

UpdateMath();

  to the Gauge.

  ``

``

Plot the changing expression

 

 

• 

Make a procedure to get the value in the second Math Container and plot it

 

PlotMath:=proc()

PlotMath:=proc()
	local expr, p;
	use DocumentTools in 

	expr:=GetProperty('MathContainer21','expression'); 

	p:=plot(expr,'t'=-Pi/2..Pi/2,'view'=[-Pi/2..Pi/2,-100..100]):

	SetProperty('Plot14','value',p)
	end use:
end proc:
• 

Put this procedure in the Initialize button and the call to it in the components.

 

NULL

``

Tidy up the app

 

 

• 

Now that we have an interactive app let's tidy it up a bit.

 

• 

The first thing I'd recommend in your own app is moving the code from the initialize button to startup code. In this document we choose to use the button instead to preserve earlier versions.

 

• 

You can also remove the borders around the components by clicking in the table and selecting "Interior Borders" > "None" and "Exterior Borders" > "None" from the context panel.

NULL

``

``

Now you have a Math App

 

 

• 

You can upload your Math App to the Maple Cloud to share with others by going to "File" > "Save to Cloud".

 

• 

I'd recommend also including a description of what your app does. You can do this nicely using another table and Text mode.

 

 

 

``

``

NULL

HowToMathApp.mw


 

Something a while ago made me wonder if people were interpretting the results of flattening the covid19 curve wrong.  Log graphs are good way to display a wide range of data in a compact way, but if you can't interpret it properly then you might as well think apples are oranges.  There was something someone said not to long ago that I didn't believe.  That person was Dr. Fauci, an American physician and immunologist who served as the director of the National Institute of Allergy and Infectious Diseases since 1984.  On April 9, 2020 he said, on the final death toll of the U.S. for Coronavirus, and I quote "looks more like 60,000 than the 100,000 to 200,000" U.S. officials had previously estimated ...  Back then I thought he was wrong, and actually now, he is wrong.

 

Some people just don't understand log graphs and I believe a lot of people are misinterpretting them.  Take a linear graph increasing in time and put it on a log scale and you naturally get a "flattening" curve without even doing anything.  But let's see what Dr. Fauci was seeing, and how he and likely many others, are misinterpretting the graphs.

 

Taking data from Worldometers.info/coronavirus we gather the total deaths

``

USTotaldeathsdates := ["Feb 15", "Feb 16", "Feb 17", "Feb 18", "Feb 19", "Feb 20", "Feb 21", "Feb 22", "Feb 23", "Feb 24", "Feb 25", "Feb 26", "Feb 27", "Feb 28", "Feb 29", "Mar 01", "Mar 02", "Mar 03", "Mar 04", "Mar 05", "Mar 06", "Mar 07", "Mar 08", "Mar 09", "Mar 10", "Mar 11", "Mar 12", "Mar 13", "Mar 14", "Mar 15", "Mar 16", "Mar 17", "Mar 18", "Mar 19", "Mar 20", "Mar 21", "Mar 22", "Mar 23", "Mar 24", "Mar 25", "Mar 26", "Mar 27", "Mar 28", "Mar 29", "Mar 30", "Mar 31", "Apr 01", "Apr 02", "Apr 03", "Apr 04", "Apr 05", "Apr 06", "Apr 07", "Apr 08", "Apr 09", "Apr 10", "Apr 11", "Apr 12", "Apr 13", "Apr 14", "Apr 15", "Apr 16", "Apr 17", "Apr 18", "Apr 19", "Apr 20", "Apr 21", "Apr 22", "Apr 23", "Apr 24", "Apr 25", "Apr 26", "Apr 27", "Apr 28", "Apr 29", "Apr 30", "May 01"]:

USTotalDeaths := [0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 1, 6, 9, 11, 12, 15, 19, 22, 26, 30, 38, 41, 48, 58, 73, 95, 121, 171, 239, 309, 374, 509, 689, 957, 1260, 1614, 2110, 2754, 3251, 4066, 5151, 6394, 7576, 8839, 10384, 11793, 13298, 15526, 17691, 19802, 22038, 24062, 25789, 27515, 30081, 32712, 34905, 37448, 39331, 40901, 42853, 45536, 47894, 50234, 52191, 54256, 55412, 56795, 59265, 61655, 63856, 65753]:

``

We will graph the data from when there were more than 100 deaths and up until April 9th when he made his prediction.

ListTools:-Search("Apr 09", USTotaldeathsdates)

55

(1)

ListTools:-Search(121, USTotalDeaths)

32

(2)

with(plots):

a := plots:-listplot(USTotalDeaths[32 .. 55], axis[2] = [mode = log], tickmarks = [[seq(i-31 = USTotaldeathsdates[i], i = 32 .. 55)], [100 = "100", 1000 = "1K", 10000 = "10K", 100000 = "100K", 1000000 = "1M"]], view = [default, 100 .. 1000000], color = "#FF9900", thickness = 6, labels = ["", "Total Coronavirus Deaths"], labeldirections = [default, vertical])

PLOT(CURVES(Matrix(24, 2, {(1, 1) = 1.0, (1, 2) = 121.0, (2, 1) = 2.0, (2, 2) = 171.0, (3, 1) = 3.0, (3, 2) = 239.0, (4, 1) = 4.0, (4, 2) = 309.0, (5, 1) = 5.0, (5, 2) = 374.0, (6, 1) = 6.0, (6, 2) = 509.0, (7, 1) = 7.0, (7, 2) = 689.0, (8, 1) = 8.0, (8, 2) = 957.0, (9, 1) = 9.0, (9, 2) = 1260.0, (10, 1) = 10.0, (10, 2) = 1614.0, (11, 1) = 11.0, (11, 2) = 2110.0, (12, 1) = 12.0, (12, 2) = 2754.0, (13, 1) = 13.0, (13, 2) = 3251.0, (14, 1) = 14.0, (14, 2) = 4066.0, (15, 1) = 15.0, (15, 2) = 5151.0, (16, 1) = 16.0, (16, 2) = 6394.0, (17, 1) = 17.0, (17, 2) = 7576.0, (18, 1) = 18.0, (18, 2) = 8839.0, (19, 1) = 19.0, (19, 2) = 10384.0, (20, 1) = 20.0, (20, 2) = 11793.0, (21, 1) = 21.0, (21, 2) = 13298.0, (22, 1) = 22.0, (22, 2) = 15526.0, (23, 1) = 23.0, (23, 2) = 17691.0, (24, 1) = 24.0, (24, 2) = 19802.0}, datatype = float[8])), COLOUR(RGB, 1.00000000, .60000000, 0.), THICKNESS(6), _AXIS[2](_MODE(1)), AXESTICKS([1 = "Mar 17", 2 = "Mar 18", 3 = "Mar 19", 4 = "Mar 20", 5 = "Mar 21", 6 = "Mar 22", 7 = "Mar 23", 8 = "Mar 24", 9 = "Mar 25", 10 = "Mar 26", 11 = "Mar 27", 12 = "Mar 28", 13 = "Mar 29", 14 = "Mar 30", 15 = "Mar 31", 16 = "Apr 01", 17 = "Apr 02", 18 = "Apr 03", 19 = "Apr 04", 20 = "Apr 05", 21 = "Apr 06", 22 = "Apr 07", 23 = "Apr 08", 24 = "Apr 09"], [100 = "100", 1000 = "1K", 10000 = "10K", 100000 = "100K", 1000000 = "1M"]), AXESLABELS("", "Total Coronavirus Deaths", FONT(DEFAULT), DEFAULT, VERTICAL), VIEW(DEFAULT, 100 .. 1000000))

(3)

b := plot([1000, 10000, 100000, 1000000], x = 0 .. 30, color = "#E6E6E6", thickness = 0):

``

NULL

 

plots:-display(a, b, title = "Total Deaths \n (Logarithmic scale)\n", titlefont = ["Helvetica", 18], size = [681, 400])

 

Just by looking at the graph you  can imagine Dr. Fauci saying look at that graph starting to level off and he would extrapolate an imaginary line that could if you wanted to level off around where he said 60,000.  And that's the confusion people have with these log graphs - people misinterpret them.  

Here's what it looks like today

a2 := plots:-listplot(USTotalDeaths[32 .. ()], axis[2] = [mode = log], tickmarks = [[seq(i-31 = USTotaldeathsdates[i], i = 32 .. nops(USTotaldeathsdates))], [100 = "100", 1000 = "1K", 10000 = "10K", 100000 = "100K", 1000000 = "1M"]], view = [default, 100 .. 1000000], color = "#FF9900", thickness = 6, labels = ["", "Total Coronavirus Deaths"], labeldirections = [default, vertical])

PLOT(CURVES(Matrix(46, 2, {(1, 1) = 1.0, (1, 2) = 121.0, (2, 1) = 2.0, (2, 2) = 171.0, (3, 1) = 3.0, (3, 2) = 239.0, (4, 1) = 4.0, (4, 2) = 309.0, (5, 1) = 5.0, (5, 2) = 374.0, (6, 1) = 6.0, (6, 2) = 509.0, (7, 1) = 7.0, (7, 2) = 689.0, (8, 1) = 8.0, (8, 2) = 957.0, (9, 1) = 9.0, (9, 2) = 1260.0, (10, 1) = 10.0, (10, 2) = 1614.0, (11, 1) = 11.0, (11, 2) = 2110.0, (12, 1) = 12.0, (12, 2) = 2754.0, (13, 1) = 13.0, (13, 2) = 3251.0, (14, 1) = 14.0, (14, 2) = 4066.0, (15, 1) = 15.0, (15, 2) = 5151.0, (16, 1) = 16.0, (16, 2) = 6394.0, (17, 1) = 17.0, (17, 2) = 7576.0, (18, 1) = 18.0, (18, 2) = 8839.0, (19, 1) = 19.0, (19, 2) = 10384.0, (20, 1) = 20.0, (20, 2) = 11793.0, (21, 1) = 21.0, (21, 2) = 13298.0, (22, 1) = 22.0, (22, 2) = 15526.0, (23, 1) = 23.0, (23, 2) = 17691.0, (24, 1) = 24.0, (24, 2) = 19802.0, (25, 1) = 25.0, (25, 2) = 22038.0, (26, 1) = 26.0, (26, 2) = 24062.0, (27, 1) = 27.0, (27, 2) = 25789.0, (28, 1) = 28.0, (28, 2) = 27515.0, (29, 1) = 29.0, (29, 2) = 30081.0, (30, 1) = 30.0, (30, 2) = 32712.0, (31, 1) = 31.0, (31, 2) = 34905.0, (32, 1) = 32.0, (32, 2) = 37448.0, (33, 1) = 33.0, (33, 2) = 39331.0, (34, 1) = 34.0, (34, 2) = 40901.0, (35, 1) = 35.0, (35, 2) = 42853.0, (36, 1) = 36.0, (36, 2) = 45536.0, (37, 1) = 37.0, (37, 2) = 47894.0, (38, 1) = 38.0, (38, 2) = 50234.0, (39, 1) = 39.0, (39, 2) = 52191.0, (40, 1) = 40.0, (40, 2) = 54256.0, (41, 1) = 41.0, (41, 2) = 55412.0, (42, 1) = 42.0, (42, 2) = 56795.0, (43, 1) = 43.0, (43, 2) = 59265.0, (44, 1) = 44.0, (44, 2) = 61655.0, (45, 1) = 45.0, (45, 2) = 63856.0, (46, 1) = 46.0, (46, 2) = 65753.0}, datatype = float[8])), COLOUR(RGB, 1.00000000, .60000000, 0.), THICKNESS(6), _AXIS[2](_MODE(1)), AXESTICKS([1 = "Mar 17", 2 = "Mar 18", 3 = "Mar 19", 4 = "Mar 20", 5 = "Mar 21", 6 = "Mar 22", 7 = "Mar 23", 8 = "Mar 24", 9 = "Mar 25", 10 = "Mar 26", 11 = "Mar 27", 12 = "Mar 28", 13 = "Mar 29", 14 = "Mar 30", 15 = "Mar 31", 16 = "Apr 01", 17 = "Apr 02", 18 = "Apr 03", 19 = "Apr 04", 20 = "Apr 05", 21 = "Apr 06", 22 = "Apr 07", 23 = "Apr 08", 24 = "Apr 09", 25 = "Apr 10", 26 = "Apr 11", 27 = "Apr 12", 28 = "Apr 13", 29 = "Apr 14", 30 = "Apr 15", 31 = "Apr 16", 32 = "Apr 17", 33 = "Apr 18", 34 = "Apr 19", 35 = "Apr 20", 36 = "Apr 21", 37 = "Apr 22", 38 = "Apr 23", 39 = "Apr 24", 40 = "Apr 25", 41 = "Apr 26", 42 = "Apr 27", 43 = "Apr 28", 44 = "Apr 29", 45 = "Apr 30", 46 = "May 01"], [100 = "100", 1000 = "1K", 10000 = "10K", 100000 = "100K", 1000000 = "1M"]), AXESLABELS("", "Total Coronavirus Deaths", FONT(DEFAULT), DEFAULT, VERTICAL), VIEW(DEFAULT, 100 .. 1000000))

(4)

b2 := plot([1000, 10000, 100000, 1000000], x = 0 .. 60, color = "#E6E6E6", thickness = 0)

PLOT(CURVES(Matrix(200, 2, {(1, 1) = .0, (1, 2) = 1000.0, (2, 1) = .3154563015075377, (2, 2) = 1000.0, (3, 1) = .5899331427135678, (3, 2) = 1000.0, (4, 1) = .8986110572864321, (4, 2) = 1000.0, (5, 1) = 1.2093350894472361, (5, 2) = 1000.0, (6, 1) = 1.5185823045226128, (6, 2) = 1000.0, (7, 1) = 1.8052940592964821, (7, 2) = 1000.0, (8, 1) = 2.102167474371859, (8, 2) = 1000.0, (9, 1) = 2.409194384924623, (9, 2) = 1000.0, (10, 1) = 2.7152366562814065, (10, 2) = 1000.0, (11, 1) = 3.0300387497487438, (11, 2) = 1000.0, (12, 1) = 3.3073166050251253, (12, 2) = 1000.0, (13, 1) = 3.6194657969849247, (13, 2) = 1000.0, (14, 1) = 3.9328967035175877, (14, 2) = 1000.0, (15, 1) = 4.234945459296482, (15, 2) = 1000.0, (16, 1) = 4.509234666331658, (16, 2) = 1000.0, (17, 1) = 4.835391063316583, (17, 2) = 1000.0, (18, 1) = 5.111688313567838, (18, 2) = 1000.0, (19, 1) = 5.433087699497487, (19, 2) = 1000.0, (20, 1) = 5.717580615075376, (20, 2) = 1000.0, (21, 1) = 6.029714433165829, (21, 2) = 1000.0, (22, 1) = 6.32693964120603, (22, 2) = 1000.0, (23, 1) = 6.63706296482412, (23, 2) = 1000.0, (24, 1) = 6.9218529859296485, (24, 2) = 1000.0, (25, 1) = 7.229037497487436, (25, 2) = 1000.0, (26, 1) = 7.548115872361809, (26, 2) = 1000.0, (27, 1) = 7.825874535678391, (27, 2) = 1000.0, (28, 1) = 8.125861501507536, (28, 2) = 1000.0, (29, 1) = 8.435777390954772, (29, 2) = 1000.0, (30, 1) = 8.738969626130652, (30, 2) = 1000.0, (31, 1) = 9.032323703517587, (31, 2) = 1000.0, (32, 1) = 9.358043390954773, (32, 2) = 1000.0, (33, 1) = 9.650717017085425, (33, 2) = 1000.0, (34, 1) = 9.963208582914572, (34, 2) = 1000.0, (35, 1) = 10.246372386934672, (35, 2) = 1000.0, (36, 1) = 10.555945218090452, (36, 2) = 1000.0, (37, 1) = 10.847229126633163, (37, 2) = 1000.0, (38, 1) = 11.151704740703517, (38, 2) = 1000.0, (39, 1) = 11.449385306532662, (39, 2) = 1000.0, (40, 1) = 11.761029271356783, (40, 2) = 1000.0, (41, 1) = 12.06117944924623, (41, 2) = 1000.0, (42, 1) = 12.368126357788944, (42, 2) = 1000.0, (43, 1) = 12.672531590954774, (43, 2) = 1000.0, (44, 1) = 12.952248385929648, (44, 2) = 1000.0, (45, 1) = 13.272835398994975, (45, 2) = 1000.0, (46, 1) = 13.55957224522613, (46, 2) = 1000.0, (47, 1) = 13.865293528643216, (47, 2) = 1000.0, (48, 1) = 14.157907806030149, (48, 2) = 1000.0, (49, 1) = 14.482818355778894, (49, 2) = 1000.0, (50, 1) = 14.76416701809045, (50, 2) = 1000.0, (51, 1) = 15.083500266331658, (51, 2) = 1000.0, (52, 1) = 15.374537855276381, (52, 2) = 1000.0, (53, 1) = 15.69288723919598, (53, 2) = 1000.0, (54, 1) = 15.967568918592962, (54, 2) = 1000.0, (55, 1) = 16.28039928844221, (55, 2) = 1000.0, (56, 1) = 16.582577981909548, (56, 2) = 1000.0, (57, 1) = 16.88455926934673, (57, 2) = 1000.0, (58, 1) = 17.18542962211055, (58, 2) = 1000.0, (59, 1) = 17.474471840201005, (59, 2) = 1000.0, (60, 1) = 17.786934132663315, (60, 2) = 1000.0, (61, 1) = 18.084733353768844, (61, 2) = 1000.0, (62, 1) = 18.398153011055275, (62, 2) = 1000.0, (63, 1) = 18.681873274371856, (63, 2) = 1000.0, (64, 1) = 18.995437278391957, (64, 2) = 1000.0, (65, 1) = 19.295776953768843, (65, 2) = 1000.0, (66, 1) = 19.595385593969848, (66, 2) = 1000.0, (67, 1) = 19.908327979899497, (67, 2) = 1000.0, (68, 1) = 20.19655934170854, (68, 2) = 1000.0, (69, 1) = 20.491747682412058, (69, 2) = 1000.0, (70, 1) = 20.817670685427135, (70, 2) = 1000.0, (71, 1) = 21.112767268341706, (71, 2) = 1000.0, (72, 1) = 21.414558798994975, (72, 2) = 1000.0, (73, 1) = 21.7214730120603, (73, 2) = 1000.0, (74, 1) = 22.003586897487438, (74, 2) = 1000.0, (75, 1) = 22.304311163819094, (75, 2) = 1000.0, (76, 1) = 22.602746297487435, (76, 2) = 1000.0, (77, 1) = 22.92197912562814, (77, 2) = 1000.0, (78, 1) = 23.20368826733668, (78, 2) = 1000.0, (79, 1) = 23.528722136683413, (79, 2) = 1000.0, (80, 1) = 23.822040144723616, (80, 2) = 1000.0, (81, 1) = 24.112262981909545, (81, 2) = 1000.0, (82, 1) = 24.42434576683417, (82, 2) = 1000.0, (83, 1) = 24.73769099095477, (83, 2) = 1000.0, (84, 1) = 25.022788748743714, (84, 2) = 1000.0, (85, 1) = 25.325549903517587, (85, 2) = 1000.0, (86, 1) = 25.6210152, (86, 2) = 1000.0, (87, 1) = 25.94130269849246, (87, 2) = 1000.0, (88, 1) = 26.21844043417085, (88, 2) = 1000.0, (89, 1) = 26.536743198994973, (89, 2) = 1000.0, (90, 1) = 26.835964531658288, (90, 2) = 1000.0, (91, 1) = 27.13229571256281, (91, 2) = 1000.0, (92, 1) = 27.428862627135675, (92, 2) = 1000.0, (93, 1) = 27.73134210753769, (93, 2) = 1000.0, (94, 1) = 28.05196528944723, (94, 2) = 1000.0, (95, 1) = 28.345945350753766, (95, 2) = 1000.0, (96, 1) = 28.636141420100497, (96, 2) = 1000.0, (97, 1) = 28.946356242211053, (97, 2) = 1000.0, (98, 1) = 29.255895753768844, (98, 2) = 1000.0, (99, 1) = 29.53372584723618, (99, 2) = 1000.0, (100, 1) = 29.862835628140704, (100, 2) = 1000.0, (101, 1) = 30.138219431155775, (101, 2) = 1000.0, (102, 1) = 30.46031172060301, (102, 2) = 1000.0, (103, 1) = 30.767717608040197, (103, 2) = 1000.0, (104, 1) = 31.042194449246228, (104, 2) = 1000.0, (105, 1) = 31.350872363819093, (105, 2) = 1000.0, (106, 1) = 31.661596395979895, (106, 2) = 1000.0, (107, 1) = 31.970843611055276, (107, 2) = 1000.0, (108, 1) = 32.25755536582914, (108, 2) = 1000.0, (109, 1) = 32.55442878090452, (109, 2) = 1000.0, (110, 1) = 32.86145569145728, (110, 2) = 1000.0, (111, 1) = 33.16749796281407, (111, 2) = 1000.0, (112, 1) = 33.4823000562814, (112, 2) = 1000.0, (113, 1) = 33.759577911557784, (113, 2) = 1000.0, (114, 1) = 34.07172710351758, (114, 2) = 1000.0, (115, 1) = 34.38515801005025, (115, 2) = 1000.0, (116, 1) = 34.687206765829146, (116, 2) = 1000.0, (117, 1) = 34.96149597286432, (117, 2) = 1000.0, (118, 1) = 35.28765236984924, (118, 2) = 1000.0, (119, 1) = 35.563949620100495, (119, 2) = 1000.0, (120, 1) = 35.88534900603015, (120, 2) = 1000.0, (121, 1) = 36.16984192160804, (121, 2) = 1000.0, (122, 1) = 36.48197573969849, (122, 2) = 1000.0, (123, 1) = 36.77920094773869, (123, 2) = 1000.0, (124, 1) = 37.08932427135678, (124, 2) = 1000.0, (125, 1) = 37.37411429246231, (125, 2) = 1000.0, (126, 1) = 37.6812988040201, (126, 2) = 1000.0, (127, 1) = 38.00037717889447, (127, 2) = 1000.0, (128, 1) = 38.27813584221106, (128, 2) = 1000.0, (129, 1) = 38.5781228080402, (129, 2) = 1000.0, (130, 1) = 38.88803869748743, (130, 2) = 1000.0, (131, 1) = 39.191230932663316, (131, 2) = 1000.0, (132, 1) = 39.484585010050246, (132, 2) = 1000.0, (133, 1) = 39.81030469748743, (133, 2) = 1000.0, (134, 1) = 40.10297832361809, (134, 2) = 1000.0, (135, 1) = 40.41546988944723, (135, 2) = 1000.0, (136, 1) = 40.69863369346733, (136, 2) = 1000.0, (137, 1) = 41.008206524623105, (137, 2) = 1000.0, (138, 1) = 41.29949043316583, (138, 2) = 1000.0, (139, 1) = 41.60396604723618, (139, 2) = 1000.0, (140, 1) = 41.90164661306532, (140, 2) = 1000.0, (141, 1) = 42.213290577889445, (141, 2) = 1000.0, (142, 1) = 42.51344075577889, (142, 2) = 1000.0, (143, 1) = 42.8203876643216, (143, 2) = 1000.0, (144, 1) = 43.12479289748743, (144, 2) = 1000.0, (145, 1) = 43.404509692462305, (145, 2) = 1000.0, (146, 1) = 43.72509670552763, (146, 2) = 1000.0, (147, 1) = 44.01183355175879, (147, 2) = 1000.0, (148, 1) = 44.31755483517587, (148, 2) = 1000.0, (149, 1) = 44.610169112562815, (149, 2) = 1000.0, (150, 1) = 44.93507966231155, (150, 2) = 1000.0, (151, 1) = 45.21642832462311, (151, 2) = 1000.0, (152, 1) = 45.53576157286432, (152, 2) = 1000.0, (153, 1) = 45.826799161809035, (153, 2) = 1000.0, (154, 1) = 46.14514854572864, (154, 2) = 1000.0, (155, 1) = 46.41983022512562, (155, 2) = 1000.0, (156, 1) = 46.73266059497487, (156, 2) = 1000.0, (157, 1) = 47.03483928844221, (157, 2) = 1000.0, (158, 1) = 47.33682057587939, (158, 2) = 1000.0, (159, 1) = 47.63769092864321, (159, 2) = 1000.0, (160, 1) = 47.92673314673367, (160, 2) = 1000.0, (161, 1) = 48.23919543919598, (161, 2) = 1000.0, (162, 1) = 48.5369946603015, (162, 2) = 1000.0, (163, 1) = 48.85041431758794, (163, 2) = 1000.0, (164, 1) = 49.134134580904515, (164, 2) = 1000.0, (165, 1) = 49.447698584924616, (165, 2) = 1000.0, (166, 1) = 49.748038260301506, (166, 2) = 1000.0, (167, 1) = 50.047646900502514, (167, 2) = 1000.0, (168, 1) = 50.36058928643215, (168, 2) = 1000.0, (169, 1) = 50.6488206482412, (169, 2) = 1000.0, (170, 1) = 50.94400898894472, (170, 2) = 1000.0, (171, 1) = 51.26993199195979, (171, 2) = 1000.0, (172, 1) = 51.56502857487437, (172, 2) = 1000.0, (173, 1) = 51.86682010552764, (173, 2) = 1000.0, (174, 1) = 52.17373431859296, (174, 2) = 1000.0, (175, 1) = 52.4558482040201, (175, 2) = 1000.0, (176, 1) = 52.756572470351756, (176, 2) = 1000.0, (177, 1) = 53.0550076040201, (177, 2) = 1000.0, (178, 1) = 53.374240432160796, (178, 2) = 1000.0, (179, 1) = 53.65594957386934, (179, 2) = 1000.0, (180, 1) = 53.980983443216076, (180, 2) = 1000.0, (181, 1) = 54.27430145125628, (181, 2) = 1000.0, (182, 1) = 54.56452428844221, (182, 2) = 1000.0, (183, 1) = 54.876607073366834, (183, 2) = 1000.0, (184, 1) = 55.18995229748743, (184, 2) = 1000.0, (185, 1) = 55.47505005527638, (185, 2) = 1000.0, (186, 1) = 55.777811210050245, (186, 2) = 1000.0, (187, 1) = 56.07327650653266, (187, 2) = 1000.0, (188, 1) = 56.39356400502512, (188, 2) = 1000.0, (189, 1) = 56.67070174070351, (189, 2) = 1000.0, (190, 1) = 56.98900450552763, (190, 2) = 1000.0, (191, 1) = 57.288225838190954, (191, 2) = 1000.0, (192, 1) = 57.58455701909548, (192, 2) = 1000.0, (193, 1) = 57.881123933668334, (193, 2) = 1000.0, (194, 1) = 58.18360341407034, (194, 2) = 1000.0, (195, 1) = 58.504226595979894, (195, 2) = 1000.0, (196, 1) = 58.79820665728643, (196, 2) = 1000.0, (197, 1) = 59.08840272663316, (197, 2) = 1000.0, (198, 1) = 59.398617548743715, (198, 2) = 1000.0, (199, 1) = 59.708157060301495, (199, 2) = 1000.0, (200, 1) = 60.0, (200, 2) = 1000.0}, datatype = float[8])), CURVES(Matrix(200, 2, {(1, 1) = .0, (1, 2) = 10000.0, (2, 1) = .3154563015075377, (2, 2) = 10000.0, (3, 1) = .5899331427135678, (3, 2) = 10000.0, (4, 1) = .8986110572864321, (4, 2) = 10000.0, (5, 1) = 1.2093350894472361, (5, 2) = 10000.0, (6, 1) = 1.5185823045226128, (6, 2) = 10000.0, (7, 1) = 1.8052940592964821, (7, 2) = 10000.0, (8, 1) = 2.102167474371859, (8, 2) = 10000.0, (9, 1) = 2.409194384924623, (9, 2) = 10000.0, (10, 1) = 2.7152366562814065, (10, 2) = 10000.0, (11, 1) = 3.0300387497487438, (11, 2) = 10000.0, (12, 1) = 3.3073166050251253, (12, 2) = 10000.0, (13, 1) = 3.6194657969849247, (13, 2) = 10000.0, (14, 1) = 3.9328967035175877, (14, 2) = 10000.0, (15, 1) = 4.234945459296482, (15, 2) = 10000.0, (16, 1) = 4.509234666331658, (16, 2) = 10000.0, (17, 1) = 4.835391063316583, (17, 2) = 10000.0, (18, 1) = 5.111688313567838, (18, 2) = 10000.0, (19, 1) = 5.433087699497487, (19, 2) = 10000.0, (20, 1) = 5.717580615075376, (20, 2) = 10000.0, (21, 1) = 6.029714433165829, (21, 2) = 10000.0, (22, 1) = 6.32693964120603, (22, 2) = 10000.0, (23, 1) = 6.63706296482412, (23, 2) = 10000.0, (24, 1) = 6.9218529859296485, (24, 2) = 10000.0, (25, 1) = 7.229037497487436, (25, 2) = 10000.0, (26, 1) = 7.548115872361809, (26, 2) = 10000.0, (27, 1) = 7.825874535678391, (27, 2) = 10000.0, (28, 1) = 8.125861501507536, (28, 2) = 10000.0, (29, 1) = 8.435777390954772, (29, 2) = 10000.0, (30, 1) = 8.738969626130652, (30, 2) = 10000.0, (31, 1) = 9.032323703517587, (31, 2) = 10000.0, (32, 1) = 9.358043390954773, (32, 2) = 10000.0, (33, 1) = 9.650717017085425, (33, 2) = 10000.0, (34, 1) = 9.963208582914572, (34, 2) = 10000.0, (35, 1) = 10.246372386934672, (35, 2) = 10000.0, (36, 1) = 10.555945218090452, (36, 2) = 10000.0, (37, 1) = 10.847229126633163, (37, 2) = 10000.0, (38, 1) = 11.151704740703517, (38, 2) = 10000.0, (39, 1) = 11.449385306532662, (39, 2) = 10000.0, (40, 1) = 11.761029271356783, (40, 2) = 10000.0, (41, 1) = 12.06117944924623, (41, 2) = 10000.0, (42, 1) = 12.368126357788944, (42, 2) = 10000.0, (43, 1) = 12.672531590954774, (43, 2) = 10000.0, (44, 1) = 12.952248385929648, (44, 2) = 10000.0, (45, 1) = 13.272835398994975, (45, 2) = 10000.0, (46, 1) = 13.55957224522613, (46, 2) = 10000.0, (47, 1) = 13.865293528643216, (47, 2) = 10000.0, (48, 1) = 14.157907806030149, (48, 2) = 10000.0, (49, 1) = 14.482818355778894, (49, 2) = 10000.0, (50, 1) = 14.76416701809045, (50, 2) = 10000.0, (51, 1) = 15.083500266331658, (51, 2) = 10000.0, (52, 1) = 15.374537855276381, (52, 2) = 10000.0, (53, 1) = 15.69288723919598, (53, 2) = 10000.0, (54, 1) = 15.967568918592962, (54, 2) = 10000.0, (55, 1) = 16.28039928844221, (55, 2) = 10000.0, (56, 1) = 16.582577981909548, (56, 2) = 10000.0, (57, 1) = 16.88455926934673, (57, 2) = 10000.0, (58, 1) = 17.18542962211055, (58, 2) = 10000.0, (59, 1) = 17.474471840201005, (59, 2) = 10000.0, (60, 1) = 17.786934132663315, (60, 2) = 10000.0, (61, 1) = 18.084733353768844, (61, 2) = 10000.0, (62, 1) = 18.398153011055275, (62, 2) = 10000.0, (63, 1) = 18.681873274371856, (63, 2) = 10000.0, (64, 1) = 18.995437278391957, (64, 2) = 10000.0, (65, 1) = 19.295776953768843, (65, 2) = 10000.0, (66, 1) = 19.595385593969848, (66, 2) = 10000.0, (67, 1) = 19.908327979899497, (67, 2) = 10000.0, (68, 1) = 20.19655934170854, (68, 2) = 10000.0, (69, 1) = 20.491747682412058, (69, 2) = 10000.0, (70, 1) = 20.817670685427135, (70, 2) = 10000.0, (71, 1) = 21.112767268341706, (71, 2) = 10000.0, (72, 1) = 21.414558798994975, (72, 2) = 10000.0, (73, 1) = 21.7214730120603, (73, 2) = 10000.0, (74, 1) = 22.003586897487438, (74, 2) = 10000.0, (75, 1) = 22.304311163819094, (75, 2) = 10000.0, (76, 1) = 22.602746297487435, (76, 2) = 10000.0, (77, 1) = 22.92197912562814, (77, 2) = 10000.0, (78, 1) = 23.20368826733668, (78, 2) = 10000.0, (79, 1) = 23.528722136683413, (79, 2) = 10000.0, (80, 1) = 23.822040144723616, (80, 2) = 10000.0, (81, 1) = 24.112262981909545, (81, 2) = 10000.0, (82, 1) = 24.42434576683417, (82, 2) = 10000.0, (83, 1) = 24.73769099095477, (83, 2) = 10000.0, (84, 1) = 25.022788748743714, (84, 2) = 10000.0, (85, 1) = 25.325549903517587, (85, 2) = 10000.0, (86, 1) = 25.6210152, (86, 2) = 10000.0, (87, 1) = 25.94130269849246, (87, 2) = 10000.0, (88, 1) = 26.21844043417085, (88, 2) = 10000.0, (89, 1) = 26.536743198994973, (89, 2) = 10000.0, (90, 1) = 26.835964531658288, (90, 2) = 10000.0, (91, 1) = 27.13229571256281, (91, 2) = 10000.0, (92, 1) = 27.428862627135675, (92, 2) = 10000.0, (93, 1) = 27.73134210753769, (93, 2) = 10000.0, (94, 1) = 28.05196528944723, (94, 2) = 10000.0, (95, 1) = 28.345945350753766, (95, 2) = 10000.0, (96, 1) = 28.636141420100497, (96, 2) = 10000.0, (97, 1) = 28.946356242211053, (97, 2) = 10000.0, (98, 1) = 29.255895753768844, (98, 2) = 10000.0, (99, 1) = 29.53372584723618, (99, 2) = 10000.0, (100, 1) = 29.862835628140704, (100, 2) = 10000.0, (101, 1) = 30.138219431155775, (101, 2) = 10000.0, (102, 1) = 30.46031172060301, (102, 2) = 10000.0, (103, 1) = 30.767717608040197, (103, 2) = 10000.0, (104, 1) = 31.042194449246228, (104, 2) = 10000.0, (105, 1) = 31.350872363819093, (105, 2) = 10000.0, (106, 1) = 31.661596395979895, (106, 2) = 10000.0, (107, 1) = 31.970843611055276, (107, 2) = 10000.0, (108, 1) = 32.25755536582914, (108, 2) = 10000.0, (109, 1) = 32.55442878090452, (109, 2) = 10000.0, (110, 1) = 32.86145569145728, (110, 2) = 10000.0, (111, 1) = 33.16749796281407, (111, 2) = 10000.0, (112, 1) = 33.4823000562814, (112, 2) = 10000.0, (113, 1) = 33.759577911557784, (113, 2) = 10000.0, (114, 1) = 34.07172710351758, (114, 2) = 10000.0, (115, 1) = 34.38515801005025, (115, 2) = 10000.0, (116, 1) = 34.687206765829146, (116, 2) = 10000.0, (117, 1) = 34.96149597286432, (117, 2) = 10000.0, (118, 1) = 35.28765236984924, (118, 2) = 10000.0, (119, 1) = 35.563949620100495, (119, 2) = 10000.0, (120, 1) = 35.88534900603015, (120, 2) = 10000.0, (121, 1) = 36.16984192160804, (121, 2) = 10000.0, (122, 1) = 36.48197573969849, (122, 2) = 10000.0, (123, 1) = 36.77920094773869, (123, 2) = 10000.0, (124, 1) = 37.08932427135678, (124, 2) = 10000.0, (125, 1) = 37.37411429246231, (125, 2) = 10000.0, (126, 1) = 37.6812988040201, (126, 2) = 10000.0, (127, 1) = 38.00037717889447, (127, 2) = 10000.0, (128, 1) = 38.27813584221106, (128, 2) = 10000.0, (129, 1) = 38.5781228080402, (129, 2) = 10000.0, (130, 1) = 38.88803869748743, (130, 2) = 10000.0, (131, 1) = 39.191230932663316, (131, 2) = 10000.0, (132, 1) = 39.484585010050246, (132, 2) = 10000.0, (133, 1) = 39.81030469748743, (133, 2) = 10000.0, (134, 1) = 40.10297832361809, (134, 2) = 10000.0, (135, 1) = 40.41546988944723, (135, 2) = 10000.0, (136, 1) = 40.69863369346733, (136, 2) = 10000.0, (137, 1) = 41.008206524623105, (137, 2) = 10000.0, (138, 1) = 41.29949043316583, (138, 2) = 10000.0, (139, 1) = 41.60396604723618, (139, 2) = 10000.0, (140, 1) = 41.90164661306532, (140, 2) = 10000.0, (141, 1) = 42.213290577889445, (141, 2) = 10000.0, (142, 1) = 42.51344075577889, (142, 2) = 10000.0, (143, 1) = 42.8203876643216, (143, 2) = 10000.0, (144, 1) = 43.12479289748743, (144, 2) = 10000.0, (145, 1) = 43.404509692462305, (145, 2) = 10000.0, (146, 1) = 43.72509670552763, (146, 2) = 10000.0, (147, 1) = 44.01183355175879, (147, 2) = 10000.0, (148, 1) = 44.31755483517587, (148, 2) = 10000.0, (149, 1) = 44.610169112562815, (149, 2) = 10000.0, (150, 1) = 44.93507966231155, (150, 2) = 10000.0, (151, 1) = 45.21642832462311, (151, 2) = 10000.0, (152, 1) = 45.53576157286432, (152, 2) = 10000.0, (153, 1) = 45.826799161809035, (153, 2) = 10000.0, (154, 1) = 46.14514854572864, (154, 2) = 10000.0, (155, 1) = 46.41983022512562, (155, 2) = 10000.0, (156, 1) = 46.73266059497487, (156, 2) = 10000.0, (157, 1) = 47.03483928844221, (157, 2) = 10000.0, (158, 1) = 47.33682057587939, (158, 2) = 10000.0, (159, 1) = 47.63769092864321, (159, 2) = 10000.0, (160, 1) = 47.92673314673367, (160, 2) = 10000.0, (161, 1) = 48.23919543919598, (161, 2) = 10000.0, (162, 1) = 48.5369946603015, (162, 2) = 10000.0, (163, 1) = 48.85041431758794, (163, 2) = 10000.0, (164, 1) = 49.134134580904515, (164, 2) = 10000.0, (165, 1) = 49.447698584924616, (165, 2) = 10000.0, (166, 1) = 49.748038260301506, (166, 2) = 10000.0, (167, 1) = 50.047646900502514, (167, 2) = 10000.0, (168, 1) = 50.36058928643215, (168, 2) = 10000.0, (169, 1) = 50.6488206482412, (169, 2) = 10000.0, (170, 1) = 50.94400898894472, (170, 2) = 10000.0, (171, 1) = 51.26993199195979, (171, 2) = 10000.0, (172, 1) = 51.56502857487437, (172, 2) = 10000.0, (173, 1) = 51.86682010552764, (173, 2) = 10000.0, (174, 1) = 52.17373431859296, (174, 2) = 10000.0, (175, 1) = 52.4558482040201, (175, 2) = 10000.0, (176, 1) = 52.756572470351756, (176, 2) = 10000.0, (177, 1) = 53.0550076040201, (177, 2) = 10000.0, (178, 1) = 53.374240432160796, (178, 2) = 10000.0, (179, 1) = 53.65594957386934, (179, 2) = 10000.0, (180, 1) = 53.980983443216076, (180, 2) = 10000.0, (181, 1) = 54.27430145125628, (181, 2) = 10000.0, (182, 1) = 54.56452428844221, (182, 2) = 10000.0, (183, 1) = 54.876607073366834, (183, 2) = 10000.0, (184, 1) = 55.18995229748743, (184, 2) = 10000.0, (185, 1) = 55.47505005527638, (185, 2) = 10000.0, (186, 1) = 55.777811210050245, (186, 2) = 10000.0, (187, 1) = 56.07327650653266, (187, 2) = 10000.0, (188, 1) = 56.39356400502512, (188, 2) = 10000.0, (189, 1) = 56.67070174070351, (189, 2) = 10000.0, (190, 1) = 56.98900450552763, (190, 2) = 10000.0, (191, 1) = 57.288225838190954, (191, 2) = 10000.0, (192, 1) = 57.58455701909548, (192, 2) = 10000.0, (193, 1) = 57.881123933668334, (193, 2) = 10000.0, (194, 1) = 58.18360341407034, (194, 2) = 10000.0, (195, 1) = 58.504226595979894, (195, 2) = 10000.0, (196, 1) = 58.79820665728643, (196, 2) = 10000.0, (197, 1) = 59.08840272663316, (197, 2) = 10000.0, (198, 1) = 59.398617548743715, (198, 2) = 10000.0, (199, 1) = 59.708157060301495, (199, 2) = 10000.0, (200, 1) = 60.0, (200, 2) = 10000.0}, datatype = float[8])), CURVES(Matrix(200, 2, {(1, 1) = .0, (1, 2) = 100000.0, (2, 1) = .3154563015075377, (2, 2) = 100000.0, (3, 1) = .5899331427135678, (3, 2) = 100000.0, (4, 1) = .8986110572864321, (4, 2) = 100000.0, (5, 1) = 1.2093350894472361, (5, 2) = 100000.0, (6, 1) = 1.5185823045226128, (6, 2) = 100000.0, (7, 1) = 1.8052940592964821, (7, 2) = 100000.0, (8, 1) = 2.102167474371859, (8, 2) = 100000.0, (9, 1) = 2.409194384924623, (9, 2) = 100000.0, (10, 1) = 2.7152366562814065, (10, 2) = 100000.0, (11, 1) = 3.0300387497487438, (11, 2) = 100000.0, (12, 1) = 3.3073166050251253, (12, 2) = 100000.0, (13, 1) = 3.6194657969849247, (13, 2) = 100000.0, (14, 1) = 3.9328967035175877, (14, 2) = 100000.0, (15, 1) = 4.234945459296482, (15, 2) = 100000.0, (16, 1) = 4.509234666331658, (16, 2) = 100000.0, (17, 1) = 4.835391063316583, (17, 2) = 100000.0, (18, 1) = 5.111688313567838, (18, 2) = 100000.0, (19, 1) = 5.433087699497487, (19, 2) = 100000.0, (20, 1) = 5.717580615075376, (20, 2) = 100000.0, (21, 1) = 6.029714433165829, (21, 2) = 100000.0, (22, 1) = 6.32693964120603, (22, 2) = 100000.0, (23, 1) = 6.63706296482412, (23, 2) = 100000.0, (24, 1) = 6.9218529859296485, (24, 2) = 100000.0, (25, 1) = 7.229037497487436, (25, 2) = 100000.0, (26, 1) = 7.548115872361809, (26, 2) = 100000.0, (27, 1) = 7.825874535678391, (27, 2) = 100000.0, (28, 1) = 8.125861501507536, (28, 2) = 100000.0, (29, 1) = 8.435777390954772, (29, 2) = 100000.0, (30, 1) = 8.738969626130652, (30, 2) = 100000.0, (31, 1) = 9.032323703517587, (31, 2) = 100000.0, (32, 1) = 9.358043390954773, (32, 2) = 100000.0, (33, 1) = 9.650717017085425, (33, 2) = 100000.0, (34, 1) = 9.963208582914572, (34, 2) = 100000.0, (35, 1) = 10.246372386934672, (35, 2) = 100000.0, (36, 1) = 10.555945218090452, (36, 2) = 100000.0, (37, 1) = 10.847229126633163, (37, 2) = 100000.0, (38, 1) = 11.151704740703517, (38, 2) = 100000.0, (39, 1) = 11.449385306532662, (39, 2) = 100000.0, (40, 1) = 11.761029271356783, (40, 2) = 100000.0, (41, 1) = 12.06117944924623, (41, 2) = 100000.0, (42, 1) = 12.368126357788944, (42, 2) = 100000.0, (43, 1) = 12.672531590954774, (43, 2) = 100000.0, (44, 1) = 12.952248385929648, (44, 2) = 100000.0, (45, 1) = 13.272835398994975, (45, 2) = 100000.0, (46, 1) = 13.55957224522613, (46, 2) = 100000.0, (47, 1) = 13.865293528643216, (47, 2) = 100000.0, (48, 1) = 14.157907806030149, (48, 2) = 100000.0, (49, 1) = 14.482818355778894, (49, 2) = 100000.0, (50, 1) = 14.76416701809045, (50, 2) = 100000.0, (51, 1) = 15.083500266331658, (51, 2) = 100000.0, (52, 1) = 15.374537855276381, (52, 2) = 100000.0, (53, 1) = 15.69288723919598, (53, 2) = 100000.0, (54, 1) = 15.967568918592962, (54, 2) = 100000.0, (55, 1) = 16.28039928844221, (55, 2) = 100000.0, (56, 1) = 16.582577981909548, (56, 2) = 100000.0, (57, 1) = 16.88455926934673, (57, 2) = 100000.0, (58, 1) = 17.18542962211055, (58, 2) = 100000.0, (59, 1) = 17.474471840201005, (59, 2) = 100000.0, (60, 1) = 17.786934132663315, (60, 2) = 100000.0, (61, 1) = 18.084733353768844, (61, 2) = 100000.0, (62, 1) = 18.398153011055275, (62, 2) = 100000.0, (63, 1) = 18.681873274371856, (63, 2) = 100000.0, (64, 1) = 18.995437278391957, (64, 2) = 100000.0, (65, 1) = 19.295776953768843, (65, 2) = 100000.0, (66, 1) = 19.595385593969848, (66, 2) = 100000.0, (67, 1) = 19.908327979899497, (67, 2) = 100000.0, (68, 1) = 20.19655934170854, (68, 2) = 100000.0, (69, 1) = 20.491747682412058, (69, 2) = 100000.0, (70, 1) = 20.817670685427135, (70, 2) = 100000.0, (71, 1) = 21.112767268341706, (71, 2) = 100000.0, (72, 1) = 21.414558798994975, (72, 2) = 100000.0, (73, 1) = 21.7214730120603, (73, 2) = 100000.0, (74, 1) = 22.003586897487438, (74, 2) = 100000.0, (75, 1) = 22.304311163819094, (75, 2) = 100000.0, (76, 1) = 22.602746297487435, (76, 2) = 100000.0, (77, 1) = 22.92197912562814, (77, 2) = 100000.0, (78, 1) = 23.20368826733668, (78, 2) = 100000.0, (79, 1) = 23.528722136683413, (79, 2) = 100000.0, (80, 1) = 23.822040144723616, (80, 2) = 100000.0, (81, 1) = 24.112262981909545, (81, 2) = 100000.0, (82, 1) = 24.42434576683417, (82, 2) = 100000.0, (83, 1) = 24.73769099095477, (83, 2) = 100000.0, (84, 1) = 25.022788748743714, (84, 2) = 100000.0, (85, 1) = 25.325549903517587, (85, 2) = 100000.0, (86, 1) = 25.6210152, (86, 2) = 100000.0, (87, 1) = 25.94130269849246, (87, 2) = 100000.0, (88, 1) = 26.21844043417085, (88, 2) = 100000.0, (89, 1) = 26.536743198994973, (89, 2) = 100000.0, (90, 1) = 26.835964531658288, (90, 2) = 100000.0, (91, 1) = 27.13229571256281, (91, 2) = 100000.0, (92, 1) = 27.428862627135675, (92, 2) = 100000.0, (93, 1) = 27.73134210753769, (93, 2) = 100000.0, (94, 1) = 28.05196528944723, (94, 2) = 100000.0, (95, 1) = 28.345945350753766, (95, 2) = 100000.0, (96, 1) = 28.636141420100497, (96, 2) = 100000.0, (97, 1) = 28.946356242211053, (97, 2) = 100000.0, (98, 1) = 29.255895753768844, (98, 2) = 100000.0, (99, 1) = 29.53372584723618, (99, 2) = 100000.0, (100, 1) = 29.862835628140704, (100, 2) = 100000.0, (101, 1) = 30.138219431155775, (101, 2) = 100000.0, (102, 1) = 30.46031172060301, (102, 2) = 100000.0, (103, 1) = 30.767717608040197, (103, 2) = 100000.0, (104, 1) = 31.042194449246228, (104, 2) = 100000.0, (105, 1) = 31.350872363819093, (105, 2) = 100000.0, (106, 1) = 31.661596395979895, (106, 2) = 100000.0, (107, 1) = 31.970843611055276, (107, 2) = 100000.0, (108, 1) = 32.25755536582914, (108, 2) = 100000.0, (109, 1) = 32.55442878090452, (109, 2) = 100000.0, (110, 1) = 32.86145569145728, (110, 2) = 100000.0, (111, 1) = 33.16749796281407, (111, 2) = 100000.0, (112, 1) = 33.4823000562814, (112, 2) = 100000.0, (113, 1) = 33.759577911557784, (113, 2) = 100000.0, (114, 1) = 34.07172710351758, (114, 2) = 100000.0, (115, 1) = 34.38515801005025, (115, 2) = 100000.0, (116, 1) = 34.687206765829146, (116, 2) = 100000.0, (117, 1) = 34.96149597286432, (117, 2) = 100000.0, (118, 1) = 35.28765236984924, (118, 2) = 100000.0, (119, 1) = 35.563949620100495, (119, 2) = 100000.0, (120, 1) = 35.88534900603015, (120, 2) = 100000.0, (121, 1) = 36.16984192160804, (121, 2) = 100000.0, (122, 1) = 36.48197573969849, (122, 2) = 100000.0, (123, 1) = 36.77920094773869, (123, 2) = 100000.0, (124, 1) = 37.08932427135678, (124, 2) = 100000.0, (125, 1) = 37.37411429246231, (125, 2) = 100000.0, (126, 1) = 37.6812988040201, (126, 2) = 100000.0, (127, 1) = 38.00037717889447, (127, 2) = 100000.0, (128, 1) = 38.27813584221106, (128, 2) = 100000.0, (129, 1) = 38.5781228080402, (129, 2) = 100000.0, (130, 1) = 38.88803869748743, (130, 2) = 100000.0, (131, 1) = 39.191230932663316, (131, 2) = 100000.0, (132, 1) = 39.484585010050246, (132, 2) = 100000.0, (133, 1) = 39.81030469748743, (133, 2) = 100000.0, (134, 1) = 40.10297832361809, (134, 2) = 100000.0, (135, 1) = 40.41546988944723, (135, 2) = 100000.0, (136, 1) = 40.69863369346733, (136, 2) = 100000.0, (137, 1) = 41.008206524623105, (137, 2) = 100000.0, (138, 1) = 41.29949043316583, (138, 2) = 100000.0, (139, 1) = 41.60396604723618, (139, 2) = 100000.0, (140, 1) = 41.90164661306532, (140, 2) = 100000.0, (141, 1) = 42.213290577889445, (141, 2) = 100000.0, (142, 1) = 42.51344075577889, (142, 2) = 100000.0, (143, 1) = 42.8203876643216, (143, 2) = 100000.0, (144, 1) = 43.12479289748743, (144, 2) = 100000.0, (145, 1) = 43.404509692462305, (145, 2) = 100000.0, (146, 1) = 43.72509670552763, (146, 2) = 100000.0, (147, 1) = 44.01183355175879, (147, 2) = 100000.0, (148, 1) = 44.31755483517587, (148, 2) = 100000.0, (149, 1) = 44.610169112562815, (149, 2) = 100000.0, (150, 1) = 44.93507966231155, (150, 2) = 100000.0, (151, 1) = 45.21642832462311, (151, 2) = 100000.0, (152, 1) = 45.53576157286432, (152, 2) = 100000.0, (153, 1) = 45.826799161809035, (153, 2) = 100000.0, (154, 1) = 46.14514854572864, (154, 2) = 100000.0, (155, 1) = 46.41983022512562, (155, 2) = 100000.0, (156, 1) = 46.73266059497487, (156, 2) = 100000.0, (157, 1) = 47.03483928844221, (157, 2) = 100000.0, (158, 1) = 47.33682057587939, (158, 2) = 100000.0, (159, 1) = 47.63769092864321, (159, 2) = 100000.0, (160, 1) = 47.92673314673367, (160, 2) = 100000.0, (161, 1) = 48.23919543919598, (161, 2) = 100000.0, (162, 1) = 48.5369946603015, (162, 2) = 100000.0, (163, 1) = 48.85041431758794, (163, 2) = 100000.0, (164, 1) = 49.134134580904515, (164, 2) = 100000.0, (165, 1) = 49.447698584924616, (165, 2) = 100000.0, (166, 1) = 49.748038260301506, (166, 2) = 100000.0, (167, 1) = 50.047646900502514, (167, 2) = 100000.0, (168, 1) = 50.36058928643215, (168, 2) = 100000.0, (169, 1) = 50.6488206482412, (169, 2) = 100000.0, (170, 1) = 50.94400898894472, (170, 2) = 100000.0, (171, 1) = 51.26993199195979, (171, 2) = 100000.0, (172, 1) = 51.56502857487437, (172, 2) = 100000.0, (173, 1) = 51.86682010552764, (173, 2) = 100000.0, (174, 1) = 52.17373431859296, (174, 2) = 100000.0, (175, 1) = 52.4558482040201, (175, 2) = 100000.0, (176, 1) = 52.756572470351756, (176, 2) = 100000.0, (177, 1) = 53.0550076040201, (177, 2) = 100000.0, (178, 1) = 53.374240432160796, (178, 2) = 100000.0, (179, 1) = 53.65594957386934, (179, 2) = 100000.0, (180, 1) = 53.980983443216076, (180, 2) = 100000.0, (181, 1) = 54.27430145125628, (181, 2) = 100000.0, (182, 1) = 54.56452428844221, (182, 2) = 100000.0, (183, 1) = 54.876607073366834, (183, 2) = 100000.0, (184, 1) = 55.18995229748743, (184, 2) = 100000.0, (185, 1) = 55.47505005527638, (185, 2) = 100000.0, (186, 1) = 55.777811210050245, (186, 2) = 100000.0, (187, 1) = 56.07327650653266, (187, 2) = 100000.0, (188, 1) = 56.39356400502512, (188, 2) = 100000.0, (189, 1) = 56.67070174070351, (189, 2) = 100000.0, (190, 1) = 56.98900450552763, (190, 2) = 100000.0, (191, 1) = 57.288225838190954, (191, 2) = 100000.0, (192, 1) = 57.58455701909548, (192, 2) = 100000.0, (193, 1) = 57.881123933668334, (193, 2) = 100000.0, (194, 1) = 58.18360341407034, (194, 2) = 100000.0, (195, 1) = 58.504226595979894, (195, 2) = 100000.0, (196, 1) = 58.79820665728643, (196, 2) = 100000.0, (197, 1) = 59.08840272663316, (197, 2) = 100000.0, (198, 1) = 59.398617548743715, (198, 2) = 100000.0, (199, 1) = 59.708157060301495, (199, 2) = 100000.0, (200, 1) = 60.0, (200, 2) = 100000.0}, datatype = float[8])), CURVES(Matrix(200, 2, {(1, 1) = .0, (1, 2) = 1000000.0, (2, 1) = .3154563015075377, (2, 2) = 1000000.0, (3, 1) = .5899331427135678, (3, 2) = 1000000.0, (4, 1) = .8986110572864321, (4, 2) = 1000000.0, (5, 1) = 1.2093350894472361, (5, 2) = 1000000.0, (6, 1) = 1.5185823045226128, (6, 2) = 1000000.0, (7, 1) = 1.8052940592964821, (7, 2) = 1000000.0, (8, 1) = 2.102167474371859, (8, 2) = 1000000.0, (9, 1) = 2.409194384924623, (9, 2) = 1000000.0, (10, 1) = 2.7152366562814065, (10, 2) = 1000000.0, (11, 1) = 3.0300387497487438, (11, 2) = 1000000.0, (12, 1) = 3.3073166050251253, (12, 2) = 1000000.0, (13, 1) = 3.6194657969849247, (13, 2) = 1000000.0, (14, 1) = 3.9328967035175877, (14, 2) = 1000000.0, (15, 1) = 4.234945459296482, (15, 2) = 1000000.0, (16, 1) = 4.509234666331658, (16, 2) = 1000000.0, (17, 1) = 4.835391063316583, (17, 2) = 1000000.0, (18, 1) = 5.111688313567838, (18, 2) = 1000000.0, (19, 1) = 5.433087699497487, (19, 2) = 1000000.0, (20, 1) = 5.717580615075376, (20, 2) = 1000000.0, (21, 1) = 6.029714433165829, (21, 2) = 1000000.0, (22, 1) = 6.32693964120603, (22, 2) = 1000000.0, (23, 1) = 6.63706296482412, (23, 2) = 1000000.0, (24, 1) = 6.9218529859296485, (24, 2) = 1000000.0, (25, 1) = 7.229037497487436, (25, 2) = 1000000.0, (26, 1) = 7.548115872361809, (26, 2) = 1000000.0, (27, 1) = 7.825874535678391, (27, 2) = 1000000.0, (28, 1) = 8.125861501507536, (28, 2) = 1000000.0, (29, 1) = 8.435777390954772, (29, 2) = 1000000.0, (30, 1) = 8.738969626130652, (30, 2) = 1000000.0, (31, 1) = 9.032323703517587, (31, 2) = 1000000.0, (32, 1) = 9.358043390954773, (32, 2) = 1000000.0, (33, 1) = 9.650717017085425, (33, 2) = 1000000.0, (34, 1) = 9.963208582914572, (34, 2) = 1000000.0, (35, 1) = 10.246372386934672, (35, 2) = 1000000.0, (36, 1) = 10.555945218090452, (36, 2) = 1000000.0, (37, 1) = 10.847229126633163, (37, 2) = 1000000.0, (38, 1) = 11.151704740703517, (38, 2) = 1000000.0, (39, 1) = 11.449385306532662, (39, 2) = 1000000.0, (40, 1) = 11.761029271356783, (40, 2) = 1000000.0, (41, 1) = 12.06117944924623, (41, 2) = 1000000.0, (42, 1) = 12.368126357788944, (42, 2) = 1000000.0, (43, 1) = 12.672531590954774, (43, 2) = 1000000.0, (44, 1) = 12.952248385929648, (44, 2) = 1000000.0, (45, 1) = 13.272835398994975, (45, 2) = 1000000.0, (46, 1) = 13.55957224522613, (46, 2) = 1000000.0, (47, 1) = 13.865293528643216, (47, 2) = 1000000.0, (48, 1) = 14.157907806030149, (48, 2) = 1000000.0, (49, 1) = 14.482818355778894, (49, 2) = 1000000.0, (50, 1) = 14.76416701809045, (50, 2) = 1000000.0, (51, 1) = 15.083500266331658, (51, 2) = 1000000.0, (52, 1) = 15.374537855276381, (52, 2) = 1000000.0, (53, 1) = 15.69288723919598, (53, 2) = 1000000.0, (54, 1) = 15.967568918592962, (54, 2) = 1000000.0, (55, 1) = 16.28039928844221, (55, 2) = 1000000.0, (56, 1) = 16.582577981909548, (56, 2) = 1000000.0, (57, 1) = 16.88455926934673, (57, 2) = 1000000.0, (58, 1) = 17.18542962211055, (58, 2) = 1000000.0, (59, 1) = 17.474471840201005, (59, 2) = 1000000.0, (60, 1) = 17.786934132663315, (60, 2) = 1000000.0, (61, 1) = 18.084733353768844, (61, 2) = 1000000.0, (62, 1) = 18.398153011055275, (62, 2) = 1000000.0, (63, 1) = 18.681873274371856, (63, 2) = 1000000.0, (64, 1) = 18.995437278391957, (64, 2) = 1000000.0, (65, 1) = 19.295776953768843, (65, 2) = 1000000.0, (66, 1) = 19.595385593969848, (66, 2) = 1000000.0, (67, 1) = 19.908327979899497, (67, 2) = 1000000.0, (68, 1) = 20.19655934170854, (68, 2) = 1000000.0, (69, 1) = 20.491747682412058, (69, 2) = 1000000.0, (70, 1) = 20.817670685427135, (70, 2) = 1000000.0, (71, 1) = 21.112767268341706, (71, 2) = 1000000.0, (72, 1) = 21.414558798994975, (72, 2) = 1000000.0, (73, 1) = 21.7214730120603, (73, 2) = 1000000.0, (74, 1) = 22.003586897487438, (74, 2) = 1000000.0, (75, 1) = 22.304311163819094, (75, 2) = 1000000.0, (76, 1) = 22.602746297487435, (76, 2) = 1000000.0, (77, 1) = 22.92197912562814, (77, 2) = 1000000.0, (78, 1) = 23.20368826733668, (78, 2) = 1000000.0, (79, 1) = 23.528722136683413, (79, 2) = 1000000.0, (80, 1) = 23.822040144723616, (80, 2) = 1000000.0, (81, 1) = 24.112262981909545, (81, 2) = 1000000.0, (82, 1) = 24.42434576683417, (82, 2) = 1000000.0, (83, 1) = 24.73769099095477, (83, 2) = 1000000.0, (84, 1) = 25.022788748743714, (84, 2) = 1000000.0, (85, 1) = 25.325549903517587, (85, 2) = 1000000.0, (86, 1) = 25.6210152, (86, 2) = 1000000.0, (87, 1) = 25.94130269849246, (87, 2) = 1000000.0, (88, 1) = 26.21844043417085, (88, 2) = 1000000.0, (89, 1) = 26.536743198994973, (89, 2) = 1000000.0, (90, 1) = 26.835964531658288, (90, 2) = 1000000.0, (91, 1) = 27.13229571256281, (91, 2) = 1000000.0, (92, 1) = 27.428862627135675, (92, 2) = 1000000.0, (93, 1) = 27.73134210753769, (93, 2) = 1000000.0, (94, 1) = 28.05196528944723, (94, 2) = 1000000.0, (95, 1) = 28.345945350753766, (95, 2) = 1000000.0, (96, 1) = 28.636141420100497, (96, 2) = 1000000.0, (97, 1) = 28.946356242211053, (97, 2) = 1000000.0, (98, 1) = 29.255895753768844, (98, 2) = 1000000.0, (99, 1) = 29.53372584723618, (99, 2) = 1000000.0, (100, 1) = 29.862835628140704, (100, 2) = 1000000.0, (101, 1) = 30.138219431155775, (101, 2) = 1000000.0, (102, 1) = 30.46031172060301, (102, 2) = 1000000.0, (103, 1) = 30.767717608040197, (103, 2) = 1000000.0, (104, 1) = 31.042194449246228, (104, 2) = 1000000.0, (105, 1) = 31.350872363819093, (105, 2) = 1000000.0, (106, 1) = 31.661596395979895, (106, 2) = 1000000.0, (107, 1) = 31.970843611055276, (107, 2) = 1000000.0, (108, 1) = 32.25755536582914, (108, 2) = 1000000.0, (109, 1) = 32.55442878090452, (109, 2) = 1000000.0, (110, 1) = 32.86145569145728, (110, 2) = 1000000.0, (111, 1) = 33.16749796281407, (111, 2) = 1000000.0, (112, 1) = 33.4823000562814, (112, 2) = 1000000.0, (113, 1) = 33.759577911557784, (113, 2) = 1000000.0, (114, 1) = 34.07172710351758, (114, 2) = 1000000.0, (115, 1) = 34.38515801005025, (115, 2) = 1000000.0, (116, 1) = 34.687206765829146, (116, 2) = 1000000.0, (117, 1) = 34.96149597286432, (117, 2) = 1000000.0, (118, 1) = 35.28765236984924, (118, 2) = 1000000.0, (119, 1) = 35.563949620100495, (119, 2) = 1000000.0, (120, 1) = 35.88534900603015, (120, 2) = 1000000.0, (121, 1) = 36.16984192160804, (121, 2) = 1000000.0, (122, 1) = 36.48197573969849, (122, 2) = 1000000.0, (123, 1) = 36.77920094773869, (123, 2) = 1000000.0, (124, 1) = 37.08932427135678, (124, 2) = 1000000.0, (125, 1) = 37.37411429246231, (125, 2) = 1000000.0, (126, 1) = 37.6812988040201, (126, 2) = 1000000.0, (127, 1) = 38.00037717889447, (127, 2) = 1000000.0, (128, 1) = 38.27813584221106, (128, 2) = 1000000.0, (129, 1) = 38.5781228080402, (129, 2) = 1000000.0, (130, 1) = 38.88803869748743, (130, 2) = 1000000.0, (131, 1) = 39.191230932663316, (131, 2) = 1000000.0, (132, 1) = 39.484585010050246, (132, 2) = 1000000.0, (133, 1) = 39.81030469748743, (133, 2) = 1000000.0, (134, 1) = 40.10297832361809, (134, 2) = 1000000.0, (135, 1) = 40.41546988944723, (135, 2) = 1000000.0, (136, 1) = 40.69863369346733, (136, 2) = 1000000.0, (137, 1) = 41.008206524623105, (137, 2) = 1000000.0, (138, 1) = 41.29949043316583, (138, 2) = 1000000.0, (139, 1) = 41.60396604723618, (139, 2) = 1000000.0, (140, 1) = 41.90164661306532, (140, 2) = 1000000.0, (141, 1) = 42.213290577889445, (141, 2) = 1000000.0, (142, 1) = 42.51344075577889, (142, 2) = 1000000.0, (143, 1) = 42.8203876643216, (143, 2) = 1000000.0, (144, 1) = 43.12479289748743, (144, 2) = 1000000.0, (145, 1) = 43.404509692462305, (145, 2) = 1000000.0, (146, 1) = 43.72509670552763, (146, 2) = 1000000.0, (147, 1) = 44.01183355175879, (147, 2) = 1000000.0, (148, 1) = 44.31755483517587, (148, 2) = 1000000.0, (149, 1) = 44.610169112562815, (149, 2) = 1000000.0, (150, 1) = 44.93507966231155, (150, 2) = 1000000.0, (151, 1) = 45.21642832462311, (151, 2) = 1000000.0, (152, 1) = 45.53576157286432, (152, 2) = 1000000.0, (153, 1) = 45.826799161809035, (153, 2) = 1000000.0, (154, 1) = 46.14514854572864, (154, 2) = 1000000.0, (155, 1) = 46.41983022512562, (155, 2) = 1000000.0, (156, 1) = 46.73266059497487, (156, 2) = 1000000.0, (157, 1) = 47.03483928844221, (157, 2) = 1000000.0, (158, 1) = 47.33682057587939, (158, 2) = 1000000.0, (159, 1) = 47.63769092864321, (159, 2) = 1000000.0, (160, 1) = 47.92673314673367, (160, 2) = 1000000.0, (161, 1) = 48.23919543919598, (161, 2) = 1000000.0, (162, 1) = 48.5369946603015, (162, 2) = 1000000.0, (163, 1) = 48.85041431758794, (163, 2) = 1000000.0, (164, 1) = 49.134134580904515, (164, 2) = 1000000.0, (165, 1) = 49.447698584924616, (165, 2) = 1000000.0, (166, 1) = 49.748038260301506, (166, 2) = 1000000.0, (167, 1) = 50.047646900502514, (167, 2) = 1000000.0, (168, 1) = 50.36058928643215, (168, 2) = 1000000.0, (169, 1) = 50.6488206482412, (169, 2) = 1000000.0, (170, 1) = 50.94400898894472, (170, 2) = 1000000.0, (171, 1) = 51.26993199195979, (171, 2) = 1000000.0, (172, 1) = 51.56502857487437, (172, 2) = 1000000.0, (173, 1) = 51.86682010552764, (173, 2) = 1000000.0, (174, 1) = 52.17373431859296, (174, 2) = 1000000.0, (175, 1) = 52.4558482040201, (175, 2) = 1000000.0, (176, 1) = 52.756572470351756, (176, 2) = 1000000.0, (177, 1) = 53.0550076040201, (177, 2) = 1000000.0, (178, 1) = 53.374240432160796, (178, 2) = 1000000.0, (179, 1) = 53.65594957386934, (179, 2) = 1000000.0, (180, 1) = 53.980983443216076, (180, 2) = 1000000.0, (181, 1) = 54.27430145125628, (181, 2) = 1000000.0, (182, 1) = 54.56452428844221, (182, 2) = 1000000.0, (183, 1) = 54.876607073366834, (183, 2) = 1000000.0, (184, 1) = 55.18995229748743, (184, 2) = 1000000.0, (185, 1) = 55.47505005527638, (185, 2) = 1000000.0, (186, 1) = 55.777811210050245, (186, 2) = 1000000.0, (187, 1) = 56.07327650653266, (187, 2) = 1000000.0, (188, 1) = 56.39356400502512, (188, 2) = 1000000.0, (189, 1) = 56.67070174070351, (189, 2) = 1000000.0, (190, 1) = 56.98900450552763, (190, 2) = 1000000.0, (191, 1) = 57.288225838190954, (191, 2) = 1000000.0, (192, 1) = 57.58455701909548, (192, 2) = 1000000.0, (193, 1) = 57.881123933668334, (193, 2) = 1000000.0, (194, 1) = 58.18360341407034, (194, 2) = 1000000.0, (195, 1) = 58.504226595979894, (195, 2) = 1000000.0, (196, 1) = 58.79820665728643, (196, 2) = 1000000.0, (197, 1) = 59.08840272663316, (197, 2) = 1000000.0, (198, 1) = 59.398617548743715, (198, 2) = 1000000.0, (199, 1) = 59.708157060301495, (199, 2) = 1000000.0, (200, 1) = 60.0, (200, 2) = 1000000.0}, datatype = float[8])), COLOUR(RGB, .90196078, .90196078, .90196078), THICKNESS(0), AXESLABELS(x, ""), VIEW(0. .. 60., DEFAULT, _ATTRIBUTE("source" = "mathdefault")))

(5)

plots:-display(a2, b2, title = "Total Deaths \n (Logarithmic scale)\n", titlefont = ["Helvetica", 18], size = [681, 400])

 

One still could think and interpret that graph at levelling off to maybe 100,000.  I sense another Dr. Fauci prediction?  

Let's take a look at the linear graph

 

a3 := plots:-listplot(USTotalDeaths[32 .. ()], tickmarks = [[seq(i-31 = USTotaldeathsdates[i], i = 32 .. nops(USTotaldeathsdates))], [20000 = "20K", 40000 = "40K", 60000 = "60K", 80000 = "80K"]], view = [default, 100 .. 80000], color = "#FF9900", thickness = 6, labels = ["", "Total Coronavirus Deaths"], labeldirections = [default, vertical])

PLOT(CURVES(Matrix(46, 2, {(1, 1) = 1.0, (1, 2) = 121.0, (2, 1) = 2.0, (2, 2) = 171.0, (3, 1) = 3.0, (3, 2) = 239.0, (4, 1) = 4.0, (4, 2) = 309.0, (5, 1) = 5.0, (5, 2) = 374.0, (6, 1) = 6.0, (6, 2) = 509.0, (7, 1) = 7.0, (7, 2) = 689.0, (8, 1) = 8.0, (8, 2) = 957.0, (9, 1) = 9.0, (9, 2) = 1260.0, (10, 1) = 10.0, (10, 2) = 1614.0, (11, 1) = 11.0, (11, 2) = 2110.0, (12, 1) = 12.0, (12, 2) = 2754.0, (13, 1) = 13.0, (13, 2) = 3251.0, (14, 1) = 14.0, (14, 2) = 4066.0, (15, 1) = 15.0, (15, 2) = 5151.0, (16, 1) = 16.0, (16, 2) = 6394.0, (17, 1) = 17.0, (17, 2) = 7576.0, (18, 1) = 18.0, (18, 2) = 8839.0, (19, 1) = 19.0, (19, 2) = 10384.0, (20, 1) = 20.0, (20, 2) = 11793.0, (21, 1) = 21.0, (21, 2) = 13298.0, (22, 1) = 22.0, (22, 2) = 15526.0, (23, 1) = 23.0, (23, 2) = 17691.0, (24, 1) = 24.0, (24, 2) = 19802.0, (25, 1) = 25.0, (25, 2) = 22038.0, (26, 1) = 26.0, (26, 2) = 24062.0, (27, 1) = 27.0, (27, 2) = 25789.0, (28, 1) = 28.0, (28, 2) = 27515.0, (29, 1) = 29.0, (29, 2) = 30081.0, (30, 1) = 30.0, (30, 2) = 32712.0, (31, 1) = 31.0, (31, 2) = 34905.0, (32, 1) = 32.0, (32, 2) = 37448.0, (33, 1) = 33.0, (33, 2) = 39331.0, (34, 1) = 34.0, (34, 2) = 40901.0, (35, 1) = 35.0, (35, 2) = 42853.0, (36, 1) = 36.0, (36, 2) = 45536.0, (37, 1) = 37.0, (37, 2) = 47894.0, (38, 1) = 38.0, (38, 2) = 50234.0, (39, 1) = 39.0, (39, 2) = 52191.0, (40, 1) = 40.0, (40, 2) = 54256.0, (41, 1) = 41.0, (41, 2) = 55412.0, (42, 1) = 42.0, (42, 2) = 56795.0, (43, 1) = 43.0, (43, 2) = 59265.0, (44, 1) = 44.0, (44, 2) = 61655.0, (45, 1) = 45.0, (45, 2) = 63856.0, (46, 1) = 46.0, (46, 2) = 65753.0}, datatype = float[8])), COLOUR(RGB, 1.00000000, .60000000, 0.), THICKNESS(6), AXESTICKS([1 = "Mar 17", 2 = "Mar 18", 3 = "Mar 19", 4 = "Mar 20", 5 = "Mar 21", 6 = "Mar 22", 7 = "Mar 23", 8 = "Mar 24", 9 = "Mar 25", 10 = "Mar 26", 11 = "Mar 27", 12 = "Mar 28", 13 = "Mar 29", 14 = "Mar 30", 15 = "Mar 31", 16 = "Apr 01", 17 = "Apr 02", 18 = "Apr 03", 19 = "Apr 04", 20 = "Apr 05", 21 = "Apr 06", 22 = "Apr 07", 23 = "Apr 08", 24 = "Apr 09", 25 = "Apr 10", 26 = "Apr 11", 27 = "Apr 12", 28 = "Apr 13", 29 = "Apr 14", 30 = "Apr 15", 31 = "Apr 16", 32 = "Apr 17", 33 = "Apr 18", 34 = "Apr 19", 35 = "Apr 20", 36 = "Apr 21", 37 = "Apr 22", 38 = "Apr 23", 39 = "Apr 24", 40 = "Apr 25", 41 = "Apr 26", 42 = "Apr 27", 43 = "Apr 28", 44 = "Apr 29", 45 = "Apr 30", 46 = "May 01"], [20000 = "20K", 40000 = "40K", 60000 = "60K", 80000 = "80K"]), AXESLABELS("", "Total Coronavirus Deaths", FONT(DEFAULT), DEFAULT, VERTICAL), VIEW(DEFAULT, 100 .. 80000))

(6)

b3 := plot([20000, 40000, 60000, 80000], x = 0 .. 60, color = "#E6E6E6", thickness = 0)

PLOT(CURVES(Matrix(200, 2, {(1, 1) = .0, (1, 2) = 20000.0, (2, 1) = .3154563015075377, (2, 2) = 20000.0, (3, 1) = .5899331427135678, (3, 2) = 20000.0, (4, 1) = .8986110572864321, (4, 2) = 20000.0, (5, 1) = 1.2093350894472361, (5, 2) = 20000.0, (6, 1) = 1.5185823045226128, (6, 2) = 20000.0, (7, 1) = 1.8052940592964821, (7, 2) = 20000.0, (8, 1) = 2.102167474371859, (8, 2) = 20000.0, (9, 1) = 2.409194384924623, (9, 2) = 20000.0, (10, 1) = 2.7152366562814065, (10, 2) = 20000.0, (11, 1) = 3.0300387497487438, (11, 2) = 20000.0, (12, 1) = 3.3073166050251253, (12, 2) = 20000.0, (13, 1) = 3.6194657969849247, (13, 2) = 20000.0, (14, 1) = 3.9328967035175877, (14, 2) = 20000.0, (15, 1) = 4.234945459296482, (15, 2) = 20000.0, (16, 1) = 4.509234666331658, (16, 2) = 20000.0, (17, 1) = 4.835391063316583, (17, 2) = 20000.0, (18, 1) = 5.111688313567838, (18, 2) = 20000.0, (19, 1) = 5.433087699497487, (19, 2) = 20000.0, (20, 1) = 5.717580615075376, (20, 2) = 20000.0, (21, 1) = 6.029714433165829, (21, 2) = 20000.0, (22, 1) = 6.32693964120603, (22, 2) = 20000.0, (23, 1) = 6.63706296482412, (23, 2) = 20000.0, (24, 1) = 6.9218529859296485, (24, 2) = 20000.0, (25, 1) = 7.229037497487436, (25, 2) = 20000.0, (26, 1) = 7.548115872361809, (26, 2) = 20000.0, (27, 1) = 7.825874535678391, (27, 2) = 20000.0, (28, 1) = 8.125861501507536, (28, 2) = 20000.0, (29, 1) = 8.435777390954772, (29, 2) = 20000.0, (30, 1) = 8.738969626130652, (30, 2) = 20000.0, (31, 1) = 9.032323703517587, (31, 2) = 20000.0, (32, 1) = 9.358043390954773, (32, 2) = 20000.0, (33, 1) = 9.650717017085425, (33, 2) = 20000.0, (34, 1) = 9.963208582914572, (34, 2) = 20000.0, (35, 1) = 10.246372386934672, (35, 2) = 20000.0, (36, 1) = 10.555945218090452, (36, 2) = 20000.0, (37, 1) = 10.847229126633163, (37, 2) = 20000.0, (38, 1) = 11.151704740703517, (38, 2) = 20000.0, (39, 1) = 11.449385306532662, (39, 2) = 20000.0, (40, 1) = 11.761029271356783, (40, 2) = 20000.0, (41, 1) = 12.06117944924623, (41, 2) = 20000.0, (42, 1) = 12.368126357788944, (42, 2) = 20000.0, (43, 1) = 12.672531590954774, (43, 2) = 20000.0, (44, 1) = 12.952248385929648, (44, 2) = 20000.0, (45, 1) = 13.272835398994975, (45, 2) = 20000.0, (46, 1) = 13.55957224522613, (46, 2) = 20000.0, (47, 1) = 13.865293528643216, (47, 2) = 20000.0, (48, 1) = 14.157907806030149, (48, 2) = 20000.0, (49, 1) = 14.482818355778894, (49, 2) = 20000.0, (50, 1) = 14.76416701809045, (50, 2) = 20000.0, (51, 1) = 15.083500266331658, (51, 2) = 20000.0, (52, 1) = 15.374537855276381, (52, 2) = 20000.0, (53, 1) = 15.69288723919598, (53, 2) = 20000.0, (54, 1) = 15.967568918592962, (54, 2) = 20000.0, (55, 1) = 16.28039928844221, (55, 2) = 20000.0, (56, 1) = 16.582577981909548, (56, 2) = 20000.0, (57, 1) = 16.88455926934673, (57, 2) = 20000.0, (58, 1) = 17.18542962211055, (58, 2) = 20000.0, (59, 1) = 17.474471840201005, (59, 2) = 20000.0, (60, 1) = 17.786934132663315, (60, 2) = 20000.0, (61, 1) = 18.084733353768844, (61, 2) = 20000.0, (62, 1) = 18.398153011055275, (62, 2) = 20000.0, (63, 1) = 18.681873274371856, (63, 2) = 20000.0, (64, 1) = 18.995437278391957, (64, 2) = 20000.0, (65, 1) = 19.295776953768843, (65, 2) = 20000.0, (66, 1) = 19.595385593969848, (66, 2) = 20000.0, (67, 1) = 19.908327979899497, (67, 2) = 20000.0, (68, 1) = 20.19655934170854, (68, 2) = 20000.0, (69, 1) = 20.491747682412058, (69, 2) = 20000.0, (70, 1) = 20.817670685427135, (70, 2) = 20000.0, (71, 1) = 21.112767268341706, (71, 2) = 20000.0, (72, 1) = 21.414558798994975, (72, 2) = 20000.0, (73, 1) = 21.7214730120603, (73, 2) = 20000.0, (74, 1) = 22.003586897487438, (74, 2) = 20000.0, (75, 1) = 22.304311163819094, (75, 2) = 20000.0, (76, 1) = 22.602746297487435, (76, 2) = 20000.0, (77, 1) = 22.92197912562814, (77, 2) = 20000.0, (78, 1) = 23.20368826733668, (78, 2) = 20000.0, (79, 1) = 23.528722136683413, (79, 2) = 20000.0, (80, 1) = 23.822040144723616, (80, 2) = 20000.0, (81, 1) = 24.112262981909545, (81, 2) = 20000.0, (82, 1) = 24.42434576683417, (82, 2) = 20000.0, (83, 1) = 24.73769099095477, (83, 2) = 20000.0, (84, 1) = 25.022788748743714, (84, 2) = 20000.0, (85, 1) = 25.325549903517587, (85, 2) = 20000.0, (86, 1) = 25.6210152, (86, 2) = 20000.0, (87, 1) = 25.94130269849246, (87, 2) = 20000.0, (88, 1) = 26.21844043417085, (88, 2) = 20000.0, (89, 1) = 26.536743198994973, (89, 2) = 20000.0, (90, 1) = 26.835964531658288, (90, 2) = 20000.0, (91, 1) = 27.13229571256281, (91, 2) = 20000.0, (92, 1) = 27.428862627135675, (92, 2) = 20000.0, (93, 1) = 27.73134210753769, (93, 2) = 20000.0, (94, 1) = 28.05196528944723, (94, 2) = 20000.0, (95, 1) = 28.345945350753766, (95, 2) = 20000.0, (96, 1) = 28.636141420100497, (96, 2) = 20000.0, (97, 1) = 28.946356242211053, (97, 2) = 20000.0, (98, 1) = 29.255895753768844, (98, 2) = 20000.0, (99, 1) = 29.53372584723618, (99, 2) = 20000.0, (100, 1) = 29.862835628140704, (100, 2) = 20000.0, (101, 1) = 30.138219431155775, (101, 2) = 20000.0, (102, 1) = 30.46031172060301, (102, 2) = 20000.0, (103, 1) = 30.767717608040197, (103, 2) = 20000.0, (104, 1) = 31.042194449246228, (104, 2) = 20000.0, (105, 1) = 31.350872363819093, (105, 2) = 20000.0, (106, 1) = 31.661596395979895, (106, 2) = 20000.0, (107, 1) = 31.970843611055276, (107, 2) = 20000.0, (108, 1) = 32.25755536582914, (108, 2) = 20000.0, (109, 1) = 32.55442878090452, (109, 2) = 20000.0, (110, 1) = 32.86145569145728, (110, 2) = 20000.0, (111, 1) = 33.16749796281407, (111, 2) = 20000.0, (112, 1) = 33.4823000562814, (112, 2) = 20000.0, (113, 1) = 33.759577911557784, (113, 2) = 20000.0, (114, 1) = 34.07172710351758, (114, 2) = 20000.0, (115, 1) = 34.38515801005025, (115, 2) = 20000.0, (116, 1) = 34.687206765829146, (116, 2) = 20000.0, (117, 1) = 34.96149597286432, (117, 2) = 20000.0, (118, 1) = 35.28765236984924, (118, 2) = 20000.0, (119, 1) = 35.563949620100495, (119, 2) = 20000.0, (120, 1) = 35.88534900603015, (120, 2) = 20000.0, (121, 1) = 36.16984192160804, (121, 2) = 20000.0, (122, 1) = 36.48197573969849, (122, 2) = 20000.0, (123, 1) = 36.77920094773869, (123, 2) = 20000.0, (124, 1) = 37.08932427135678, (124, 2) = 20000.0, (125, 1) = 37.37411429246231, (125, 2) = 20000.0, (126, 1) = 37.6812988040201, (126, 2) = 20000.0, (127, 1) = 38.00037717889447, (127, 2) = 20000.0, (128, 1) = 38.27813584221106, (128, 2) = 20000.0, (129, 1) = 38.5781228080402, (129, 2) = 20000.0, (130, 1) = 38.88803869748743, (130, 2) = 20000.0, (131, 1) = 39.191230932663316, (131, 2) = 20000.0, (132, 1) = 39.484585010050246, (132, 2) = 20000.0, (133, 1) = 39.81030469748743, (133, 2) = 20000.0, (134, 1) = 40.10297832361809, (134, 2) = 20000.0, (135, 1) = 40.41546988944723, (135, 2) = 20000.0, (136, 1) = 40.69863369346733, (136, 2) = 20000.0, (137, 1) = 41.008206524623105, (137, 2) = 20000.0, (138, 1) = 41.29949043316583, (138, 2) = 20000.0, (139, 1) = 41.60396604723618, (139, 2) = 20000.0, (140, 1) = 41.90164661306532, (140, 2) = 20000.0, (141, 1) = 42.213290577889445, (141, 2) = 20000.0, (142, 1) = 42.51344075577889, (142, 2) = 20000.0, (143, 1) = 42.8203876643216, (143, 2) = 20000.0, (144, 1) = 43.12479289748743, (144, 2) = 20000.0, (145, 1) = 43.404509692462305, (145, 2) = 20000.0, (146, 1) = 43.72509670552763, (146, 2) = 20000.0, (147, 1) = 44.01183355175879, (147, 2) = 20000.0, (148, 1) = 44.31755483517587, (148, 2) = 20000.0, (149, 1) = 44.610169112562815, (149, 2) = 20000.0, (150, 1) = 44.93507966231155, (150, 2) = 20000.0, (151, 1) = 45.21642832462311, (151, 2) = 20000.0, (152, 1) = 45.53576157286432, (152, 2) = 20000.0, (153, 1) = 45.826799161809035, (153, 2) = 20000.0, (154, 1) = 46.14514854572864, (154, 2) = 20000.0, (155, 1) = 46.41983022512562, (155, 2) = 20000.0, (156, 1) = 46.73266059497487, (156, 2) = 20000.0, (157, 1) = 47.03483928844221, (157, 2) = 20000.0, (158, 1) = 47.33682057587939, (158, 2) = 20000.0, (159, 1) = 47.63769092864321, (159, 2) = 20000.0, (160, 1) = 47.92673314673367, (160, 2) = 20000.0, (161, 1) = 48.23919543919598, (161, 2) = 20000.0, (162, 1) = 48.5369946603015, (162, 2) = 20000.0, (163, 1) = 48.85041431758794, (163, 2) = 20000.0, (164, 1) = 49.134134580904515, (164, 2) = 20000.0, (165, 1) = 49.447698584924616, (165, 2) = 20000.0, (166, 1) = 49.748038260301506, (166, 2) = 20000.0, (167, 1) = 50.047646900502514, (167, 2) = 20000.0, (168, 1) = 50.36058928643215, (168, 2) = 20000.0, (169, 1) = 50.6488206482412, (169, 2) = 20000.0, (170, 1) = 50.94400898894472, (170, 2) = 20000.0, (171, 1) = 51.26993199195979, (171, 2) = 20000.0, (172, 1) = 51.56502857487437, (172, 2) = 20000.0, (173, 1) = 51.86682010552764, (173, 2) = 20000.0, (174, 1) = 52.17373431859296, (174, 2) = 20000.0, (175, 1) = 52.4558482040201, (175, 2) = 20000.0, (176, 1) = 52.756572470351756, (176, 2) = 20000.0, (177, 1) = 53.0550076040201, (177, 2) = 20000.0, (178, 1) = 53.374240432160796, (178, 2) = 20000.0, (179, 1) = 53.65594957386934, (179, 2) = 20000.0, (180, 1) = 53.980983443216076, (180, 2) = 20000.0, (181, 1) = 54.27430145125628, (181, 2) = 20000.0, (182, 1) = 54.56452428844221, (182, 2) = 20000.0, (183, 1) = 54.876607073366834, (183, 2) = 20000.0, (184, 1) = 55.18995229748743, (184, 2) = 20000.0, (185, 1) = 55.47505005527638, (185, 2) = 20000.0, (186, 1) = 55.777811210050245, (186, 2) = 20000.0, (187, 1) = 56.07327650653266, (187, 2) = 20000.0, (188, 1) = 56.39356400502512, (188, 2) = 20000.0, (189, 1) = 56.67070174070351, (189, 2) = 20000.0, (190, 1) = 56.98900450552763, (190, 2) = 20000.0, (191, 1) = 57.288225838190954, (191, 2) = 20000.0, (192, 1) = 57.58455701909548, (192, 2) = 20000.0, (193, 1) = 57.881123933668334, (193, 2) = 20000.0, (194, 1) = 58.18360341407034, (194, 2) = 20000.0, (195, 1) = 58.504226595979894, (195, 2) = 20000.0, (196, 1) = 58.79820665728643, (196, 2) = 20000.0, (197, 1) = 59.08840272663316, (197, 2) = 20000.0, (198, 1) = 59.398617548743715, (198, 2) = 20000.0, (199, 1) = 59.708157060301495, (199, 2) = 20000.0, (200, 1) = 60.0, (200, 2) = 20000.0}, datatype = float[8])), CURVES(Matrix(200, 2, {(1, 1) = .0, (1, 2) = 40000.0, (2, 1) = .3154563015075377, (2, 2) = 40000.0, (3, 1) = .5899331427135678, (3, 2) = 40000.0, (4, 1) = .8986110572864321, (4, 2) = 40000.0, (5, 1) = 1.2093350894472361, (5, 2) = 40000.0, (6, 1) = 1.5185823045226128, (6, 2) = 40000.0, (7, 1) = 1.8052940592964821, (7, 2) = 40000.0, (8, 1) = 2.102167474371859, (8, 2) = 40000.0, (9, 1) = 2.409194384924623, (9, 2) = 40000.0, (10, 1) = 2.7152366562814065, (10, 2) = 40000.0, (11, 1) = 3.0300387497487438, (11, 2) = 40000.0, (12, 1) = 3.3073166050251253, (12, 2) = 40000.0, (13, 1) = 3.6194657969849247, (13, 2) = 40000.0, (14, 1) = 3.9328967035175877, (14, 2) = 40000.0, (15, 1) = 4.234945459296482, (15, 2) = 40000.0, (16, 1) = 4.509234666331658, (16, 2) = 40000.0, (17, 1) = 4.835391063316583, (17, 2) = 40000.0, (18, 1) = 5.111688313567838, (18, 2) = 40000.0, (19, 1) = 5.433087699497487, (19, 2) = 40000.0, (20, 1) = 5.717580615075376, (20, 2) = 40000.0, (21, 1) = 6.029714433165829, (21, 2) = 40000.0, (22, 1) = 6.32693964120603, (22, 2) = 40000.0, (23, 1) = 6.63706296482412, (23, 2) = 40000.0, (24, 1) = 6.9218529859296485, (24, 2) = 40000.0, (25, 1) = 7.229037497487436, (25, 2) = 40000.0, (26, 1) = 7.548115872361809, (26, 2) = 40000.0, (27, 1) = 7.825874535678391, (27, 2) = 40000.0, (28, 1) = 8.125861501507536, (28, 2) = 40000.0, (29, 1) = 8.435777390954772, (29, 2) = 40000.0, (30, 1) = 8.738969626130652, (30, 2) = 40000.0, (31, 1) = 9.032323703517587, (31, 2) = 40000.0, (32, 1) = 9.358043390954773, (32, 2) = 40000.0, (33, 1) = 9.650717017085425, (33, 2) = 40000.0, (34, 1) = 9.963208582914572, (34, 2) = 40000.0, (35, 1) = 10.246372386934672, (35, 2) = 40000.0, (36, 1) = 10.555945218090452, (36, 2) = 40000.0, (37, 1) = 10.847229126633163, (37, 2) = 40000.0, (38, 1) = 11.151704740703517, (38, 2) = 40000.0, (39, 1) = 11.449385306532662, (39, 2) = 40000.0, (40, 1) = 11.761029271356783, (40, 2) = 40000.0, (41, 1) = 12.06117944924623, (41, 2) = 40000.0, (42, 1) = 12.368126357788944, (42, 2) = 40000.0, (43, 1) = 12.672531590954774, (43, 2) = 40000.0, (44, 1) = 12.952248385929648, (44, 2) = 40000.0, (45, 1) = 13.272835398994975, (45, 2) = 40000.0, (46, 1) = 13.55957224522613, (46, 2) = 40000.0, (47, 1) = 13.865293528643216, (47, 2) = 40000.0, (48, 1) = 14.157907806030149, (48, 2) = 40000.0, (49, 1) = 14.482818355778894, (49, 2) = 40000.0, (50, 1) = 14.76416701809045, (50, 2) = 40000.0, (51, 1) = 15.083500266331658, (51, 2) = 40000.0, (52, 1) = 15.374537855276381, (52, 2) = 40000.0, (53, 1) = 15.69288723919598, (53, 2) = 40000.0, (54, 1) = 15.967568918592962, (54, 2) = 40000.0, (55, 1) = 16.28039928844221, (55, 2) = 40000.0, (56, 1) = 16.582577981909548, (56, 2) = 40000.0, (57, 1) = 16.88455926934673, (57, 2) = 40000.0, (58, 1) = 17.18542962211055, (58, 2) = 40000.0, (59, 1) = 17.474471840201005, (59, 2) = 40000.0, (60, 1) = 17.786934132663315, (60, 2) = 40000.0, (61, 1) = 18.084733353768844, (61, 2) = 40000.0, (62, 1) = 18.398153011055275, (62, 2) = 40000.0, (63, 1) = 18.681873274371856, (63, 2) = 40000.0, (64, 1) = 18.995437278391957, (64, 2) = 40000.0, (65, 1) = 19.295776953768843, (65, 2) = 40000.0, (66, 1) = 19.595385593969848, (66, 2) = 40000.0, (67, 1) = 19.908327979899497, (67, 2) = 40000.0, (68, 1) = 20.19655934170854, (68, 2) = 40000.0, (69, 1) = 20.491747682412058, (69, 2) = 40000.0, (70, 1) = 20.817670685427135, (70, 2) = 40000.0, (71, 1) = 21.112767268341706, (71, 2) = 40000.0, (72, 1) = 21.414558798994975, (72, 2) = 40000.0, (73, 1) = 21.7214730120603, (73, 2) = 40000.0, (74, 1) = 22.003586897487438, (74, 2) = 40000.0, (75, 1) = 22.304311163819094, (75, 2) = 40000.0, (76, 1) = 22.602746297487435, (76, 2) = 40000.0, (77, 1) = 22.92197912562814, (77, 2) = 40000.0, (78, 1) = 23.20368826733668, (78, 2) = 40000.0, (79, 1) = 23.528722136683413, (79, 2) = 40000.0, (80, 1) = 23.822040144723616, (80, 2) = 40000.0, (81, 1) = 24.112262981909545, (81, 2) = 40000.0, (82, 1) = 24.42434576683417, (82, 2) = 40000.0, (83, 1) = 24.73769099095477, (83, 2) = 40000.0, (84, 1) = 25.022788748743714, (84, 2) = 40000.0, (85, 1) = 25.325549903517587, (85, 2) = 40000.0, (86, 1) = 25.6210152, (86, 2) = 40000.0, (87, 1) = 25.94130269849246, (87, 2) = 40000.0, (88, 1) = 26.21844043417085, (88, 2) = 40000.0, (89, 1) = 26.536743198994973, (89, 2) = 40000.0, (90, 1) = 26.835964531658288, (90, 2) = 40000.0, (91, 1) = 27.13229571256281, (91, 2) = 40000.0, (92, 1) = 27.428862627135675, (92, 2) = 40000.0, (93, 1) = 27.73134210753769, (93, 2) = 40000.0, (94, 1) = 28.05196528944723, (94, 2) = 40000.0, (95, 1) = 28.345945350753766, (95, 2) = 40000.0, (96, 1) = 28.636141420100497, (96, 2) = 40000.0, (97, 1) = 28.946356242211053, (97, 2) = 40000.0, (98, 1) = 29.255895753768844, (98, 2) = 40000.0, (99, 1) = 29.53372584723618, (99, 2) = 40000.0, (100, 1) = 29.862835628140704, (100, 2) = 40000.0, (101, 1) = 30.138219431155775, (101, 2) = 40000.0, (102, 1) = 30.46031172060301, (102, 2) = 40000.0, (103, 1) = 30.767717608040197, (103, 2) = 40000.0, (104, 1) = 31.042194449246228, (104, 2) = 40000.0, (105, 1) = 31.350872363819093, (105, 2) = 40000.0, (106, 1) = 31.661596395979895, (106, 2) = 40000.0, (107, 1) = 31.970843611055276, (107, 2) = 40000.0, (108, 1) = 32.25755536582914, (108, 2) = 40000.0, (109, 1) = 32.55442878090452, (109, 2) = 40000.0, (110, 1) = 32.86145569145728, (110, 2) = 40000.0, (111, 1) = 33.16749796281407, (111, 2) = 40000.0, (112, 1) = 33.4823000562814, (112, 2) = 40000.0, (113, 1) = 33.759577911557784, (113, 2) = 40000.0, (114, 1) = 34.07172710351758, (114, 2) = 40000.0, (115, 1) = 34.38515801005025, (115, 2) = 40000.0, (116, 1) = 34.687206765829146, (116, 2) = 40000.0, (117, 1) = 34.96149597286432, (117, 2) = 40000.0, (118, 1) = 35.28765236984924, (118, 2) = 40000.0, (119, 1) = 35.563949620100495, (119, 2) = 40000.0, (120, 1) = 35.88534900603015, (120, 2) = 40000.0, (121, 1) = 36.16984192160804, (121, 2) = 40000.0, (122, 1) = 36.48197573969849, (122, 2) = 40000.0, (123, 1) = 36.77920094773869, (123, 2) = 40000.0, (124, 1) = 37.08932427135678, (124, 2) = 40000.0, (125, 1) = 37.37411429246231, (125, 2) = 40000.0, (126, 1) = 37.6812988040201, (126, 2) = 40000.0, (127, 1) = 38.00037717889447, (127, 2) = 40000.0, (128, 1) = 38.27813584221106, (128, 2) = 40000.0, (129, 1) = 38.5781228080402, (129, 2) = 40000.0, (130, 1) = 38.88803869748743, (130, 2) = 40000.0, (131, 1) = 39.191230932663316, (131, 2) = 40000.0, (132, 1) = 39.484585010050246, (132, 2) = 40000.0, (133, 1) = 39.81030469748743, (133, 2) = 40000.0, (134, 1) = 40.10297832361809, (134, 2) = 40000.0, (135, 1) = 40.41546988944723, (135, 2) = 40000.0, (136, 1) = 40.69863369346733, (136, 2) = 40000.0, (137, 1) = 41.008206524623105, (137, 2) = 40000.0, (138, 1) = 41.29949043316583, (138, 2) = 40000.0, (139, 1) = 41.60396604723618, (139, 2) = 40000.0, (140, 1) = 41.90164661306532, (140, 2) = 40000.0, (141, 1) = 42.213290577889445, (141, 2) = 40000.0, (142, 1) = 42.51344075577889, (142, 2) = 40000.0, (143, 1) = 42.8203876643216, (143, 2) = 40000.0, (144, 1) = 43.12479289748743, (144, 2) = 40000.0, (145, 1) = 43.404509692462305, (145, 2) = 40000.0, (146, 1) = 43.72509670552763, (146, 2) = 40000.0, (147, 1) = 44.01183355175879, (147, 2) = 40000.0, (148, 1) = 44.31755483517587, (148, 2) = 40000.0, (149, 1) = 44.610169112562815, (149, 2) = 40000.0, (150, 1) = 44.93507966231155, (150, 2) = 40000.0, (151, 1) = 45.21642832462311, (151, 2) = 40000.0, (152, 1) = 45.53576157286432, (152, 2) = 40000.0, (153, 1) = 45.826799161809035, (153, 2) = 40000.0, (154, 1) = 46.14514854572864, (154, 2) = 40000.0, (155, 1) = 46.41983022512562, (155, 2) = 40000.0, (156, 1) = 46.73266059497487, (156, 2) = 40000.0, (157, 1) = 47.03483928844221, (157, 2) = 40000.0, (158, 1) = 47.33682057587939, (158, 2) = 40000.0, (159, 1) = 47.63769092864321, (159, 2) = 40000.0, (160, 1) = 47.92673314673367, (160, 2) = 40000.0, (161, 1) = 48.23919543919598, (161, 2) = 40000.0, (162, 1) = 48.5369946603015, (162, 2) = 40000.0, (163, 1) = 48.85041431758794, (163, 2) = 40000.0, (164, 1) = 49.134134580904515, (164, 2) = 40000.0, (165, 1) = 49.447698584924616, (165, 2) = 40000.0, (166, 1) = 49.748038260301506, (166, 2) = 40000.0, (167, 1) = 50.047646900502514, (167, 2) = 40000.0, (168, 1) = 50.36058928643215, (168, 2) = 40000.0, (169, 1) = 50.6488206482412, (169, 2) = 40000.0, (170, 1) = 50.94400898894472, (170, 2) = 40000.0, (171, 1) = 51.26993199195979, (171, 2) = 40000.0, (172, 1) = 51.56502857487437, (172, 2) = 40000.0, (173, 1) = 51.86682010552764, (173, 2) = 40000.0, (174, 1) = 52.17373431859296, (174, 2) = 40000.0, (175, 1) = 52.4558482040201, (175, 2) = 40000.0, (176, 1) = 52.756572470351756, (176, 2) = 40000.0, (177, 1) = 53.0550076040201, (177, 2) = 40000.0, (178, 1) = 53.374240432160796, (178, 2) = 40000.0, (179, 1) = 53.65594957386934, (179, 2) = 40000.0, (180, 1) = 53.980983443216076, (180, 2) = 40000.0, (181, 1) = 54.27430145125628, (181, 2) = 40000.0, (182, 1) = 54.56452428844221, (182, 2) = 40000.0, (183, 1) = 54.876607073366834, (183, 2) = 40000.0, (184, 1) = 55.18995229748743, (184, 2) = 40000.0, (185, 1) = 55.47505005527638, (185, 2) = 40000.0, (186, 1) = 55.777811210050245, (186, 2) = 40000.0, (187, 1) = 56.07327650653266, (187, 2) = 40000.0, (188, 1) = 56.39356400502512, (188, 2) = 40000.0, (189, 1) = 56.67070174070351, (189, 2) = 40000.0, (190, 1) = 56.98900450552763, (190, 2) = 40000.0, (191, 1) = 57.288225838190954, (191, 2) = 40000.0, (192, 1) = 57.58455701909548, (192, 2) = 40000.0, (193, 1) = 57.881123933668334, (193, 2) = 40000.0, (194, 1) = 58.18360341407034, (194, 2) = 40000.0, (195, 1) = 58.504226595979894, (195, 2) = 40000.0, (196, 1) = 58.79820665728643, (196, 2) = 40000.0, (197, 1) = 59.08840272663316, (197, 2) = 40000.0, (198, 1) = 59.398617548743715, (198, 2) = 40000.0, (199, 1) = 59.708157060301495, (199, 2) = 40000.0, (200, 1) = 60.0, (200, 2) = 40000.0}, datatype = float[8])), CURVES(Matrix(200, 2, {(1, 1) = .0, (1, 2) = 60000.0, (2, 1) = .3154563015075377, (2, 2) = 60000.0, (3, 1) = .5899331427135678, (3, 2) = 60000.0, (4, 1) = .8986110572864321, (4, 2) = 60000.0, (5, 1) = 1.2093350894472361, (5, 2) = 60000.0, (6, 1) = 1.5185823045226128, (6, 2) = 60000.0, (7, 1) = 1.8052940592964821, (7, 2) = 60000.0, (8, 1) = 2.102167474371859, (8, 2) = 60000.0, (9, 1) = 2.409194384924623, (9, 2) = 60000.0, (10, 1) = 2.7152366562814065, (10, 2) = 60000.0, (11, 1) = 3.0300387497487438, (11, 2) = 60000.0, (12, 1) = 3.3073166050251253, (12, 2) = 60000.0, (13, 1) = 3.6194657969849247, (13, 2) = 60000.0, (14, 1) = 3.9328967035175877, (14, 2) = 60000.0, (15, 1) = 4.234945459296482, (15, 2) = 60000.0, (16, 1) = 4.509234666331658, (16, 2) = 60000.0, (17, 1) = 4.835391063316583, (17, 2) = 60000.0, (18, 1) = 5.111688313567838, (18, 2) = 60000.0, (19, 1) = 5.433087699497487, (19, 2) = 60000.0, (20, 1) = 5.717580615075376, (20, 2) = 60000.0, (21, 1) = 6.029714433165829, (21, 2) = 60000.0, (22, 1) = 6.32693964120603, (22, 2) = 60000.0, (23, 1) = 6.63706296482412, (23, 2) = 60000.0, (24, 1) = 6.9218529859296485, (24, 2) = 60000.0, (25, 1) = 7.229037497487436, (25, 2) = 60000.0, (26, 1) = 7.548115872361809, (26, 2) = 60000.0, (27, 1) = 7.825874535678391, (27, 2) = 60000.0, (28, 1) = 8.125861501507536, (28, 2) = 60000.0, (29, 1) = 8.435777390954772, (29, 2) = 60000.0, (30, 1) = 8.738969626130652, (30, 2) = 60000.0, (31, 1) = 9.032323703517587, (31, 2) = 60000.0, (32, 1) = 9.358043390954773, (32, 2) = 60000.0, (33, 1) = 9.650717017085425, (33, 2) = 60000.0, (34, 1) = 9.963208582914572, (34, 2) = 60000.0, (35, 1) = 10.246372386934672, (35, 2) = 60000.0, (36, 1) = 10.555945218090452, (36, 2) = 60000.0, (37, 1) = 10.847229126633163, (37, 2) = 60000.0, (38, 1) = 11.151704740703517, (38, 2) = 60000.0, (39, 1) = 11.449385306532662, (39, 2) = 60000.0, (40, 1) = 11.761029271356783, (40, 2) = 60000.0, (41, 1) = 12.06117944924623, (41, 2) = 60000.0, (42, 1) = 12.368126357788944, (42, 2) = 60000.0, (43, 1) = 12.672531590954774, (43, 2) = 60000.0, (44, 1) = 12.952248385929648, (44, 2) = 60000.0, (45, 1) = 13.272835398994975, (45, 2) = 60000.0, (46, 1) = 13.55957224522613, (46, 2) = 60000.0, (47, 1) = 13.865293528643216, (47, 2) = 60000.0, (48, 1) = 14.157907806030149, (48, 2) = 60000.0, (49, 1) = 14.482818355778894, (49, 2) = 60000.0, (50, 1) = 14.76416701809045, (50, 2) = 60000.0, (51, 1) = 15.083500266331658, (51, 2) = 60000.0, (52, 1) = 15.374537855276381, (52, 2) = 60000.0, (53, 1) = 15.69288723919598, (53, 2) = 60000.0, (54, 1) = 15.967568918592962, (54, 2) = 60000.0, (55, 1) = 16.28039928844221, (55, 2) = 60000.0, (56, 1) = 16.582577981909548, (56, 2) = 60000.0, (57, 1) = 16.88455926934673, (57, 2) = 60000.0, (58, 1) = 17.18542962211055, (58, 2) = 60000.0, (59, 1) = 17.474471840201005, (59, 2) = 60000.0, (60, 1) = 17.786934132663315, (60, 2) = 60000.0, (61, 1) = 18.084733353768844, (61, 2) = 60000.0, (62, 1) = 18.398153011055275, (62, 2) = 60000.0, (63, 1) = 18.681873274371856, (63, 2) = 60000.0, (64, 1) = 18.995437278391957, (64, 2) = 60000.0, (65, 1) = 19.295776953768843, (65, 2) = 60000.0, (66, 1) = 19.595385593969848, (66, 2) = 60000.0, (67, 1) = 19.908327979899497, (67, 2) = 60000.0, (68, 1) = 20.19655934170854, (68, 2) = 60000.0, (69, 1) = 20.491747682412058, (69, 2) = 60000.0, (70, 1) = 20.817670685427135, (70, 2) = 60000.0, (71, 1) = 21.112767268341706, (71, 2) = 60000.0, (72, 1) = 21.414558798994975, (72, 2) = 60000.0, (73, 1) = 21.7214730120603, (73, 2) = 60000.0, (74, 1) = 22.003586897487438, (74, 2) = 60000.0, (75, 1) = 22.304311163819094, (75, 2) = 60000.0, (76, 1) = 22.602746297487435, (76, 2) = 60000.0, (77, 1) = 22.92197912562814, (77, 2) = 60000.0, (78, 1) = 23.20368826733668, (78, 2) = 60000.0, (79, 1) = 23.528722136683413, (79, 2) = 60000.0, (80, 1) = 23.822040144723616, (80, 2) = 60000.0, (81, 1) = 24.112262981909545, (81, 2) = 60000.0, (82, 1) = 24.42434576683417, (82, 2) = 60000.0, (83, 1) = 24.73769099095477, (83, 2) = 60000.0, (84, 1) = 25.022788748743714, (84, 2) = 60000.0, (85, 1) = 25.325549903517587, (85, 2) = 60000.0, (86, 1) = 25.6210152, (86, 2) = 60000.0, (87, 1) = 25.94130269849246, (87, 2) = 60000.0, (88, 1) = 26.21844043417085, (88, 2) = 60000.0, (89, 1) = 26.536743198994973, (89, 2) = 60000.0, (90, 1) = 26.835964531658288, (90, 2) = 60000.0, (91, 1) = 27.13229571256281, (91, 2) = 60000.0, (92, 1) = 27.428862627135675, (92, 2) = 60000.0, (93, 1) = 27.73134210753769, (93, 2) = 60000.0, (94, 1) = 28.05196528944723, (94, 2) = 60000.0, (95, 1) = 28.345945350753766, (95, 2) = 60000.0, (96, 1) = 28.636141420100497, (96, 2) = 60000.0, (97, 1) = 28.946356242211053, (97, 2) = 60000.0, (98, 1) = 29.255895753768844, (98, 2) = 60000.0, (99, 1) = 29.53372584723618, (99, 2) = 60000.0, (100, 1) = 29.862835628140704, (100, 2) = 60000.0, (101, 1) = 30.138219431155775, (101, 2) = 60000.0, (102, 1) = 30.46031172060301, (102, 2) = 60000.0, (103, 1) = 30.767717608040197, (103, 2) = 60000.0, (104, 1) = 31.042194449246228, (104, 2) = 60000.0, (105, 1) = 31.350872363819093, (105, 2) = 60000.0, (106, 1) = 31.661596395979895, (106, 2) = 60000.0, (107, 1) = 31.970843611055276, (107, 2) = 60000.0, (108, 1) = 32.25755536582914, (108, 2) = 60000.0, (109, 1) = 32.55442878090452, (109, 2) = 60000.0, (110, 1) = 32.86145569145728, (110, 2) = 60000.0, (111, 1) = 33.16749796281407, (111, 2) = 60000.0, (112, 1) = 33.4823000562814, (112, 2) = 60000.0, (113, 1) = 33.759577911557784, (113, 2) = 60000.0, (114, 1) = 34.07172710351758, (114, 2) = 60000.0, (115, 1) = 34.38515801005025, (115, 2) = 60000.0, (116, 1) = 34.687206765829146, (116, 2) = 60000.0, (117, 1) = 34.96149597286432, (117, 2) = 60000.0, (118, 1) = 35.28765236984924, (118, 2) = 60000.0, (119, 1) = 35.563949620100495, (119, 2) = 60000.0, (120, 1) = 35.88534900603015, (120, 2) = 60000.0, (121, 1) = 36.16984192160804, (121, 2) = 60000.0, (122, 1) = 36.48197573969849, (122, 2) = 60000.0, (123, 1) = 36.77920094773869, (123, 2) = 60000.0, (124, 1) = 37.08932427135678, (124, 2) = 60000.0, (125, 1) = 37.37411429246231, (125, 2) = 60000.0, (126, 1) = 37.6812988040201, (126, 2) = 60000.0, (127, 1) = 38.00037717889447, (127, 2) = 60000.0, (128, 1) = 38.27813584221106, (128, 2) = 60000.0, (129, 1) = 38.5781228080402, (129, 2) = 60000.0, (130, 1) = 38.88803869748743, (130, 2) = 60000.0, (131, 1) = 39.191230932663316, (131, 2) = 60000.0, (132, 1) = 39.484585010050246, (132, 2) = 60000.0, (133, 1) = 39.81030469748743, (133, 2) = 60000.0, (134, 1) = 40.10297832361809, (134, 2) = 60000.0, (135, 1) = 40.41546988944723, (135, 2) = 60000.0, (136, 1) = 40.69863369346733, (136, 2) = 60000.0, (137, 1) = 41.008206524623105, (137, 2) = 60000.0, (138, 1) = 41.29949043316583, (138, 2) = 60000.0, (139, 1) = 41.60396604723618, (139, 2) = 60000.0, (140, 1) = 41.90164661306532, (140, 2) = 60000.0, (141, 1) = 42.213290577889445, (141, 2) = 60000.0, (142, 1) = 42.51344075577889, (142, 2) = 60000.0, (143, 1) = 42.8203876643216, (143, 2) = 60000.0, (144, 1) = 43.12479289748743, (144, 2) = 60000.0, (145, 1) = 43.404509692462305, (145, 2) = 60000.0, (146, 1) = 43.72509670552763, (146, 2) = 60000.0, (147, 1) = 44.01183355175879, (147, 2) = 60000.0, (148, 1) = 44.31755483517587, (148, 2) = 60000.0, (149, 1) = 44.610169112562815, (149, 2) = 60000.0, (150, 1) = 44.93507966231155, (150, 2) = 60000.0, (151, 1) = 45.21642832462311, (151, 2) = 60000.0, (152, 1) = 45.53576157286432, (152, 2) = 60000.0, (153, 1) = 45.826799161809035, (153, 2) = 60000.0, (154, 1) = 46.14514854572864, (154, 2) = 60000.0, (155, 1) = 46.41983022512562, (155, 2) = 60000.0, (156, 1) = 46.73266059497487, (156, 2) = 60000.0, (157, 1) = 47.03483928844221, (157, 2) = 60000.0, (158, 1) = 47.33682057587939, (158, 2) = 60000.0, (159, 1) = 47.63769092864321, (159, 2) = 60000.0, (160, 1) = 47.92673314673367, (160, 2) = 60000.0, (161, 1) = 48.23919543919598, (161, 2) = 60000.0, (162, 1) = 48.5369946603015, (162, 2) = 60000.0, (163, 1) = 48.85041431758794, (163, 2) = 60000.0, (164, 1) = 49.134134580904515, (164, 2) = 60000.0, (165, 1) = 49.447698584924616, (165, 2) = 60000.0, (166, 1) = 49.748038260301506, (166, 2) = 60000.0, (167, 1) = 50.047646900502514, (167, 2) = 60000.0, (168, 1) = 50.36058928643215, (168, 2) = 60000.0, (169, 1) = 50.6488206482412, (169, 2) = 60000.0, (170, 1) = 50.94400898894472, (170, 2) = 60000.0, (171, 1) = 51.26993199195979, (171, 2) = 60000.0, (172, 1) = 51.56502857487437, (172, 2) = 60000.0, (173, 1) = 51.86682010552764, (173, 2) = 60000.0, (174, 1) = 52.17373431859296, (174, 2) = 60000.0, (175, 1) = 52.4558482040201, (175, 2) = 60000.0, (176, 1) = 52.756572470351756, (176, 2) = 60000.0, (177, 1) = 53.0550076040201, (177, 2) = 60000.0, (178, 1) = 53.374240432160796, (178, 2) = 60000.0, (179, 1) = 53.65594957386934, (179, 2) = 60000.0, (180, 1) = 53.980983443216076, (180, 2) = 60000.0, (181, 1) = 54.27430145125628, (181, 2) = 60000.0, (182, 1) = 54.56452428844221, (182, 2) = 60000.0, (183, 1) = 54.876607073366834, (183, 2) = 60000.0, (184, 1) = 55.18995229748743, (184, 2) = 60000.0, (185, 1) = 55.47505005527638, (185, 2) = 60000.0, (186, 1) = 55.777811210050245, (186, 2) = 60000.0, (187, 1) = 56.07327650653266, (187, 2) = 60000.0, (188, 1) = 56.39356400502512, (188, 2) = 60000.0, (189, 1) = 56.67070174070351, (189, 2) = 60000.0, (190, 1) = 56.98900450552763, (190, 2) = 60000.0, (191, 1) = 57.288225838190954, (191, 2) = 60000.0, (192, 1) = 57.58455701909548, (192, 2) = 60000.0, (193, 1) = 57.881123933668334, (193, 2) = 60000.0, (194, 1) = 58.18360341407034, (194, 2) = 60000.0, (195, 1) = 58.504226595979894, (195, 2) = 60000.0, (196, 1) = 58.79820665728643, (196, 2) = 60000.0, (197, 1) = 59.08840272663316, (197, 2) = 60000.0, (198, 1) = 59.398617548743715, (198, 2) = 60000.0, (199, 1) = 59.708157060301495, (199, 2) = 60000.0, (200, 1) = 60.0, (200, 2) = 60000.0}, datatype = float[8])), CURVES(Matrix(200, 2, {(1, 1) = .0, (1, 2) = 80000.0, (2, 1) = .3154563015075377, (2, 2) = 80000.0, (3, 1) = .5899331427135678, (3, 2) = 80000.0, (4, 1) = .8986110572864321, (4, 2) = 80000.0, (5, 1) = 1.2093350894472361, (5, 2) = 80000.0, (6, 1) = 1.5185823045226128, (6, 2) = 80000.0, (7, 1) = 1.8052940592964821, (7, 2) = 80000.0, (8, 1) = 2.102167474371859, (8, 2) = 80000.0, (9, 1) = 2.409194384924623, (9, 2) = 80000.0, (10, 1) = 2.7152366562814065, (10, 2) = 80000.0, (11, 1) = 3.0300387497487438, (11, 2) = 80000.0, (12, 1) = 3.3073166050251253, (12, 2) = 80000.0, (13, 1) = 3.6194657969849247, (13, 2) = 80000.0, (14, 1) = 3.9328967035175877, (14, 2) = 80000.0, (15, 1) = 4.234945459296482, (15, 2) = 80000.0, (16, 1) = 4.509234666331658, (16, 2) = 80000.0, (17, 1) = 4.835391063316583, (17, 2) = 80000.0, (18, 1) = 5.111688313567838, (18, 2) = 80000.0, (19, 1) = 5.433087699497487, (19, 2) = 80000.0, (20, 1) = 5.717580615075376, (20, 2) = 80000.0, (21, 1) = 6.029714433165829, (21, 2) = 80000.0, (22, 1) = 6.32693964120603, (22, 2) = 80000.0, (23, 1) = 6.63706296482412, (23, 2) = 80000.0, (24, 1) = 6.9218529859296485, (24, 2) = 80000.0, (25, 1) = 7.229037497487436, (25, 2) = 80000.0, (26, 1) = 7.548115872361809, (26, 2) = 80000.0, (27, 1) = 7.825874535678391, (27, 2) = 80000.0, (28, 1) = 8.125861501507536, (28, 2) = 80000.0, (29, 1) = 8.435777390954772, (29, 2) = 80000.0, (30, 1) = 8.738969626130652, (30, 2) = 80000.0, (31, 1) = 9.032323703517587, (31, 2) = 80000.0, (32, 1) = 9.358043390954773, (32, 2) = 80000.0, (33, 1) = 9.650717017085425, (33, 2) = 80000.0, (34, 1) = 9.963208582914572, (34, 2) = 80000.0, (35, 1) = 10.246372386934672, (35, 2) = 80000.0, (36, 1) = 10.555945218090452, (36, 2) = 80000.0, (37, 1) = 10.847229126633163, (37, 2) = 80000.0, (38, 1) = 11.151704740703517, (38, 2) = 80000.0, (39, 1) = 11.449385306532662, (39, 2) = 80000.0, (40, 1) = 11.761029271356783, (40, 2) = 80000.0, (41, 1) = 12.06117944924623, (41, 2) = 80000.0, (42, 1) = 12.368126357788944, (42, 2) = 80000.0, (43, 1) = 12.672531590954774, (43, 2) = 80000.0, (44, 1) = 12.952248385929648, (44, 2) = 80000.0, (45, 1) = 13.272835398994975, (45, 2) = 80000.0, (46, 1) = 13.55957224522613, (46, 2) = 80000.0, (47, 1) = 13.865293528643216, (47, 2) = 80000.0, (48, 1) = 14.157907806030149, (48, 2) = 80000.0, (49, 1) = 14.482818355778894, (49, 2) = 80000.0, (50, 1) = 14.76416701809045, (50, 2) = 80000.0, (51, 1) = 15.083500266331658, (51, 2) = 80000.0, (52, 1) = 15.374537855276381, (52, 2) = 80000.0, (53, 1) = 15.69288723919598, (53, 2) = 80000.0, (54, 1) = 15.967568918592962, (54, 2) = 80000.0, (55, 1) = 16.28039928844221, (55, 2) = 80000.0, (56, 1) = 16.582577981909548, (56, 2) = 80000.0, (57, 1) = 16.88455926934673, (57, 2) = 80000.0, (58, 1) = 17.18542962211055, (58, 2) = 80000.0, (59, 1) = 17.474471840201005, (59, 2) = 80000.0, (60, 1) = 17.786934132663315, (60, 2) = 80000.0, (61, 1) = 18.084733353768844, (61, 2) = 80000.0, (62, 1) = 18.398153011055275, (62, 2) = 80000.0, (63, 1) = 18.681873274371856, (63, 2) = 80000.0, (64, 1) = 18.995437278391957, (64, 2) = 80000.0, (65, 1) = 19.295776953768843, (65, 2) = 80000.0, (66, 1) = 19.595385593969848, (66, 2) = 80000.0, (67, 1) = 19.908327979899497, (67, 2) = 80000.0, (68, 1) = 20.19655934170854, (68, 2) = 80000.0, (69, 1) = 20.491747682412058, (69, 2) = 80000.0, (70, 1) = 20.817670685427135, (70, 2) = 80000.0, (71, 1) = 21.112767268341706, (71, 2) = 80000.0, (72, 1) = 21.414558798994975, (72, 2) = 80000.0, (73, 1) = 21.7214730120603, (73, 2) = 80000.0, (74, 1) = 22.003586897487438, (74, 2) = 80000.0, (75, 1) = 22.304311163819094, (75, 2) = 80000.0, (76, 1) = 22.602746297487435, (76, 2) = 80000.0, (77, 1) = 22.92197912562814, (77, 2) = 80000.0, (78, 1) = 23.20368826733668, (78, 2) = 80000.0, (79, 1) = 23.528722136683413, (79, 2) = 80000.0, (80, 1) = 23.822040144723616, (80, 2) = 80000.0, (81, 1) = 24.112262981909545, (81, 2) = 80000.0, (82, 1) = 24.42434576683417, (82, 2) = 80000.0, (83, 1) = 24.73769099095477, (83, 2) = 80000.0, (84, 1) = 25.022788748743714, (84, 2) = 80000.0, (85, 1) = 25.325549903517587, (85, 2) = 80000.0, (86, 1) = 25.6210152, (86, 2) = 80000.0, (87, 1) = 25.94130269849246, (87, 2) = 80000.0, (88, 1) = 26.21844043417085, (88, 2) = 80000.0, (89, 1) = 26.536743198994973, (89, 2) = 80000.0, (90, 1) = 26.835964531658288, (90, 2) = 80000.0, (91, 1) = 27.13229571256281, (91, 2) = 80000.0, (92, 1) = 27.428862627135675, (92, 2) = 80000.0, (93, 1) = 27.73134210753769, (93, 2) = 80000.0, (94, 1) = 28.05196528944723, (94, 2) = 80000.0, (95, 1) = 28.345945350753766, (95, 2) = 80000.0, (96, 1) = 28.636141420100497, (96, 2) = 80000.0, (97, 1) = 28.946356242211053, (97, 2) = 80000.0, (98, 1) = 29.255895753768844, (98, 2) = 80000.0, (99, 1) = 29.53372584723618, (99, 2) = 80000.0, (100, 1) = 29.862835628140704, (100, 2) = 80000.0, (101, 1) = 30.138219431155775, (101, 2) = 80000.0, (102, 1) = 30.46031172060301, (102, 2) = 80000.0, (103, 1) = 30.767717608040197, (103, 2) = 80000.0, (104, 1) = 31.042194449246228, (104, 2) = 80000.0, (105, 1) = 31.350872363819093, (105, 2) = 80000.0, (106, 1) = 31.661596395979895, (106, 2) = 80000.0, (107, 1) = 31.970843611055276, (107, 2) = 80000.0, (108, 1) = 32.25755536582914, (108, 2) = 80000.0, (109, 1) = 32.55442878090452, (109, 2) = 80000.0, (110, 1) = 32.86145569145728, (110, 2) = 80000.0, (111, 1) = 33.16749796281407, (111, 2) = 80000.0, (112, 1) = 33.4823000562814, (112, 2) = 80000.0, (113, 1) = 33.759577911557784, (113, 2) = 80000.0, (114, 1) = 34.07172710351758, (114, 2) = 80000.0, (115, 1) = 34.38515801005025, (115, 2) = 80000.0, (116, 1) = 34.687206765829146, (116, 2) = 80000.0, (117, 1) = 34.96149597286432, (117, 2) = 80000.0, (118, 1) = 35.28765236984924, (118, 2) = 80000.0, (119, 1) = 35.563949620100495, (119, 2) = 80000.0, (120, 1) = 35.88534900603015, (120, 2) = 80000.0, (121, 1) = 36.16984192160804, (121, 2) = 80000.0, (122, 1) = 36.48197573969849, (122, 2) = 80000.0, (123, 1) = 36.77920094773869, (123, 2) = 80000.0, (124, 1) = 37.08932427135678, (124, 2) = 80000.0, (125, 1) = 37.37411429246231, (125, 2) = 80000.0, (126, 1) = 37.6812988040201, (126, 2) = 80000.0, (127, 1) = 38.00037717889447, (127, 2) = 80000.0, (128, 1) = 38.27813584221106, (128, 2) = 80000.0, (129, 1) = 38.5781228080402, (129, 2) = 80000.0, (130, 1) = 38.88803869748743, (130, 2) = 80000.0, (131, 1) = 39.191230932663316, (131, 2) = 80000.0, (132, 1) = 39.484585010050246, (132, 2) = 80000.0, (133, 1) = 39.81030469748743, (133, 2) = 80000.0, (134, 1) = 40.10297832361809, (134, 2) = 80000.0, (135, 1) = 40.41546988944723, (135, 2) = 80000.0, (136, 1) = 40.69863369346733, (136, 2) = 80000.0, (137, 1) = 41.008206524623105, (137, 2) = 80000.0, (138, 1) = 41.29949043316583, (138, 2) = 80000.0, (139, 1) = 41.60396604723618, (139, 2) = 80000.0, (140, 1) = 41.90164661306532, (140, 2) = 80000.0, (141, 1) = 42.213290577889445, (141, 2) = 80000.0, (142, 1) = 42.51344075577889, (142, 2) = 80000.0, (143, 1) = 42.8203876643216, (143, 2) = 80000.0, (144, 1) = 43.12479289748743, (144, 2) = 80000.0, (145, 1) = 43.404509692462305, (145, 2) = 80000.0, (146, 1) = 43.72509670552763, (146, 2) = 80000.0, (147, 1) = 44.01183355175879, (147, 2) = 80000.0, (148, 1) = 44.31755483517587, (148, 2) = 80000.0, (149, 1) = 44.610169112562815, (149, 2) = 80000.0, (150, 1) = 44.93507966231155, (150, 2) = 80000.0, (151, 1) = 45.21642832462311, (151, 2) = 80000.0, (152, 1) = 45.53576157286432, (152, 2) = 80000.0, (153, 1) = 45.826799161809035, (153, 2) = 80000.0, (154, 1) = 46.14514854572864, (154, 2) = 80000.0, (155, 1) = 46.41983022512562, (155, 2) = 80000.0, (156, 1) = 46.73266059497487, (156, 2) = 80000.0, (157, 1) = 47.03483928844221, (157, 2) = 80000.0, (158, 1) = 47.33682057587939, (158, 2) = 80000.0, (159, 1) = 47.63769092864321, (159, 2) = 80000.0, (160, 1) = 47.92673314673367, (160, 2) = 80000.0, (161, 1) = 48.23919543919598, (161, 2) = 80000.0, (162, 1) = 48.5369946603015, (162, 2) = 80000.0, (163, 1) = 48.85041431758794, (163, 2) = 80000.0, (164, 1) = 49.134134580904515, (164, 2) = 80000.0, (165, 1) = 49.447698584924616, (165, 2) = 80000.0, (166, 1) = 49.748038260301506, (166, 2) = 80000.0, (167, 1) = 50.047646900502514, (167, 2) = 80000.0, (168, 1) = 50.36058928643215, (168, 2) = 80000.0, (169, 1) = 50.6488206482412, (169, 2) = 80000.0, (170, 1) = 50.94400898894472, (170, 2) = 80000.0, (171, 1) = 51.26993199195979, (171, 2) = 80000.0, (172, 1) = 51.56502857487437, (172, 2) = 80000.0, (173, 1) = 51.86682010552764, (173, 2) = 80000.0, (174, 1) = 52.17373431859296, (174, 2) = 80000.0, (175, 1) = 52.4558482040201, (175, 2) = 80000.0, (176, 1) = 52.756572470351756, (176, 2) = 80000.0, (177, 1) = 53.0550076040201, (177, 2) = 80000.0, (178, 1) = 53.374240432160796, (178, 2) = 80000.0, (179, 1) = 53.65594957386934, (179, 2) = 80000.0, (180, 1) = 53.980983443216076, (180, 2) = 80000.0, (181, 1) = 54.27430145125628, (181, 2) = 80000.0, (182, 1) = 54.56452428844221, (182, 2) = 80000.0, (183, 1) = 54.876607073366834, (183, 2) = 80000.0, (184, 1) = 55.18995229748743, (184, 2) = 80000.0, (185, 1) = 55.47505005527638, (185, 2) = 80000.0, (186, 1) = 55.777811210050245, (186, 2) = 80000.0, (187, 1) = 56.07327650653266, (187, 2) = 80000.0, (188, 1) = 56.39356400502512, (188, 2) = 80000.0, (189, 1) = 56.67070174070351, (189, 2) = 80000.0, (190, 1) = 56.98900450552763, (190, 2) = 80000.0, (191, 1) = 57.288225838190954, (191, 2) = 80000.0, (192, 1) = 57.58455701909548, (192, 2) = 80000.0, (193, 1) = 57.881123933668334, (193, 2) = 80000.0, (194, 1) = 58.18360341407034, (194, 2) = 80000.0, (195, 1) = 58.504226595979894, (195, 2) = 80000.0, (196, 1) = 58.79820665728643, (196, 2) = 80000.0, (197, 1) = 59.08840272663316, (197, 2) = 80000.0, (198, 1) = 59.398617548743715, (198, 2) = 80000.0, (199, 1) = 59.708157060301495, (199, 2) = 80000.0, (200, 1) = 60.0, (200, 2) = 80000.0}, datatype = float[8])), COLOUR(RGB, .90196078, .90196078, .90196078), THICKNESS(0), AXESLABELS(x, ""), VIEW(0. .. 60., DEFAULT, _ATTRIBUTE("source" = "mathdefault")))

(7)

plots:-display(a3, b3, title = "Total Deaths \n (Linear scale)\n", titlefont = ["Helvetica", 18], size = [681, 400])

 

My guess is it was Dr. Fauci's hope that it would only go to 60,000 but it was also his interpretation of the log graph.  It could start to round a peak at some point and it will eventually, however based on the way people behave in North America and there will apparently be no complete lockdown, in my humble opinion, that graph is going to keep on sailing well passed 100,000.

 

 

NULL


 

Download log_misinterpretation2.mw

One of the forums asked a question: what is the maximum area of a triangle inscribed in a given ellipse x^2/16 + y^2/3 - 1 = 0? It turned out to be 9, but there are infinitely many such triangles. There was a desire to show them in one of the possible ways. This is a complete (as far as possible) set of such triangles.
(This is not an example of Maple programming; it is just an implementation of a Maple-based algorithm and the work of the Optimization package).
MAX_S_TRIAN_ANINATION.mw

This app shows the modeling and simulation of DNA carried out entirely in Maple. The mathematical model is inserted through the combination of trigonometric functions. It shows the graphs of the curvature vs time for its interpretation. Made for engineering and health science students.

MV_AC_R3_UNI_2020.mw

Lenin Araujo Castillo

Ambassador of Maple

 

 

First 13 14 15 16 17 18 19 Last Page 15 of 71