tomleslie

13876 Reputation

20 Badges

15 years, 173 days

MaplePrimes Activity


These are answers submitted by tomleslie

Maple 7 was superseded seventeen years ago, so I doubt if anyone here still has a copy: I certainly don't! I only have Maple releases going back five years, so I can't test anything for your release - just make some suggestions which you can try

  1. If the [$65..95] construct is casing a problem - don't use it. The construct [seq(i, i=65..95)] *ought* to do the same thiing
  2. Although the convert(...., `bytes`) command appears to work, I notice from the AMple update history that the StringTools package was introduced in Maple 7 and this contains specific commands for converting integers to letters and vice versa. Thus the construct [seq(StringTools[Char](i), i=65..95)] *ought to do exactly the same as convert( [$65..95], 'bytes' ). And possibly without the "Error" massage?!
  3. The warnng messages about the redefnition of "changecoords" and "arrow" are not cause by anything in this worksheet. I can only assume that these arise because of code you have in your Maple initialisation file (maple.ini). If you want to get rid of these warning messages you will need to locate/edit this initialisation file. Depending on your installation, the relevant file could be in a variety of locations. Try typing "?worksheet,reference,installation" or "?maple.ini" (without the quotes) at the Maple prompt and you ought to get some idea where your maple.ini file is located

     

If I take the fastest code I had in my earlier answer and increase the size of the problem by 10X to nelems=10000000, then this sequential code takes about 55secs on my machine (compared with ~6secs for nelems=1000000, so execution time looks pretty linear with size

If I parallelize the code into 4 Tasks, then the same size problem (ie nelems=10000000), then the execution time drops to ~23secs on my machine. (Parallelized code is a bit rough, I was in a hurry - sorry)

So a further 2.5X speed-up

Check the attached - be aware that total execution times is about 85 secs (on my machine)

#
# Using the fastest sequential code I cam up with
# with nelems=10000000. Takes about 55 secs on my
# machine
#
  restart;
  nelems := 10000000:
  n := 374894756873546859847556:
  op(n):
  A := Array(1 .. 4, 1 .. nelems):
  length(n):
  st := time[real]():
  A[1,1..nelems]:= Array([seq( i^10*n, i=1..nelems)]):
  A[2,1..nelems]:= Array([seq( length(A[1, i])-1, i=1..nelems)]):
  A[3,1..nelems]:= Array([seq(iquo(A[1,i], 10^(A[2, i]-2)),i=1..nelems)]):
  A[4,1..nelems]:= Array([seq(irem(A[1,i],1000),i=1..nelems)]):
  time[real]() - st;
  A:
  A[1, -2];
  A[2, -2];
  A[3, -2];
  A[4, -2];

55.113

 

3748943819789586888963018855788947266280687433550338920856680612859778836854072888791259847556

 

93

 

374

 

556

(1)

#
# Parallelize the above across four tasks, Takes about
# 23 secs on my machine, so a speed up of 2.5X on the
# above sequential code
#
  restart;
  nelems := 10000000:
  n := 374894756873546859847556:
  op(n):
  length(n):
  st := time():
  doTask:=proc(sv, nv)
               local rng:=nv-sv+1,
                     B:=Array(1..4,1..nv-sv+1),
                     i :
               B[1,1..rng]:= Array([seq( (sv-1+i)^10*n, i=1..rng)]):
               B[2,1..rng]:= Array([seq( length(B[1, i])-1, i=1..rng)]):
               B[3,1..rng]:= Array([seq(iquo(B[1,i], 10^(B[2, i]-2)),i=1..rng)]):
               B[4,1..rng]:= Array([seq(irem(B[1,i],1000),i=1..nv-sv+1)]):
               return B;
         end proc:
  time() - st;
  contTask:=proc( V,W,X,Y )
                  return copy(ArrayTools:-Concatenate(2, V, W, X, Y)):
           end proc:
                  
  setupTask:=proc(n)
                  Threads:-Task:-Continue
                  ( contTask,
                    Task=[doTask, 1, n/4 ],
                    Task=[doTask, n/4+1, n/2],
                    Task=[doTask, n/2+1, 3*n/4],
                    Task=[doTask, 3*n/4+1, n]
                  );
            end proc:

  st := time[real]():
  A:=Threads:-Task:-Start( setupTask, nelems):
  time[real]() - st;
  A[1, -2];
  A[2, -2];
  A[3, -2];
  A[4, -2];

 

0.

 

24.836

 

3748943819789586888963018855788947266280687433550338920856680612859778836854072888791259847556

 

93

 

374

 

556

(2)

interface(rtablesize=10);

[10, 10]

(3)

 

Download speedUP2.mw

 

 

 

I'm pretty sure that any Matrix initialiser function which takes two arguments can be used.

For example, the following

#
# Consider an initialiser function
# which takes two arguments
#
  f:=(x,y)->x+y;
  Matrix(3, 3, f);

will "work".

When you use eg `+`, this is just the "prefix form" of the + operator, and will accept two (or more) arguments. So for example

`+`(1,2,3,4,5,6);

will correctly reurn 21

that this is a version issue, because I see the same problem in my Maple 2018.2 installation - see the attached.

It seems to be a "bug" in odetest(), which got "fixed" with the release of Maple 2019

Using Maple 2018.2, one can check validity without using odetest().  Just substitute the proposed solutions into the original ODEs/boundary conditions. This confirms that the solutions are OK, so the problem must be with odetest()..

See the attached.

#
# Initialize and show version: possibly a version
# Maple issue on this problem
#
  restart:
  kernelopts(version);
  Physics:-Version();

`Maple 2018.2, X86 64 WINDOWS, Nov 16 2018, Build ID 1362973`

 

"C:\Users\TomLeslie\maple\toolbox\2018\Physics Updates\lib\Physics Updates.maple", `2019, March 14, 23:22 hours, version in the MapleCloud: 341, version installed in this computer: 326.`

(1)

#
# Using lists rather than sets tests two solutions
# and four BCs, so odetest() should return 6 zeros
# if everything is good - but it doesn't.
#
# Last two entries in the output list are non-zero,
# suggesting that the problem arises with the final
# two boundary conditions
#
  laplace := -phiL(z) + diff(phiL(z),z$2)=0,
             -phiM(z) + diff(phiM(z),z$2)=0:

  BCs:=  phiL(d1)=0,
         phiM(-d1)=0,
         phiL(0)=phiM(0),
         D(phiL)(0)-D(phiM)(0)=-n:

  sol:= [ phiM(z) = n/2/coth(d1)*(cosh(z)+coth(d1)*sinh(z)),
          phiL(z) = n/2/coth(d1)*(cosh(z)-coth(d1)*sinh(z))
        ]:

  odetest(sol, [laplace, BCs]);

[0, 0, 0, 0, (1/2)*(2*phiL(0)*coth(d1)-n)/coth(d1), (D(phiM))(0)-(1/2)*n]

(2)

#################################################
# Test the ode system with the obtained solutions.
#
# Should give 0=0, 0=0, which it does!
#
  eval( laplace, sol);
#################################################
# Test the first BC, phiL(d1)=0 with the relevant
# solution.
#
# Should result in 0, which it does!
#
  simplify
  ( eval
    ( eval
      ( phiL(z), sol),
      z=d1
    ),
    trig
  );
##################################################
# Test the second BC phiM(-d1)=0 with the relevant
# solution.
#
# Should result in 0, which it does!
#
  simplify
  ( eval
    ( eval
      ( phiM(z), sol),
      z=-d1
    ),
    trig
  );
##################################################
# Test the third BC phiL(0)=phiM(0) with the
# relevant solutions.
#
# Should result in 0, which it does!
#
  simplify
  ( eval
    ( eval
      ( phiL(z), sol),
      z=0
    ),
    trig
  )-
  simplify
  ( eval
    ( eval
      ( phiM(z), sol),
      z=0
    ),
    trig
  );
###############################################
# Test the fourth BC D(phiL)(0)-D(phiM)(0)=-n
# with the relevant solutions.
#
# Should result in -n, which it does!
#
  eval
  ( diff
    ( eval
      ( phiL(z), sol),
      z
    ),
    z=0
  )-
  eval
  ( diff
    ( eval
      ( phiM(z), sol),
      z
    ),
    z=0
  );

0 = 0, 0 = 0

 

0

 

0

 

0

 

-n

(3)

 

Download odeTest2.mw

 

  1. Simple problem - you use sets rather than lists for both the ode system and the  solution functions. Sets do not maintain the 'order' in which you enter elements. In fact elements will be sorted (more-or-less) lexicographically. This will cause arguments to the odetest() command to be p[resented in a slightly different order - so the output may(?) be in a (correspondingly? different order.Since you have two solutions and four boundary conditions, there ought to be 6 outputs (ideally all zero). If you use sets as arguments to odetest() then these six outputs will (ideally) collapse  to a set with the single element 0. since sets cannot contain duplicate elements. Since you are getting three outputs, this implies that you are getting four zeros and two non-zeros: the set container collapses the four zeros to a single zero, so you get an output set of three eleemnts, I recommend that you use list arguments rather than sets, as in the attached: this will maintain all six (hopefully) zeros and if anything is non-zero you can work out which solution/bc "failed"
  2. I'm restricted in identifying which two solutions/BCs are causing issues, because as the attached shows, using either sets or lists, I get either {0} or [0,0,0,0,0,0], indicating that odetest() thinks that everything is fine. This may be a version issue. What version are you running - check by using the same commands I used at the top of the attached.


For some reason this worksheet won't display here - no idea why: you will have to download to view

Download odeTest.mw

The attached performs your calculation three different ways: your original code, then two "improved" versions for nelems=1000000, which is long enough to make timings more-or-less reliable, but short enough that I don't get bored waiting. Before considering parallelizing I think it is important to make the "simple" code as fast as possible

The overall speed-up in the attached is about 5X. I may get a chance to look at improvements by parallelization later

#
# OP's original - takes ~35secs for nelems=1000000
# on my machine
#
  restart;
  nelems := 1000000:
  n := 374894756873546859847556:
  op(n):
  A := Array(1 .. 4, 1 .. nelems):
  length(n):
  st := time():
  for i to nelems do
      A[1, i] := i^10*n;
      A[2, i] := length(A[1, i]) - 1;
      b := convert(A[1, i], string);
      A[3, i] := parse(b[1 .. 3]);
      A[4, i] := parse(b[-3 .. -1]);
  end do:
  time() - st;
  A:
  A[1, -2];
  A[2, -2];
  A[3, -2];
  A[4, -2];

37.643

 

374891007942848343450975036111986883129568134169301890673940708132428295071299847556

 

83

 

374

 

556

(1)

#
# Simple code rewrite. Gives about 4X speed-up.
# Takes about 9.5secs for nelems=1000000 on my
# machine
#
  restart;
  nelems := 1000000: # ~ takes about 50mins when n=100,000,000
  n := 374894756873546859847556:
  op(n):
  A := Array(1 .. 4, 1 .. nelems):
  length(n):
  st := time():
  for i to nelems do
      A[1, i]:= i^10*n;
      A[2, i]:= length(A[1, i]) - 1;
      A[3, i]:= iquo(A[1,i], 10^(A[2, i]-2));
      A[4, i]:= irem(A[1,i],1000);
  end do:
  time() - st;
  A:
  A[1, -2];
  A[2, -2];
  A[3, -2];
  A[4, -2];

9.656

 

374891007942848343450975036111986883129568134169301890673940708132428295071299847556

 

83

 

374

 

556

(2)

#
# Use seq() commands rather than for-loop. Gives
# about 30% further speed-up. Takes about 6.5secs
# for nelems=1000000 on my machine
#
  restart;
  nelems := 1000000:
  n := 374894756873546859847556:
  op(n):
  A := Array(1 .. 4, 1 .. nelems):
  length(n):
  st := time():
  A[1,1..nelems]:= Array([seq( i^10*n, i=1..nelems)]):
  A[2,1..nelems]:= Array([seq( length(A[1, i])-1, i=1..nelems)]):
  A[3,1..nelems]:= Array([seq(iquo(A[1,i], 10^(A[2, i]-2)),i=1..nelems)]):
  A[4,1..nelems]:= Array([seq(irem(A[1,i],1000),i=1..nelems)]):
  time() - st;
  A:
  A[1, -2];
  A[2, -2];
  A[3, -2];
  A[4, -2];

6.303

 

374891007942848343450975036111986883129568134169301890673940708132428295071299847556

 

83

 

374

 

556

(3)

interface(rtablesize=10);

[10, 10]

(4)

 

Download speedUP.mw

 

that is before you edited/removed the pictures from your textbook, the first example had the initial conditions tau=0, prey(0)=40, pred(0)=16, although variable names 'pred' and 'prey' were given as 'x' and 'y'.

The attached reproduces the first few graphs from your textbook piccies with these conditions.

Observation

In a predator/prey model, the numbers of both quantities should be integers, and you should be using difference equations rather than differential equations: non-integer numbers of either predator or prey do not make sense -  unless you can define something like (say) 0.1 of a lion!!

I supppose that if the numbers of both predator and prey are "sufficiently large", then using continuou variables may be an acceptable(?) approximation.

However in your revised post you start with pred(0)=1 and prey(0)=1. This fails the "sufficiently large numbers" test mentioned above. It is also (logically) nonsense because

with prey(0)=1, no reproduction is possible. Even without a predator, the number of prey would stay at 1.Furthermore, given a moderately peckish predator, the number of prey will decline from 1 to 0 quite quickly. Some time later the predator will also die of starvation!

Attached worksheet won't display inline here: it contains the "rtablesize" workaround so the problem is probably one of the plot options I have used ( 'size=' maybe?). You will have to download to view :-(

Download predPrey.mw

 slightly different(?) way


 

  restart;
  with(plots):
  nFrames:=100:
  step:=evalf(2*Pi/nFrames):
  display( [ pointplot
             ( [ seq( [j*Pi, 0], j=0..6 )],
               symbol=solidcircle,
               symbolsize=10,
               color=red
             ),
             display
             ( [ seq( plot( [ sin(x+phi),
                              sin(x-phi),
                              sin(x+phi)+sin(x-phi)
                            ],
                            x=0..6*Pi,
                            color=[blue, green, black]
                          ),
                      phi=0..step*(nFrames-1), step
                    )
               ],
               insequence=true
             )
           ],
           axes=boxed,
           gridlines=false
         );

 

interface(rtablesize=10);

[10, 10]

(1)

 


 

Download stWave.mw

Your "desired" result contains the variable name Gr but this variable does not occur in the problem statement. It is therefore impossible to obtain  the former from the latter!

It is however relatively(?) simple to get the term containing Br - see the attached. And if Gr were defined anywhere it might be possible to do somehting similar

 

restart:
with(DETools):
a1:=m^2*((1-N)/(2-N))*(r/2)*Dp:
a2:=((1-N)*m^2/(2-N))*(((Nb-Nt)/64)*(r^5/6-h^2*r/2)-(B[r]/4)*(r^3/4-h^2*r/2)*(Nt/Nb)):
a3:=a1-a2:
a4:=r^2*a3:
DE1:=r^2*diff(v(r),r,r)+r*diff(v(r),r)-(m^2*r^2+1)*v(r)=a4:
b1:=dsolve(DE1,v(r));

v(r) = BesselI(1, m*r)*_C2+BesselK(1, m*r)*_C1-(1/128)*(((-(1/3)*r^4+h^2)*Nb^2+(((1/3)*r^4-h^2)*Nt+64*Dp)*Nb-16*Nt*(h^2-(1/2)*r^2)*B[r])*m^4+(-8*Nb^2*r^2+8*Nb*Nt*r^2+64*Nt*B[r])*m^2-64*Nb*(Nb-Nt))*r*(-1+N)/(Nb*m^4*(-2+N))

(1)

#
# Get the term in B[r]
#
  simplify(collect(coeff(rhs(collect(expand(b1), [B[r], Nt])), B[r]),r))*B[r];

(1/16)*(2*h^2*m^2-m^2*r^2-8)*r*Nt*(-1+N)*B[r]/(Nb*m^2*(-2+N))

(2)

interface(rtablesize=10):

 

Download sinpProb.mw

clear (to me) exactly what you want to be included in the animation. Possibly the one shown in the attachment


 

 with(plots):
 local O:
 R:= 5:
 alpha:= (1/9)*Pi:
 beta:= (1/3)*Pi:
 n:= 100:
 dt:= 2*Pi/n:
 C1:= plot([R*cos(t), R*sin(t), t = 0 .. 2*Pi], color = blue):
 O:= [0, 0]:
 M:= [R*cos(beta), R*sin(beta)]:
 A:= [R*cos(alpha), R*sin(alpha)]:
 B:= [R*cos(alpha+Pi), R*sin(alpha+Pi)]:
 AB:= plot([A, B]):
 OM:= plot([O, M]):
 P:= [R*cos(t0*dt), R*sin(t0*dt)]:
 Q:= [R*cos(dt*t0+Pi), R*sin(dt*t0+Pi)]:
 diamob:= seq
           ( display
             ( [ plot( [P, Q], color = green),
                 plot([M, P]),
                 plot([M, Q])
               ]
             ),
             t0 = 0 .. n
           ):
 tp:= textplot( [ [A[1]+.3, A[2], "A"],
                   [B[1]-.3, B[2], "B"],
                   [M[1]+.3, M[2]+.3, "M"]
                 ]
               ):
 display( [ AB, C1, OM, tp,
            display
            ( diamob,
              insequence = true
            )
          ],
          scaling = constrained
        );

 

interface(rtablesize=10):

 


 

Download anim.mw

then the attached is one alternative. (it would be relatively trivial to change for 3D, or handle 2D and 3D, but I don't feel inclined to cover all the bases unless it is really necessary)

Ignore the interface(rtablesize=10) command at the end: this is just a workaround to ensure that worksheets created in Mapale 2019 display properly on this site

  restart;
  getCirc:= proc( k, l, m)
                  uses geometry, plots;
                  local ci;
                #
                # Check collinearity
                #
                  point(A, k[1], k[2]);
                  point(B, l[1], l[2]);
                  point(C, m[1], m[2]);
                  if   AreCollinear(A, B, C)
                  then error "Points are collinear"
                  else circle
                       ( c,
                         [A, B, C],
                         [x,y]
                       );
                       return Equation(c),
                              [ pointplot
                                ( [k, l, m],
                                  symbol=solidcircle,
                                  symbolsize=20,
                                  color=blue
                                ),
                                draw
                                ( c,
                                  axes=none,
                                  color=red
                                )
                              ]
                  fi;
            end proc:
#
# If we hae points which are not collinear
#
  expr, plt:= getCirc( [2.5, 1], [0, 5], [-1,2] ):
  plots:-display( plt,
                  size=[1000, 500],
                  title=typeset( "A plot of the circle\n",
                                  expr,
                                 "\nwith defining points"
                               ),
                  titlefont=[times, bold, 20]
                );
#
# Or if we have points which are collinear
#
  expr, plt:= getCirc( [0, 0], [2, 0], [-3, 0]);

 

Error, (in getCirc) Points are collinear

 

interface(rtablesize=10):

 


 

Download drawCirc.mw

If I undertsand correctly, you can set the positions of the vertexes in your graph with the SetVertexPositions() command,

See the attached - ignore the interface(rablesize=10) command at teh end of the attached - this is just needed to make things display prooperly on this site
 

  restart;
  with(GraphTheory):
#
# Define adjacency Matrix
#
  A:= Matrix(9, 9, [ [0, 0, 1, 0, 1, 1, 1, 0, 0],
                     [1, 0, 0, 0, 0, 0, 0, 0, 0],
                     [0, 1, 0, 0, 0, 0, 0, 0, 0],
                     [1, 0, 0, 0, 0, 0, 0, 0, 0],
                     [1, 0, 0, 0, 0, 0, 0, 0, 0],
                     [1, 0, 0, 0, 0, 0, 0, 0, 0],
                     [0, 0, 0, 0, 0, 0, 0, 0, 1],
                     [0, 0, 0, 1, 0, 0, 0, 0, 0],
                     [0, 0, 0, 0, 0, 0, 0, 1, 0]
                   ]
          ):
#
# Define graph based on adjacency matrix and then
# draw it
#
  G1:=Graph(A):
  DrawGraph( G1 );
#
# Define and set vertext positions for the graph
# then draw it
#
  vp:=[ [40, 40], [22, 22], [36, 26], [21, 45], [45, 35],
        [55, 20], [55, 45], [26, 59], [55, 65]
      ]:
  SetVertexPositions(G1, vp):
  DrawGraph(G1);

 

 

interface(rtablesize=10):

 


 

Download drGraph.mw

@vv 

The IntegrationTools:-Parts() command will provide the "desired"(??) solution - which looks "suspicious" to me in the absence of limits

  restart;
#
# Consider the integral
#
  I1:=int(diff(v(x),x,x)*u(x), x);
#
# Write an alternative form of I1 using
# "integration by parts"
#
  I2:=IntegrationTools:-Parts( I1, u(x));
#
# Now these two "repesentations of the same
# integral *ought* to be the same, so one
# could say I1=I2, or equivalently I2-I=0.
# Use the latter
#
  I2-I1=0;

int((diff(diff(v(x), x), x))*u(x), x)

 

(diff(v(x), x))*u(x)-(int((diff(v(x), x))*(diff(u(x), x)), x))

 

(diff(v(x), x))*u(x)-(int((diff(v(x), x))*(diff(u(x), x)), x))-(int((diff(diff(v(x), x), x))*u(x), x)) = 0

(1)

 


 

Download parts.mw

Your basic problem is that (in certain execution groups) you have attempted to use 2D-input with manual code indentation (presumably for readability). Just don't!!! The 2-D parser will place all sorts of "interesting" interpretations on the extra "whitespace" which arises from this indentation. Obviously this never happens if you use 1-D input because, because in this format "whitespace" is just "whitespace"

If you must use 2D-input, you *might* get away with using manual indentation provided you put commands and their associated opening bracket on the same line. So write

seq(

but never

seq
(

Apply the same principle for all  other commands - eg Transpose etc. Randomly typing "shift C/R" and "whitespace" (for indentation purposes) whilst using 2D-input mode is just asking for trouble!

In the attached, I have simply removed the "indentation" from your code, and everything now works


 

restart

#
# Load packages "properly" and check Maple
# version
#
  with(DirectSearch):
  with(LinearAlgebra):
  kernelopts(version)

`Maple 2018.2, X86 64 WINDOWS, Nov 16 2018, Build ID 1362973`

(1)

r[0] := 1.25*10^(-4)

0.1250000000e-3

(2)

r[1] := 1.25*10^(-4)

0.1250000000e-3

(3)

r[2] := 1.25*10^(-4)

0.1250000000e-3

(4)

r[3] := 1.25*10^(-4)

0.1250000000e-3

(5)

r[4] := 1.25*10^(-4)

0.1250000000e-3

(6)

for n to 20 do e1 := t[0] = (-p[0, fail]^7+1)/((1-p[0, fail])*((-p[0, fail]^7+1)/(1-p[0, fail])+(17/2+(17/2)*p[0, fail]+(33/2)*p[0, fail]^2+(33/2)*p[0, fail]^3+(65/2)*p[0, fail]^4+(65/2)*p[0, fail]^5+(65/2)*p[0, fail]^6)/p[0, idle]+(1-r[0])*(p[0, fail]^6+(-p[0, fail]^6+1)*p[0, succ]/(1-p[0, fail]))/r[0])); e2 := t[1] = (-p[1, fail]^7+1)/((1-p[1, fail])*((-p[1, fail]^7+1)/(1-p[1, fail])+(9/2+(9/2)*p[1, fail]+(17/2)*p[1, fail]^2+(17/2)*p[1, fail]^3+(33/2)*p[1, fail]^4+(33/2)*p[1, fail]^5+(33/2)*p[1, fail]^6)/p[1, idle]+(1-r[1])*(p[1, fail]^6+(-p[1, fail]^6+1)*p[1, succ]/(1-p[1, fail]))/r[1])); e3 := t[2] = (-p[2, fail]^7+1)/((1-p[2, fail])*((-p[2, fail]^7+1)/(1-p[2, fail])+(5/2+(5/2)*p[2, fail]+(9/2)*p[2, fail]^2+(9/2)*p[2, fail]^3+(17/2)*p[2, fail]^4+(17/2)*p[2, fail]^5+(17/2)*p[2, fail]^6)/p[2, idle]+(1-r[2])*(p[2, fail]^6+(-p[2, fail]^6+1)*p[2, succ]/(1-p[2, fail]))/r[2])); e4 := t[3] = (-p[3, fail]^7+1)/((1-p[3, fail])*((-p[3, fail]^7+1)/(1-p[3, fail])+(3/2+(3/2)*p[3, fail]+(5/2)*p[3, fail]^2+(5/2)*p[3, fail]^3+(9/2)*p[3, fail]^4+(9/2)*p[3, fail]^5+(9/2)*p[3, fail]^6)/p[3, idle]+(1-r[3])*(p[3, fail]^6+(-p[3, fail]^6+1)*p[3, succ]/(1-p[3, fail]))/r[3])); e5 := t[4] = (-p[4, fail]^7+1)/((1-p[4, fail])*((-p[4, fail]^7+1)/(1-p[4, fail])+(1+p[4, fail]+(3/2)*p[4, fail]^2+(3/2)*p[4, fail]^3+(5/2)*p[4, fail]^4+(5/2)*p[4, fail]^5+(5/2)*p[4, fail]^6)/p[4, idle]+(1-r[4])*(p[4, fail]^6+(-p[4, fail]^6+1)*p[4, succ]/(1-p[4, fail]))/r[4])); e6 := p[0, fail] = n*t[0]*(1-(1-t[0])^(n-1)*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n)+0.1590000000e-1*n*t[0]*(1-t[0])^(n-1)*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n/(1-(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e7 := p[1, fail] = n*t[1]*(1-(1-t[1])^(n-1)*(1-t[0])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n)+0.1590000000e-1*n*t[1]*(1-t[1])^(n-1)*(1-t[0])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n/(1-(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e8 := p[2, fail] = n*t[2]*(1-(1-t[2])^(n-1)*(1-t[1])^n*(1-t[0])^n*(1-t[3])^n*(1-t[4])^n)+0.1590000000e-1*n*t[2]*(1-t[2])^(n-1)*(1-t[1])^n*(1-t[0])^n*(1-t[3])^n*(1-t[4])^n/(1-(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e9 := p[3, fail] = (1/2)*n*t[3]*(1-(1-t[3])^(n-1)*(1-t[4])^n)+(1/2)*n*t[3]*(1-(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^(n-1)*(1-t[4])^n)+(0.1590000000e-1*((1/2)*n*t[3]*(1-t[3])^(n-1)*(1-t[4])^n+(1/2)*n*t[3]*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^(n-1)*(1-t[4])^n))/(1-(1/2)*(1-t[3])^n*(1-t[4])^n-(1/2)*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e10 := p[4, fail] = (1/2)*n*t[4]*(1-(1-t[4])^(n-1)*(1-t[3])^n)+(1/2)*n*t[4]*(1-(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[4])^(n-1)*(1-t[3])^n)+(0.1590000000e-1*((1/2)*n*t[4]*(1-t[4])^(n-1)*(1-t[3])^n+(1/2)*n*t[4]*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[4])^(n-1)*(1-t[3])^n))/(1-(1/2)*(1-t[3])^n*(1-t[4])^n-(1/2)*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e11 := p[0, succ] = .9841000000*n*t[0]*(1-t[0])^(n-1)*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n/(1-(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e12 := p[1, succ] = .9841000000*n*t[1]*(1-t[1])^(n-1)*(1-t[0])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n/(1-(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e13 := p[2, succ] = .9841000000*n*t[2]*(1-t[2])^(n-1)*(1-t[1])^n*(1-t[0])^n*(1-t[3])^n*(1-t[4])^n/(1-(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e14 := p[3, succ] = (.9841000000*((1/2)*n*t[3]*(1-t[3])^(n-1)*(1-t[4])^n+(1/2)*n*t[3]*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^(n-1)*(1-t[4])^n))/(1-(1/2)*(1-t[3])^n*(1-t[4])^n-(1/2)*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e15 := p[4, succ] = (.9841000000*((1/2)*n*t[4]*(1-t[4])^(n-1)*(1-t[3])^n+(1/2)*n*t[4]*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[4])^(n-1)*(1-t[3])^n))/(1-(1/2)*(1-t[3])^n*(1-t[4])^n-(1/2)*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^n*(1-t[4])^n); e16 := p[0, idle] = (1-t[0])^(n-1)*(1-t[1])^n*(1-t[2])^n; e17 := p[1, idle] = (1-t[1])^(n-1)*(1-t[0])^n*(1-t[2])^n; e18 := p[2, idle] = (1-t[2])^(n-1)*(1-t[1])^n*(1-t[0])^n; e19 := p[3, idle] = (1/2)*(1-t[3])^(n-1)*(1-t[4])^n+(1/2)*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[3])^(n-1)*(1-t[4])^n; e20 := p[4, idle] = (1/2)*(1-t[4])^(n-1)*(1-t[3])^n+(1/2)*(1-t[0])^n*(1-t[1])^n*(1-t[2])^n*(1-t[4])^(n-1)*(1-t[3])^n; CSTR := `~`[`=`]({p[0, fail], p[0, idle], p[0, succ], p[1, fail], p[1, idle], p[1, succ], p[2, fail], p[2, idle], p[2, succ], p[3, fail], p[3, idle], p[3, succ], p[4, fail], p[4, idle], p[4, succ], t[0], t[1], t[2], t[3], t[4]}, 0 .. 1); residuals := `~`[lhs-rhs]([e1, e2, e3, e4, e5, e6, e7, e8, e9, e10, e11, e12, e13, e14, e15, e16, e17, e18, e19, e20]); ansLS[n] := Optimization:-LSSolve(residuals, op(CSTR), iterationlimit = 10000); ansDS[n] := DirectSearch:-SolveEquations(residuals, CSTR, initialpoint = ansLS[n][2]) end do

Matrix(20, 20, [seq(ansDS[j][3], j = 1 .. 10)]); Matrix(20, 20, [seq(ansLS[j][2], j = 1 .. 20)])

RTABLE(18446744074184966142, anything, Matrix, rectangular, Fortran_order, [], 2, 1 .. 20, 1 .. 20)

 

RTABLE(18446744074184966294, anything, Matrix, rectangular, Fortran_order, [], 2, 1 .. 20, 1 .. 20)

(7)

LSMat := Matrix(max([indices(ansLS, 'nolist')])+1, numelems(ansLS[1][2])+1); LSMat[1, 1] := "n"; LSMat[1, 2 .. -1] := `~`[convert](`<,>`(`~`[lhs](ansLS[1][2])[]), string); LSMat[2 .. -1, 1] := `<,>`(seq(j, j = 1 .. n-1)); LSMat[2 .. -1, 2 .. -1] := `<,>`(seq(Transpose(`<,>`(`~`[rhs](ansLS[j][2]))), j = 1 .. n-1)); DSMat := Matrix(max([indices(ansDS, 'nolist')])+1, numelems(ansDS[1][3])+1); DSMat[1, 1] := "n"; DSMat[1, 2 .. -1] := `~`[convert](`<,>`(`~`[lhs](ansDS[1][3])[]), string); DSMat[2 .. -1, 1] := `<,>`(seq(j, j = 1 .. n-1)); DSMat[2 .. -1, 2 .. -1] := `<,>`(seq(Transpose(`<,>`(`~`[rhs](ansDS[j][3]))), j = 1 .. n-1)); LSMat; DSMat

RTABLE(18446744074184966446, anything, Matrix, rectangular, Fortran_order, [], 2, 1 .. 21, 1 .. 21)

 

RTABLE(18446744074184966598, anything, Matrix, rectangular, Fortran_order, [], 2, 1 .. 21, 1 .. 21)

(8)

mi := max[index](DSMat-LSMat); (DSMat-LSMat)[mi]

14, 6

 

HFloat(2.95463431498888e-10)

(9)

NULL

NULL

NULL

NULL


 

Download dsls.mw

You should never, ever use an indexed variable (eg c[1], c[2]), and a nonindexed variable (eg 'c') in the same calculation!

It si also not a good idea to use non-commutative multiplication ( ie the '.' symbol) rather than simple multiplication (ie the '*' symbol), unless your are really sure that you need the former

I changed refereence to 'c' to 'cc' and all '.' characters to '*' and came up with the attached. Be aware that the dsolve command takes ~3mins to completet on my machine - yours may be faster (or slower!)


 

restart;
with(plots):
r := 0.5e-2; k := 10000; a := .4; alpha := .25; epsilon := 0.2e-1;
 mu := 0.4e-1; delta := 0.3e-2; Lambda := 0.2e-1;
beta[2] := .45; beta[1] := .2; c[1] := 2; c[2] := 5;
 w[1] := 10; w[2] := 30; T := 3;
u[1] := min(max(0, z), 1); z := beta[2]*s(t)*i(t)*(lambda[2](t)-lambda[1](t))/(w[1]*(s(t)+i(t)+e(t)));
 u[2] := min(max(0, cc), 1);
 cc := (beta[1]*s(t)*p(t)*(lambda[2](t)-lambda[1](t)))/(w[2]*(a+p(t)))+(lambda[2](t)*e(t)+(i(t)+alpha.e(t))*lambda[3](t)-(gamma.i(t)+p(t)).lambda[4](t))/w[2];

sys := diff(s(t), t) = r*s(t)*(1-(s(t)+i(t)+e(t))/k)-beta[1]*s(t)*p(t)*(1-u[2])/(a+p(t))-beta[2]*s(t)*i(t)*(1-u[1])/(s(t)+i(t)+e(t)),
       diff(e(t), t) = beta[1]*s(t)*p(t)*(1-u[2])/(a+p(t))+beta[2]*s(t)*i(t)*(1-u[1])/(s(t)+i(t)+e(t))-(mu+alpha+u[2])*e(t),
       diff(i(t), t) = (alpha+u[2])*e(t)-(mu+epsilon+u[2])*i(t),
       diff(p(t), t) = Lambda+(epsilon+u[2])*i(t)-delta*p(t),
       diff(lambda[1](t), t) = -lambda[1](t)*(r*(1-(2*s(t)+i(t)+e(t))/k)-beta[1]*p(t)*(1-u[2])/(a+p(t))-beta[2]*i(t)*(1-u[1])/(s(t)+i(t)+e(t)))-lambda[2](t)*(beta[1]*p(t)*(1-u[2])/(a+p(t))-beta[2]*i(t)*(1-u[1])/(s(t)+i(t)+e(t))),
       diff(lambda[2](t), t) = -c[1]+lambda[1](t)*r*s(t)/k+lambda[2](t)*(mu+alpha+u[2])-(1-u[2])*alpha*lambda[3](t),
       diff(lambda[3](t), t) = -c[2]+lambda[1](t)*(r*s(t)/k+beta[2]*s(t)*(1-u[1])/(s(t)+i(t)+e(t)))-lambda[2](t)*beta[2]*s(t)*(1-u[1])/(s(t)+i(t)+e(t))+lambda[3](t)*(u[2]+mu+gamma)-lambda[4](t)*gamma*(1-u[2]),
       diff(lambda[4](t), t) = ((lambda[1](t)*beta[1])*s(t)*a*(1-u[2]))/(a+p(t))^2-((lambda[2](t)*beta[1])*s(t)*a*(1-u[2]))/(a+p(t))^2-lambda[4](t)*(delta+u[2]),
       s(0) = 1000, e(0) = 10, i(0) = 0, p(0) = 100, lambda[1](T) = 0, lambda[2](T) = 0, lambda[3](T) = 0, lambda[4](T);
p1 := dsolve({sys}, numeric, abserr=1.0e-03, maxmesh=1024);

0.5e-2

 

10000

 

.4

 

.25

 

0.2e-1

 

0.4e-1

 

0.3e-2

 

0.2e-1

 

.45

 

.2

 

2

 

5

 

10

 

30

 

3

 

min(1, max(0, z))

 

0.4500000000e-1*s(t)*i(t)*(lambda[2](t)-lambda[1](t))/(s(t)+i(t)+e(t))

 

min(1, max(0, cc))

 

0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t))

 

diff(s(t), t) = 0.5e-2*s(t)*(1-(1/10000)*s(t)-(1/10000)*i(t)-(1/10000)*e(t))-.2*s(t)*p(t)*(1-min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))/(.4+p(t))-.45*s(t)*i(t)*(1-min(1, max(0, 0.4500000000e-1*s(t)*i(t)*(lambda[2](t)-lambda[1](t))/(s(t)+i(t)+e(t)))))/(s(t)+i(t)+e(t)), diff(e(t), t) = .2*s(t)*p(t)*(1-min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))/(.4+p(t))+.45*s(t)*i(t)*(1-min(1, max(0, 0.4500000000e-1*s(t)*i(t)*(lambda[2](t)-lambda[1](t))/(s(t)+i(t)+e(t)))))/(s(t)+i(t)+e(t))-(.29+min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))*e(t), diff(i(t), t) = (.25+min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))*e(t)-(0.6e-1+min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))*i(t), diff(p(t), t) = 0.2e-1+(0.2e-1+min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))*i(t)-0.3e-2*p(t), diff(lambda[1](t), t) = -lambda[1](t)*(0.5e-2-0.1000000000e-5*s(t)-0.5000000000e-6*i(t)-0.5000000000e-6*e(t)-.2*p(t)*(1-min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))/(.4+p(t))-.45*i(t)*(1-min(1, max(0, 0.4500000000e-1*s(t)*i(t)*(lambda[2](t)-lambda[1](t))/(s(t)+i(t)+e(t)))))/(s(t)+i(t)+e(t)))-lambda[2](t)*(.2*p(t)*(1-min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))/(.4+p(t))-.45*i(t)*(1-min(1, max(0, 0.4500000000e-1*s(t)*i(t)*(lambda[2](t)-lambda[1](t))/(s(t)+i(t)+e(t)))))/(s(t)+i(t)+e(t))), diff(lambda[2](t), t) = -2+0.5000000000e-6*s(t)*lambda[1](t)+lambda[2](t)*(.29+min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))-.25*(1-min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))*lambda[3](t), diff(lambda[3](t), t) = -5+lambda[1](t)*(0.5000000000e-6*s(t)+.45*s(t)*(1-min(1, max(0, 0.4500000000e-1*s(t)*i(t)*(lambda[2](t)-lambda[1](t))/(s(t)+i(t)+e(t)))))/(s(t)+i(t)+e(t)))-.45*lambda[2](t)*s(t)*(1-min(1, max(0, 0.4500000000e-1*s(t)*i(t)*(lambda[2](t)-lambda[1](t))/(s(t)+i(t)+e(t)))))/(s(t)+i(t)+e(t))+lambda[3](t)*(min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t))))+0.4e-1+gamma)-lambda[4](t)*gamma*(1-min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t))))), diff(lambda[4](t), t) = 0.8e-1*lambda[1](t)*s(t)*(1-min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))/(.4+p(t))^2-0.8e-1*lambda[2](t)*s(t)*(1-min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t)))))/(.4+p(t))^2-lambda[4](t)*(0.3e-2+min(1, max(0, 0.6666666667e-2*s(t)*p(t)*(lambda[2](t)-lambda[1](t))/(.4+p(t))+(1/30)*lambda[2](t)*e(t)+(1/30)*(i(t)+.25*e(t))*lambda[3](t)-(1/30)*((gamma*i(t)+p(t)).lambda[4](t))))), s(0) = 1000, e(0) = 10, i(0) = 0, p(0) = 100, lambda[1](3) = 0, lambda[2](3) = 0, lambda[3](3) = 0, lambda[4](3)

 

proc (x_bvp) local res, data, solnproc, _ndsol, outpoint, i; option `Copyright (c) 2000 by Waterloo Maple Inc. All rights reserved.`; _EnvDSNumericSaveDigits := Digits; Digits := 15; if _EnvInFsolve = true then outpoint := evalf[_EnvDSNumericSaveDigits](x_bvp) else outpoint := evalf(x_bvp) end if; data := Array(1..4, {(1) = proc (outpoint) local X, Y, YP, yout, errproc, L, V, i; option `Copyright (c) 2000 by Waterloo Maple Inc. All rights reserved.`; X := Vector(122, {(1) = .0, (2) = 0.9741435106503429e-2, (3) = 0.19707189158802676e-1, (4) = 0.2990782982757365e-1, (5) = 0.4035468839555765e-1, (6) = 0.51059934946617196e-1, (7) = 0.62036663005486145e-1, (8) = 0.732989850822334e-1, (9) = 0.8486214083876946e-1, (10) = 0.9674261986134969e-1, (11) = .10895833907658463, (12) = .12152886800268148, (13) = .13447543115104388, (14) = .1478212039749837, (15) = .16159156902610294, (16) = .17581440459606146, (17) = .1905204219231735, (18) = .2057435609748033, (19) = .22152145757186412, (20) = .23789602193504325, (21) = .25491439085962175, (22) = .27262932405428647, (23) = .2911002393000661, (24) = .3103944840382796, (25) = .3305888084021936, (26) = .3517711953548975, (27) = .3740431562700764, (28) = .39752264073240134, (29) = .4223477673432611, (30) = .4486825709916404, (31) = .4766224874284011, (32) = .5059299989198147, (33) = .5360639779566353, (34) = .5670339223010088, (35) = .5988564659101844, (36) = .6315490455116444, (37) = .665132714021168, (38) = .6996089370778189, (39) = .7349722211903196, (40) = .7712212602958708, (41) = .8083507944918464, (42) = .8463418431675694, (43) = .885168047571194, (44) = .9247996715263419, (45) = .9652041825220232, (46) = 1.006355960451245, (47) = 1.048221571279199, (48) = 1.0907635687216195, (49) = 1.1339516742031843, (50) = 1.1777571492568144, (51) = 1.2221446362150017, (52) = 1.2670806629233007, (53) = 1.3125263805338878, (54) = 1.3584520199179504, (55) = 1.404830083985476, (56) = 1.451622058971123, (57) = 1.498802953852514, (58) = 1.5463509015029775, (59) = 1.5942373703266048, (60) = 1.6424357424625993, (61) = 1.690921930260093, (62) = 1.7396390535434036, (63) = 1.7884019443410892, (64) = 1.8365148980229262, (65) = 1.8838664336932738, (66) = 1.9307382864102527, (67) = 1.9772200785721323, (68) = 2.0231982707759397, (69) = 2.068533909383313, (70) = 2.113050269923841, (71) = 2.156567546064062, (72) = 2.198888212916297, (73) = 2.23980728091143, (74) = 2.279128120258343, (75) = 2.316672074587299, (76) = 2.352283612876669, (77) = 2.3858528111599733, (78) = 2.4173263519948054, (79) = 2.4467118515199453, (80) = 2.474059951351264, (81) = 2.4994631784630887, (82) = 2.5230595210833147, (83) = 2.5449916887106143, (84) = 2.565421886715661, (85) = 2.5845042984516353, (86) = 2.6023900332269765, (87) = 2.61921851178031, (88) = 2.635112503713722, (89) = 2.6501876068068095, (90) = 2.664545654245356, (91) = 2.6782722885189303, (92) = 2.6914468043182116, (93) = 2.7041382854495692, (94) = 2.7164070629279187, (95) = 2.7283057857332493, (96) = 2.7398805934676407, (97) = 2.7511723491714175, (98) = 2.762217098566082, (99) = 2.773046677277982, (100) = 2.7836890609808993, (101) = 2.794169101930963, (102) = 2.8045087959121373, (103) = 2.8147268856055696, (104) = 2.824841442748569, (105) = 2.8348680735443472, (106) = 2.8448195459526886, (107) = 2.8547077266056764, (108) = 2.8645428448478993, (109) = 2.874333374077579, (110) = 2.8840886491995987, (111) = 2.893814960611468, (112) = 2.903517841082119, (113) = 2.913201583880822, (114) = 2.922870293058419, (115) = 2.9325283060532534, (116) = 2.9421787975362634, (117) = 2.951823224967565, (118) = 2.961463174210137, (119) = 2.971099265323444, (120) = 2.9807331838318056, (121) = 2.9903666649653213, (122) = 3.0}, datatype = float[8], order = C_order); Y := Matrix(122, 8, {(1, 1) = 10.0, (1, 2) = .0, (1, 3) = -0.36444696780525638e-2, (1, 4) = 1.518112565990186, (1, 5) = 3.3947233644706145, (1, 6) = 0.2309917969246506e-3, (1, 7) = 100.0, (1, 8) = 1000.0, (2, 1) = 9.875381491901775, (2, 2) = .12038318791006769, (2, 3) = -0.3643932939406801e-2, (2, 4) = 1.517704406448608, (2, 5) = 3.392905414633155, (2, 6) = 0.2287458448316375e-3, (2, 7) = 99.99787279747972, (2, 8) = 1000.0435277935364, (3, 1) = 9.750025914406631, (3, 2) = .2407099801060637, (3, 3) = -0.36425882372461338e-2, (3, 4) = 1.517281506451318, (3, 5) = 3.3910730828323645, (3, 6) = 0.22647077049184873e-3, (3, 7) = 99.9969201352501, (3, 8) = 1000.0875339850887, (4, 1) = 9.623899350009179, (4, 2) = .3609686908103676, (4, 3) = -0.36404119491717664e-2, (4, 4) = 1.516842971602914, (4, 5) = 3.3892254220533906, (4, 6) = 0.22416550606552818e-3, (4, 7) = 99.99719669994941, (4, 8) = 1000.1320503017414, (5, 1) = 9.496965881391954, (5, 2) = .4811464542034129, (5, 3) = -0.3637378803283913e-2, (5, 4) = 1.5163878302526927, (5, 5) = 3.3873613949187016, (5, 6) = 0.22182891824350175e-3, (5, 7) = 99.99876100333515, (5, 8) = 1000.1771107938796, (6, 1) = 9.369187424228853, (6, 2) = .6012290917665649, (6, 3) = -0.363346171850262e-2, (6, 4) = 1.5159150247450437, (6, 5) = 3.3854798626179883, (6, 6) = 0.21945980256677056e-3, (6, 7) = 100.00167574611228, (6, 8) = 1000.2227520649499, (7, 1) = 9.240523541790992, (7, 2) = .7212009616581284, (7, 3) = -0.36286316250627826e-2, (7, 4) = 1.5154234014331571, (7, 5) = 3.383579572176033, (7, 6) = 0.21705687710521238e-3, (7, 7) = 100.00600822604716, (7, 8) = 1000.2690135301738, (8, 1) = 9.110931238917598, (8, 2) = .8410447872018941, (8, 3) = -0.36228572621692322e-2, (8, 4) = 1.5149116992449687, (8, 5) = 3.381659141761102, (8, 6) = 0.21461877540623453e-3, (8, 7) = 100.01183079698195, (8, 8) = 1000.3159377086649, (9, 1) = 8.98036473255779, (9, 2) = .9607414609808916, (9, 3) = -0.36161049492553794e-2, (9, 4) = 1.5143785365479803, (9, 5) = 3.3797170436745496, (9, 6) = 0.2121440386100391e-3, (9, 7) = 100.01922138654376, (9, 8) = 1000.3635705542292, (10, 1) = 8.848775196241366, (10, 2) = 1.0802698197965024, (10, 3) = -0.3608338326670509e-2, (10, 4) = 1.5138223960098305, (10, 5) = 3.3777515845942245, (10, 6) = 0.20963110662229674e-3, (10, 7) = 100.02826408171408, (10, 8) = 1000.4119618308804, (11, 1) = 8.716110070244886, (11, 2) = 1.1996067474791985, (11, 3) = -0.3599518032398251e-2, (11, 4) = 1.5132416052822664, (11, 5) = 3.3757608764551494, (11, 6) = 0.2070783003907275e-3, (11, 7) = 100.0390498286218, (11, 8) = 1000.4611656911958, (12, 1) = 8.582312092383937, (12, 2) = 1.3187274316493696, (12, 3) = -0.35896012994317285e-2, (12, 4) = 1.5126343133247007, (12, 5) = 3.3737427994924167, (12, 6) = 0.2044837977962039e-3, (12, 7) = 100.05167728116174, (12, 8) = 1000.5112414164304, (13, 1) = 8.447320916282314, (13, 2) = 1.4376032313319602, (13, 3) = -0.35785416982138584e-2, (13, 4) = 1.5119984752047602, (13, 5) = 3.371695000101513, (13, 6) = 0.20184565902066215e-3, (13, 7) = 100.06625351220568, (13, 8) = 1000.5622532470184, (14, 1) = 8.311071762963728, (14, 2) = 1.5562021311030958, (14, 3) = -0.3566288640166338e-2, (14, 4) = 1.5113318203155797, (14, 5) = 3.369614839247266, (14, 6) = 0.1991617942719388e-3, (14, 7) = 100.08289506661364, (14, 8) = 1000.6142713758094, (15, 1) = 8.173494847762024, (15, 2) = 1.674488365012905, (15, 3) = -0.35527868537124116e-2, (15, 4) = 1.5106318189986074, (15, 5) = 3.3674993461484255, (15, 6) = 0.19642994519791305e-3, (15, 7) = 100.10172912091274, (15, 8) = 1000.6673727415705, (16, 1) = 8.034514825872513, (16, 2) = 1.7924218839478387, (16, 3) = -0.35379757826064645e-2, (16, 4) = 1.5098956434837933, (16, 5) = 3.3653451645416954, (16, 6) = 0.19364766550242907e-3, (16, 7) = 100.12289481754043, (16, 8) = 1000.7216419147042, (17, 1) = 7.894050157285309, (17, 2) = 1.9099577291364591, (17, 3) = -0.3521788884657889e-2, (17, 4) = 1.5091201214189744, (17, 5) = 3.3631484881843896, (17, 6) = 0.19081229864252976e-3, (17, 7) = 100.14654481538157, (17, 8) = 1000.7771721324737, (18, 1) = 7.7520123772281755, (18, 2) = 2.027045291088544, (18, 3) = -0.35041528106047855e-2, (18, 4) = 1.5083016802800613, (18, 5) = 3.360904983011134, (18, 6) = 0.1879209520749296e-3, (18, 7) = 100.17284709987757, (18, 8) = 1000.8340665146394, (19, 1) = 7.6083052527833175, (19, 2) = 2.1436274300400373, (19, 3) = -0.34849864376536362e-2, (19, 4) = 1.5074362804700085, (19, 5) = 3.3586096925844293, (19, 6) = 0.18497046735024337e-3, (19, 7) = 100.20198710684122, (19, 8) = 1000.892439499086, (20, 1) = 7.462823591578409, (20, 2) = 2.25963959372224, (20, 3) = -0.34641996945381074e-2, (20, 4) = 1.5065193329288127, (20, 5) = 3.3562569190591405, (20, 6) = 0.18195738081063797e-3, (20, 7) = 100.23417027641804, (20, 8) = 1000.9524186348091, (21, 1) = 7.3154496447924915, (21, 2) = 2.375010444017136, (21, 3) = -0.34416918027070772e-2, (21, 4) = 1.505545583398332, (21, 5) = 3.353840040094274, (21, 6) = 0.1788778309554289e-3, (21, 7) = 100.26962566045641, (21, 8) = 1001.0141476624779, (22, 1) = 7.166055443032617, (22, 2) = 2.4896573293880695, (22, 3) = -0.34173501253704354e-2, (22, 4) = 1.5045090125809022, (22, 5) = 3.3513513904160512, (22, 6) = 0.1757275854745333e-3, (22, 7) = 100.30860875098074, (22, 8) = 1001.0777874837237, (23, 1) = 7.014500532201328, (23, 2) = 2.6034849984842143, (23, 3) = -0.3391048123548789e-2, (23, 4) = 1.50340268182999, (23, 5) = 3.3487820300095628, (23, 6) = 0.17250197023805101e-3, (23, 7) = 100.35140586081805, (23, 8) = 1001.1435194029241, (24, 1) = 6.860629308815491, (24, 2) = 2.716383911812464, (24, 3) = -0.3362642830431816e-2, (24, 4) = 1.5022185393403122, (24, 5) = 3.346121451758136, (24, 6) = 0.16919578415529888e-3, (24, 7) = 100.39833951191841, (24, 8) = 1001.2115490968023, (25, 1) = 6.704268634867088, (25, 2) = 2.8282274796515887, (25, 3) = -0.3331971868797309e-2, (25, 4) = 1.5009471808932044, (25, 5) = 3.3433572227187875, (25, 6) = 0.16580321329978692e-3, (25, 7) = 100.44977484369323, (25, 8) = 1001.2821111650888, (26, 1) = 6.5452249520385894, (26, 2) = 2.9388686176327576, (26, 3) = -0.32988497619437637e-2, (26, 4) = 1.4995775449403774, (26, 5) = 3.3404745221881695, (26, 6) = 0.1623177264567889e-3, (26, 7) = 100.50612750949858, (26, 8) = 1001.355474790129, (27, 1) = 6.38328076381553, (27, 2) = 3.0481354094959845, (27, 3) = -0.326306332899454e-2, (27, 4) = 1.498096519741816, (27, 5) = 3.3374555401924404, (27, 6) = 0.15873194705151009e-3, (27, 7) = 100.56787349533764, (27, 8) = 1001.4319508436824, (28, 1) = 6.218190309313985, (28, 2) = 3.155825589712756, (28, 3) = -0.3224365879546717e-2, (28, 4) = 1.4964884310962638, (28, 5) = 3.334278684565643, (28, 6) = 0.15503749468860203e-3, (28, 7) = 100.63556145033289, (28, 8) = 1001.5119009063064, (29, 1) = 6.049674193732152, (29, 2) = 3.261699445302701, (29, 3) = -0.31824698145736033e-2, (29, 4) = 1.49473436555199, (29, 5) = 3.3309175215755746, (29, 6) = 0.1512247871849631e-3, (29, 7) = 100.70982833952205, (29, 8) = 1001.595748847309, (30, 1) = 5.877406858829773, (30, 2) = 3.3654739845525046, (30, 3) = -0.3137035508418204e-2, (30, 4) = 1.492811196148081, (30, 5) = 3.3273392163625166, (30, 6) = 0.14728265717988656e-3, (30, 7) = 100.79142239618065, (30, 8) = 1001.6839988981254, (31, 1) = 5.701631275992783, (31, 2) = 3.466460967520514, (31, 3) = -0.30878380462302244e-2, (31, 4) = 1.4906981038048681, (31, 5) = 3.323516416405632, (31, 6) = 0.14321254307782843e-3, (31, 7) = 100.88090151673867, (31, 8) = 1001.7769210769753, (32, 1) = 5.5246337730120425, (32, 2) = 3.5628612506746355, (32, 3) = -0.30352606814447423e-2, (32, 4) = 1.4883981946700946, (32, 5) = 3.3194633513911294, (32, 6) = 0.13906402070449023e-3, (32, 7) = 100.97770343033788, (32, 8) = 1001.8736916098571, (33, 1) = 5.350154592968329, (33, 2) = 3.652390870189664, (33, 3) = -0.29802919291256925e-2, (33, 4) = 1.4859409958580596, (33, 5) = 3.3152345047193488, (33, 6) = 0.1349237800020272e-3, (33, 7) = 101.0800834510413, (33, 8) = 1001.9725260573754, (34, 1) = 5.178387232087359, (34, 2) = 3.7348787387713545, (34, 3) = -0.29229649866224436e-2, (34, 4) = 1.4833141048182175, (34, 5) = 3.31080664765983, (34, 6) = 0.13079708749310837e-3, (34, 7) = 101.18801065170281, (34, 8) = 1002.0734804973796, (35, 1) = 5.009476370444567, (35, 2) = 3.8102002829413735, (35, 3) = -0.28633037678588045e-2, (35, 4) = 1.4805033211699752, (35, 5) = 3.3061525532615232, (35, 6) = 0.12668822669221217e-3, (35, 7) = 101.30145941122774, (35, 8) = 1002.1766360971047, (36, 1) = 4.843557126562859, (36, 2) = 3.8782555782149255, (36, 3) = -0.2801334164721053e-2, (36, 4) = 1.4774929833521062, (36, 5) = 3.3012415269952995, (36, 6) = 0.12260140734034352e-3, (36, 7) = 101.42038870702935, (36, 8) = 1002.2820780375602, (37, 1) = 4.680741872196596, (37, 2) = 3.938974049466876, (37, 3) = -0.27370787280213567e-2, (37, 4) = 1.4742655215506686, (37, 5) = 3.2960385771457625, (37, 6) = 0.11854042985671781e-3, (37, 7) = 101.54475254284954, (37, 8) = 1002.3899044837473, (38, 1) = 4.52122823488075, (38, 2) = 3.992277892889112, (38, 3) = -0.2670601540153369e-2, (38, 4) = 1.47080358362855, (38, 5) = 3.2905076840508305, (38, 6) = 0.11451140561823563e-3, (38, 7) = 101.674412792546, (38, 8) = 1002.5001523517784, (39, 1) = 4.3652229297432115, (39, 2) = 4.038122055085992, (39, 3) = -0.26019850791793313e-2, (39, 4) = 1.4670889383691117, (39, 5) = 3.2846098170255593, (39, 6) = 0.11052094560169408e-3, (39, 7) = 101.80918266317471, (39, 8) = 1002.612838641725, (40, 1) = 4.212889106571467, (40, 2) = 4.076511478042859, (40, 3) = -0.25313086271314417e-2, (40, 4) = 1.463101232994331, (40, 5) = 3.2783008435502317, (40, 6) = 0.10657481951913266e-3, (40, 7) = 101.94886972736465, (40, 8) = 1002.727995962536, (41, 1) = 4.06438301183598, (41, 2) = 4.107488166397131, (41, 3) = -0.24586638988303277e-2, (41, 4) = 1.4588186806990329, (41, 5) = 3.2715325159160855, (41, 6) = 0.10267886947911793e-3, (41, 7) = 102.0932466718976, (41, 8) = 1002.8456463986511, (42, 1) = 3.919886917025248, (42, 2) = 4.13112803294773, (42, 3) = -0.2384174239505647e-2, (42, 4) = 1.454219197438303, (42, 5) = 3.2642541491896986, (42, 6) = 0.9883989545094558e-4, (42, 7) = 102.24201413693095, (42, 8) = 1002.9657706705342, (43, 1) = 3.779574857603436, (43, 2) = 4.147553389326067, (43, 3) = -0.23079821488425447e-2, (43, 4) = 1.4492798162657692, (43, 5) = 3.2564116156780325, (43, 6) = 0.9506478814927868e-4, (43, 7) = 102.39482664776061, (43, 8) = 1003.088328336215, (44, 1) = 3.6435944961175655, (44, 2) = 4.156935453531325, (44, 3) = -0.2230241025272658e-2, (44, 4) = 1.4439762396038949, (44, 5) = 3.247946590134056, (44, 6) = 0.9136003418992978e-4, (44, 7) = 102.55131117254489, (44, 8) = 1003.2132702453185, (45, 1) = 3.5120648112127473, (45, 2) = 4.159491413955829, (45, 3) = -0.2151113496452073e-2, (45, 4) = 1.4382827531275109, (45, 5) = 3.2387963774243635, (45, 6) = 0.8773162115316142e-4, (45, 7) = 102.71107295402261, (45, 8) = 1003.3405400701206, (46, 1) = 3.3850473588317747, (46, 2) = 4.155478742084017, (46, 3) = -0.20707519113143183e-2, (46, 4) = 1.4321707396960714, (46, 5) = 3.2288914661703934, (46, 6) = 0.8418419205476828e-4, (46, 7) = 102.87373761695768, (46, 8) = 1003.4701045399681, (47, 1) = 3.2625966413637784, (47, 2) = 4.145188524084685, (47, 3) = -0.1989326708640548e-2, (47, 4) = 1.4256106523198426, (47, 5) = 3.218158632770821, (47, 6) = 0.8072238743132502e-4, (47, 7) = 103.03889649057243, (47, 8) = 1003.6019067399039, (48, 1) = 3.144746461255684, (48, 2) = 4.128943477554031, (48, 3) = -0.19070183084393803e-2, (48, 4) = 1.4185715718192036, (48, 5) = 3.2065202157075396, (48, 6) = 0.7735044483950526e-4, (48, 7) = 103.20612525220594, (48, 8) = 1003.7358777790233, (49, 1) = 3.0314815478841743, (49, 2) = 4.107087953759735, (49, 3) = -0.18239949277285726e-2, (49, 4) = 1.4110192848841112, (49, 5) = 3.1938908740511445, (49, 6) = 0.7407133810574211e-4, (49, 7) = 103.37503128442931, (49, 8) = 1003.8719716569984, (50, 1) = 2.9227593369044924, (50, 2) = 4.079981687521251, (50, 3) = -0.17404232529257934e-2, (50, 4) = 1.40291689987796, (50, 5) = 3.1801784380877507, (50, 6) = 0.7088733352142471e-4, (50, 7) = 103.54523411929307, (50, 8) = 1004.0101472709666, (51, 1) = 2.818532318088372, (51, 2) = 4.04800032024303, (51, 3) = -0.16564835078594748e-2, (51, 4) = 1.3942262731596269, (51, 5) = 3.165286216461357, (51, 6) = 0.678006047438914e-4, (51, 7) = 103.71633641557084, (51, 8) = 1004.150342378808, (52, 1) = 2.7187280936790317, (52, 2) = 4.011526532303451, (52, 3) = -0.15723525597125968e-2, (52, 4) = 1.3849064453243334, (52, 5) = 3.149110267793224, (52, 6) = 0.6481261618441686e-4, (52, 7) = 103.88795971072348, (52, 8) = 1004.2925000746584, (53, 1) = 2.6232681738966965, (53, 2) = 3.9709513662370832, (53, 3) = -0.14882169460372393e-2, (53, 4) = 1.3749150713099034, (53, 5) = 3.1315417666348657, (53, 6) = 0.6192464377154925e-4, (53, 7) = 104.05971891331018, (53, 8) = 1004.4365454747932, (54, 1) = 2.532039672401558, (54, 2) = 3.9266575489405793, (54, 3) = -0.1404245466004386e-2, (54, 4) = 1.364205215074936, (54, 5) = 3.112461254112237, (54, 6) = 0.591368828689821e-4, (54, 7) = 104.231278977145, (54, 8) = 1004.582431181872, (55, 1) = 2.444915288399487, (55, 2) = 3.879019952940104, (55, 3) = -0.13206019295365567e-2, (55, 4) = 1.3527263662749478, (55, 5) = 3.091740108365379, (55, 6) = 0.5644900171226812e-4, (55, 7) = 104.40232938185949, (55, 8) = 1004.7301155968692, (56, 1) = 2.3617794617568273, (56, 2) = 3.8284169005836826, (56, 3) = -0.12374684641906389e-2, (56, 4) = 1.3404277296168692, (56, 5) = 3.069246336323917, (56, 6) = 0.538609245966871e-4, (56, 7) = 104.57253658598354, (56, 8) = 1004.8795202583855, (57, 1) = 2.282484917273496, (57, 2) = 3.7752020863284894, (57, 3) = -0.11550009710742976e-2, (57, 4) = 1.3272519452804112, (57, 5) = 3.0448329958920137, (57, 6) = 0.51371462558750336e-4, (57, 7) = 104.74163503705402, (57, 8) = 1005.0306077619977, (58, 1) = 2.206876933049816, (58, 2) = 3.7197118247511183, (58, 3) = -0.1073348372828022e-2, (58, 4) = 1.313137022640557, (58, 5) = 3.018341230996348, (58, 6) = 0.4897902878034034e-4, (58, 7) = 104.9093876711253, (58, 8) = 1005.1833486875437, (59, 1) = 2.1348103054809795, (59, 2) = 3.662275158448085, (59, 3) = -0.992669152506124e-3, (59, 4) = 1.2980190506093596, (59, 5) = 2.9896050723126506, (59, 6) = 0.466821606583681e-4, (59, 7) = 105.07555151785476, (59, 8) = 1005.3376899604622, (60, 1) = 2.066135920341177, (60, 2) = 3.6032031903321946, (60, 3) = -0.9131159399183302e-3, (60, 4) = 1.2818297076377272, (60, 5) = 2.9584465619273472, (60, 6) = 0.4447908703403362e-4, (60, 7) = 105.23990869703216, (60, 8) = 1005.4935820835929, (61, 1) = 2.0007018880383085, (61, 2) = 3.5427871837115497, (61, 3) = -0.8348345493164736e-3, (61, 4) = 1.2644957011843787, (61, 5) = 2.9246743090821625, (61, 6) = 0.4236775072626598e-4, (61, 7) = 105.40226780936662, (61, 8) = 1005.6509810588723, (62, 1) = 1.9383993997569469, (62, 2) = 3.4813425849929107, (62, 3) = -0.7580192068672139e-3, (62, 4) = 1.24595219873378, (62, 5) = 2.8881097247802434, (62, 6) = 0.4034728881617895e-4, (62, 7) = 105.56234795216479, (62, 8) = 1005.8097330504858, (63, 1) = 1.879265754192106, (63, 2) = 3.4193319409998444, (63, 3) = -0.6830506388362913e-3, (63, 4) = 1.226186791700086, (63, 5) = 2.8486763956772867, (63, 6) = 0.384214162894923e-4, (63, 7) = 105.7194841431087, (63, 8) = 1005.9692590770709, (64, 1) = 1.823876834786275, (64, 2) = 3.3578552300893394, (64, 3) = -0.6110329379643392e-3, (64, 4) = 1.2054274652072128, (64, 5) = 2.806787590645107, (64, 6) = 0.3661132893261153e-4, (64, 7) = 105.87147271750081, (64, 8) = 1006.1272881736769, (65, 1) = 1.7720460447926063, (65, 2) = 3.2972442630394743, (65, 3) = -0.5421139001385188e-3, (65, 4) = 1.1836992230810017, (65, 5) = 2.762463279578025, (65, 6) = 0.3491317044627193e-4, (65, 7) = 106.01808575355534, (65, 8) = 1006.2834405402563, (66, 1) = 1.723193585722836, (66, 2) = 3.2372943914384056, (66, 3) = -0.47586990605610506e-3, (66, 4) = 1.160843492814887, (66, 5) = 2.7153472041315774, (66, 6) = 0.3330980057532151e-4, (66, 7) = 106.16031072659887, (66, 8) = 1006.4386323329015, (67, 1) = 1.677007477409624, (67, 2) = 3.178020927054096, (67, 3) = -0.4121801890234409e-3, (67, 4) = 1.1367713395996881, (67, 5) = 2.665217429443866, (67, 6) = 0.3179250043435628e-4, (67, 7) = 106.29850582291073, (67, 8) = 1006.593152481529, (68, 1) = 1.6333996676513298, (68, 2) = 3.1196767146842266, (68, 3) = -0.3512014693931245e-3, (68, 4) = 1.1114968482761625, (68, 5) = 2.612064554645336, (68, 6) = 0.30359646191503225e-4, (68, 7) = 106.43242650456075, (68, 8) = 1006.7466133079122, (69, 1) = 1.5923027156197485, (69, 2) = 3.0625240615592473, (69, 3) = -0.2930994253463614e-3, (69, 4) = 1.085063796593711, (69, 5) = 2.555945770449655, (69, 6) = 0.29010059585762927e-4, (69, 7) = 106.56178698466356, (69, 8) = 1006.8985340272344, (70, 1) = 1.5536772751047994, (70, 2) = 3.0068491755936324, (70, 3) = -0.23805746924002874e-3, (70, 4) = 1.0575598942040991, (70, 5) = 2.4970181054048295, (70, 6) = 0.2774325483058201e-4, (70, 7) = 106.68623100421581, (70, 8) = 1007.0482977184555, (71, 1) = 1.517479468589498, (71, 2) = 2.952917619826108, (71, 3) = -0.18622729233276178e-3, (71, 4) = 1.029102594931295, (71, 5) = 2.435511308813636, (71, 6) = 0.2655836894638685e-4, (71, 7) = 106.80543347757383, (71, 8) = 1007.1952666986787, (72, 1) = 1.483674678047859, (72, 2) = 2.900992582023927, (72, 3) = -0.13774457376538517e-3, (72, 4) = .9998525666782392, (72, 5) = 2.3717593326049142, (72, 6) = 0.2545462060882071e-4, (72, 7) = 106.91905858139707, (72, 8) = 1007.338733276349, (73, 1) = 1.4522297150963215, (73, 2) = 2.8513224762327263, (73, 3) = -0.9271442400348364e-4, (73, 4) = .9700115852035236, (73, 5) = 2.306198556352411, (73, 6) = 0.24431064477556568e-4, (73, 7) = 107.02678682429834, (73, 8) = 1007.4779544372792, (74, 1) = 1.4231028565348978, (74, 2) = 2.8041231399671878, (74, 3) = -0.5119453118280671e-4, (74, 4) = .939813245002056, (74, 5) = 2.2393493917132656, (74, 6) = 0.23486285482922064e-4, (74, 7) = 107.12835249503514, (74, 8) = 1007.6122065570883, (75, 1) = 1.3962404367953059, (75, 2) = 2.7595691207862023, (75, 3) = -0.13189380995024111e-4, (75, 4) = .9095142973841915, (75, 5) = 2.171797969445039, (75, 6) = 0.22618317063078462e-4, (75, 7) = 107.22356062901171, (75, 8) = 1007.740820053353, (76, 1) = 1.371577130367831, (76, 2) = 2.7177913154872835, (76, 3) = 0.2134823848711461e-4, (76, 4) = .8793865742755739, (76, 5) = 2.1041780280514213, (76, 6) = 0.2182468555599744e-4, (76, 7) = 107.31229065588529, (76, 8) = 1007.8631993310453, (77, 1) = 1.3490245474990221, (77, 2) = 2.67885518525662, (77, 3) = 0.5252987459855957e-4, (77, 4) = .8496910369806541, (77, 5) = 2.0371113978483546, (77, 6) = 0.21102083671259044e-4, (77, 7) = 107.39454163033987, (77, 8) = 1007.9789027592636, (78, 1) = 1.3284687725360627, (78, 2) = 2.6427536930126583, (78, 3) = 0.8052881409638854e-4, (78, 4) = .8206567289880976, (78, 5) = 1.9711575403489863, (78, 6) = 0.20446338622334644e-4, (78, 7) = 107.47044602626754, (78, 8) = 1008.0876839634886, (79, 1) = 1.3097718241189547, (79, 2) = 2.609408110164726, (79, 3) = 0.10557033034507772e-3, (79, 4) = .7924636212738783, (79, 5) = 1.9067707364483897, (79, 6) = 0.1985250448441742e-4, (79, 7) = 107.54026762711666, (79, 8) = 1008.1895100753335, (80, 1) = 1.292785782460524, (80, 2) = 2.5786932195678793, (80, 3) = 0.12790471280016717e-3, (80, 4) = .7652475297946962, (80, 5) = 1.8443074321404633, (80, 6) = 0.19315348236985073e-4, (80, 7) = 107.60434937220303, (80, 8) = 1008.2845022760924, (81, 1) = 1.2773542755873124, (81, 2) = 2.5504419249372092, (81, 3) = 0.14779845884451377e-3, (81, 4) = .7390921461228508, (81, 5) = 1.7840047914704762, (81, 6) = 0.1882942090471205e-4, (81, 7) = 107.66310537375784, (81, 8) = 1008.3729333672233, (82, 1) = 1.2633105531735604, (82, 2) = 2.5244439038431197, (82, 3) = 0.16553051042363535e-3, (82, 4) = .7140172014047285, (82, 5) = 1.7259503969309267, (82, 6) = 0.1838901465188807e-4, (82, 7) = 107.7170254082598, (82, 8) = 1008.4552413514366, (83, 1) = 1.2505010589680714, (83, 2) = 2.5004920084421127, (83, 3) = 0.18135782632343353e-3, (83, 4) = .690016274965007, (83, 5) = 1.6701675121394153, (83, 6) = 0.17988910636306035e-4, (83, 7) = 107.76658057713867, (83, 8) = 1008.5318877945917, (84, 1) = 1.2387747644167835, (84, 2) = 2.478366064042242, (84, 3) = 0.1955266136903851e-3, (84, 4) = .6670397868157247, (84, 5) = 1.6165746783823618, (84, 6) = 0.17624042193432317e-4, (84, 7) = 107.81225910779223, (84, 8) = 1008.60340896847, (85, 1) = 1.2279973327620057, (85, 2) = 2.4578625448373574, (85, 3) = 0.20825371088370462e-3, (85, 4) = .6450251766331305, (85, 5) = 1.565055312691797, (85, 6) = 0.1728993161543869e-4, (85, 7) = 107.85450686018427, (85, 8) = 1008.6703190964062, (86, 1) = 1.2180461604033224, (86, 2) = 2.4387882945854344, (86, 3) = 0.21973278806508236e-3, (86, 4) = .623893268966289, (86, 5) = 1.5154493245813299, (86, 6) = 0.169825263298283e-4, (86, 7) = 107.89374203891565, (86, 8) = 1008.7331268144675, (87, 1) = 1.208813436024759, (87, 2) = 2.420968851896833, (87, 3) = 0.2301313409230479e-3, (87, 4) = .6035603463485366, (87, 5) = 1.4675816086289168, (87, 6) = 0.16698284480847687e-4, (87, 7) = 107.93033942657502, (87, 8) = 1008.7923041717536, (88, 1) = 1.200207167289285, (88, 2) = 2.404252645496022, (88, 3) = 0.23959075898127673e-3, (88, 4) = .5839469305020923, (88, 5) = 1.4212832070383317, (88, 6) = 0.1643419646938823e-4, (88, 7) = 107.9646229427594, (88, 8) = 1008.8482683568902, (89, 1) = 1.192144637830353, (89, 2) = 2.3885000623118042, (89, 3) = 0.24823481831505657e-3, (89, 4) = .564968738557786, (89, 5) = 1.3763704779813828, (89, 6) = 0.16187575216887474e-4, (89, 7) = 107.99688898594378, (89, 8) = 1008.9014143577331, (90, 1) = 1.1845549234192725, (90, 2) = 2.373589642009134, (90, 3) = 0.256167932069057e-3, (90, 4) = .546546852013684, (90, 5) = 1.3326694976205116, (90, 6) = 0.15956126537873774e-4, (90, 7) = 108.02739440307086, (90, 8) = 1008.9520912027735, (91, 1) = 1.1773791797294266, (91, 2) = 2.3594198163591105, (91, 3) = 0.2634761530457433e-3, (91, 4) = .5286131757300976, (91, 5) = 1.2900295304817477, (91, 6) = 0.15737950899387407e-4, (91, 7) = 108.05635351212293, (91, 8) = 1009.0005928495993, (92, 1) = 1.170564701245008, (92, 2) = 2.345898097281151, (92, 3) = 0.27023438241683014e-3, (92, 4) = .5110995918698664, (92, 5) = 1.248297699507849, (92, 6) = 0.1553135697281658e-4, (92, 7) = 108.08396064552066, (92, 8) = 1009.0471925135606, (93, 1) = 1.1640664024249363, (93, 2) = 2.3329446303193726, (93, 3) = 0.27650560865928283e-3, (93, 4) = .493944309283272, (93, 5) = 1.2073343646804715, (93, 6) = 0.15334902741057016e-4, (93, 7) = 108.11038319471544, (93, 8) = 1009.092128715933, (94, 1) = 1.1578455753795385, (94, 2) = 2.32049027723128, (94, 3) = 0.28234293455207043e-3, (94, 4) = .4770912633312428, (94, 5) = 1.1670120052108626, (94, 6) = 0.1514735412409919e-4, (94, 7) = 108.1357657848123, (94, 8) = 1009.1356101562209, (95, 1) = 1.151868954719366, (95, 2) = 2.3084751808387076, (95, 3) = 0.28779115180150704e-3, (95, 4) = .46048977627620397, (95, 5) = 1.127214668852344, (95, 6) = 0.14967653696341687e-4, (95, 7) = 108.1602334024605, (95, 8) = 1009.1778192737107, (96, 1) = 1.1461078149776158, (96, 2) = 2.29684729588608, (96, 3) = 0.2928881547161977e-3, (96, 4) = .44409386332597134, (96, 5) = 1.0878365278247146, (96, 6) = 0.14794891026479485e-4, (96, 7) = 108.1838945456674, (96, 8) = 1009.2189162180401, (97, 1) = 1.1405371100063924, (97, 2) = 2.285560922316409, (97, 3) = 0.29766618738189714e-3, (97, 4) = .4278612487695864, (97, 5) = 1.048779692803115, (97, 6) = 0.14628274847877453e-4, (97, 7) = 108.20684433059007, (97, 8) = 1009.2590430757165, (98, 1) = 1.1351350507868603, (98, 2) = 2.274576062841772, (98, 3) = 0.3021526052869504e-3, (98, 4) = .41175332362884526, (98, 5) = 1.0099542534723644, (98, 6) = 0.14467118803029708e-4, (98, 7) = 108.22916589308201, (98, 8) = 1009.298325381669, (99, 1) = 1.129882645674095, (99, 2) = 2.2638576629535483, (99, 3) = 0.30637060824777586e-3, (99, 4) = .39573479610666523, (99, 5) = .9712775607193374, (99, 6) = 0.14310826348864847e-4, (99, 7) = 108.25093201001752, (99, 8) = 1009.3368741772966, (100, 1) = 1.1247633960158296, (100, 2) = 2.253375132898194, (100, 3) = 0.3103397890263327e-3, (100, 4) = .3797736326282997, (100, 5) = .9326741915263894, (100, 6) = 0.14158880540772325e-4, (100, 7) = 108.27220613213622, (100, 8) = 1009.3747871717721, (101, 1) = 1.1197628299893865, (101, 2) = 2.243101510938904, (101, 3) = 0.31407675910876765e-3, (101, 4) = .363840347759116, (101, 5) = .8940743241034856, (101, 6) = 0.14010829218302085e-4, (101, 7) = 108.29304413259052, (101, 8) = 1009.4121512943889, (102, 1) = 1.1148682852858023, (102, 2) = 2.2330131114004486, (102, 3) = 0.31759552909490547e-3, (102, 4) = .3479079198879219, (102, 5) = .8554136081318738, (102, 6) = 0.13866277774859106e-4, (102, 7) = 108.31349506088394, (102, 8) = 1009.4490435884408, (103, 1) = 1.1100690162583013, (103, 2) = 2.223089828411273, (103, 3) = 0.32090764062656676e-3, (103, 4) = .3319527087511955, (103, 5) = .8166354640283016, (103, 6) = 0.13724891596992297e-4, (103, 7) = 108.33360056147548, (103, 8) = 1009.4855297432207, (104, 1) = 1.1053549160607077, (104, 2) = 2.2133125605838093, (104, 3) = 0.32402322044088326e-3, (104, 4) = .3159506731099912, (104, 5) = .777681948766702, (104, 6) = 0.1358635782671519e-4, (104, 7) = 108.35340011909545, (104, 8) = 1009.5216732714151, (105, 1) = 1.1007173156995493, (105, 2) = 2.20366490979554, (105, 3) = 0.32695053552961724e-3, (105, 4) = .29988032519327096, (105, 5) = .738500968903049, (105, 6) = 0.13450408503890039e-4, (105, 7) = 108.37292763649033, (105, 8) = 1009.5575290728453, (106, 1) = 1.0961490982048523, (106, 2) = 2.194133475615768, (106, 3) = 0.32969609732425253e-3, (106, 4) = .28372358213661114, (106, 5) = .6990484193099787, (106, 6) = 0.13316823368029326e-4, (106, 7) = 108.3922108606125, (106, 8) = 1009.5931420618228, (107, 1) = 1.0916437604807332, (107, 2) = 2.184705945332422, (107, 3) = 0.33226537947844773e-3, (107, 4) = .267462841916087, (107, 5) = .6592810977639261, (107, 6) = 0.13185401961071409e-4, (107, 7) = 108.41127526486004, (107, 8) = 1009.6285540648985, (108, 1) = 1.0871957217609958, (108, 2) = 2.1753717673288526, (108, 3) = 0.3346627164823903e-3, (108, 4) = .2510822963378531, (108, 5) = .6191599377734077, (108, 6) = 0.13055972370279655e-4, (108, 7) = 108.43014269860242, (108, 8) = 1009.6638011673451, (109, 1) = 1.082800342884562, (109, 2) = 2.1661222244780514, (109, 3) = 0.33689140727870726e-3, (109, 4) = .23456828973869584, (109, 5) = .578650926733286, (109, 6) = 0.12928391457567054e-4, (109, 7) = 108.44883125109214, (109, 8) = 1009.6989132638626, (110, 1) = 1.0784527300706157, (110, 2) = 2.1569479381902137, (110, 3) = 0.33895438612868364e-3, (110, 4) = .21790499193454377, (110, 5) = .5377145107542645, (110, 6) = 0.12802509932592766e-4, (110, 7) = 108.46736030276855, (110, 8) = 1009.7339234312249, (111, 1) = 1.0741494664841609, (111, 2) = 2.1478425334789786, (111, 3) = 0.3408534176927792e-3, (111, 4) = .20108108845544617, (111, 5) = .4963220299993043, (111, 6) = 0.12678222399020893e-4, (111, 7) = 108.48574312792246, (111, 8) = 1009.7688539046025, (112, 1) = 1.0698875589298389, (112, 2) = 2.1388004463484536, (112, 3) = 0.34258973036048625e-3, (112, 4) = .18408606496818333, (112, 5) = .4544466413829278, (112, 6) = 0.12555436521058364e-4, (112, 7) = 108.50399133313152, (112, 8) = 1009.8037242597546, (113, 1) = 1.0656646326866508, (113, 2) = 2.129817352834518, (113, 3) = 0.34416399952391e-3, (113, 4) = .16691113787578332, (113, 5) = .41206563262789075, (113, 6) = 0.12434078469019902e-4, (113, 7) = 108.52211399687606, (113, 8) = 1009.8385496691683, (114, 1) = 1.0614784569653106, (114, 2) = 2.120889174509504, (114, 3) = 0.34557659014352546e-3, (114, 4) = .149547482712354, (114, 5) = .3691560735264752, (114, 6) = 0.12314079116049633e-4, (114, 7) = 108.5401196808661, (114, 8) = 1009.8733446670566, (115, 1) = 1.1190268012437492, (115, 2) = 2.1125066669681547, (115, 3) = 0.3385423827650658e-3, (115, 4) = .13191785946901147, (115, 5) = .3255897170931506, (115, 6) = 0.11916762098433257e-4, (115, 7) = 108.55737154225534, (115, 8) = 1009.8465687920385, (116, 1) = 1.4022063033600545, (116, 2) = 2.1071091978033976, (116, 3) = 0.30504313639639473e-3, (116, 4) = .11386577088150214, (116, 5) = .28111876240310024, (116, 6) = 0.10642153338419899e-4, (116, 7) = 108.57216916543068, (116, 8) = 1009.5935321898036, (117, 1) = 1.9241264182505855, (117, 2) = 2.1065504401104227, (117, 3) = 0.2516253404831578e-3, (117, 4) = 0.9543698838191442e-1, (117, 5) = .235806615226062, (117, 6) = 0.8719201916033117e-5, (117, 7) = 108.58440184816543, (117, 8) = 1009.099285610769, (118, 1) = 2.687052622022314, (118, 2) = 2.1117841995674485, (118, 3) = 0.18693062889992302e-3, (118, 4) = 0.7669476443740557e-1, (118, 5) = .18974281548157357, (118, 6) = 0.64430252447126135e-5, (118, 7) = 108.59407387869393, (118, 8) = 1008.3605071545982, (119, 1) = 3.694514886643791, (119, 2) = 2.122885496726727, (119, 3) = 0.11994698241791731e-3, (119, 4) = 0.5770778722005928e-1, (119, 5) = .14302685091879444, (119, 6) = 0.4116784358234e-5, (119, 7) = 108.60116464871184, (119, 8) = 1007.3735087747729, (120, 1) = 4.95151117738771, (120, 2) = 2.139013752739792, (120, 3) = 0.59987662084718824e-4, (120, 4) = 0.3854622644463407e-1, (120, 5) = 0.9575865292968025e-1, (120, 6) = 0.20519614238688914e-5, (120, 7) = 108.60562411477576, (120, 8) = 1006.1340820766882, (121, 1) = 6.4645108157551245, (121, 2) = 2.1583526343896744, (121, 3) = 0.16689266341603627e-4, (121, 4) = 0.19283655706716363e-1, (121, 5) = 0.4804356188673288e-1, (121, 6) = 0.5693838123095452e-6, (121, 7) = 108.60737029527003, (121, 8) = 1004.6375531231579, (122, 1) = 8.241205253154899, (122, 2) = 2.1780220972460627, (122, 3) = .0, (122, 4) = .0, (122, 5) = .0, (122, 6) = .0, (122, 7) = 108.6062948231846, (122, 8) = 1002.8791080809377}, datatype = float[8], order = C_order); YP := Matrix(122, 8, {(1, 1) = -12.9, (1, 2) = 12.5, (1, 3) = 0.14559656363819994e-4, (1, 4) = -0.4163661210749914e-1, (1, 5) = -.18801257965198026, (1, 6) = -0.23168477231542452e-3, (1, 7) = -.27999999999999997, (1, 8) = 4.495, (2, 1) = -12.686043472570276, (2, 2) = 12.216620685692547, (2, 3) = 0.9509983157261424e-4, (2, 4) = -0.421631377270717e-1, (2, 5) = -.18524256445177478, (2, 6) = -0.22943208236613237e-3, (2, 7) = -.1572027667241701, (2, 8) = 4.441977358357099, (3, 1) = -12.472034722546566, (3, 2) = 11.932379814095862, (3, 3) = 0.1742248100126113e-3, (3, 4) = -0.4270867813134305e-1, (3, 5) = -.18249805235200345, (3, 6) = -0.22715018280332425e-3, (3, 7) = -0.3446658069756531e-1, (3, 8) = 4.389855619859547, (4, 1) = -12.257932846153826, (4, 2) = 11.647247375252485, (4, 3) = 0.2519290648627995e-3, (4, 4) = -0.4327438707857412e-1, (4, 5) = -.1797810568598619, (4, 6) = -0.22483800258372473e-3, (4, 7) = 0.8819647452672669e-1, (4, 8) = 4.3386377838574814, (5, 1) = -12.0436944524579, (5, 2) = 11.361192110284327, (5, 3) = 0.32820680598573794e-3, (5, 4) = -0.438615179855375e-1, (5, 5) = -.17709378355301197, (5, 6) = -0.22249440499823222e-3, (5, 7) = .21077310027747564, (5, 8) = 4.288326953170187, (6, 1) = -11.82927345415494, (6, 2) = 11.074181443013508, (6, 3) = 0.4030519566452355e-3, (6, 4) = -0.4447143521443331e-1, (6, 5) = -.17443865291295424, (6, 6) = -0.22011818197447083e-3, (6, 7) = .3332486463635594, (6, 8) = 4.238926341626846, (7, 1) = -11.614620835860368, (7, 2) = 10.786181407881124, (7, 3) = 0.47645812686475874e-3, (7, 4) = -0.4510562695511533e-1, (7, 5) = -.17181832648148543, (7, 6) = -0.217708047736528e-3, (7, 7) = .45560695621314956, (7, 8) = 4.19043928271548, (8, 1) = -11.399684396950834, (8, 2) = 10.49715657421299, (8, 3) = 0.5484185828100621e-3, (8, 4) = -0.4576571997491996e-1, (8, 5) = -.16923573691928517, (8, 6) = -0.21526263173245321e-3, (8, 7) = .5778301905549862, (8, 8) = 4.1428692395581646, (9, 1) = -11.184408465608355, (9, 2) = 10.207069967057492, (9, 3) = 0.6189262114319743e-3, (9, 4) = -0.4645349656293485e-1, (9, 5) = -.16669412266483086, (9, 6) = -0.21278047072586918e-3, (9, 7) = .6998986260408782, (9, 8) = 4.096219816490436, (10, 1) = -10.9687335811767, (10, 2) = 9.915882986317413, (10, 3) = 0.6879734791301275e-3, (10, 4) = -0.4717091405973051e-1, (10, 5) = -.16419706804950618, (10, 6) = -0.2102599999421636e-3, (10, 7) = .8217904239472903, (10, 8) = 4.050494772790783, (11, 1) = -10.752595483337865, (11, 2) = 9.623554435478157, (11, 3) = 0.7555525863015649e-3, (11, 4) = -0.4792012977487947e-1, (11, 5) = -.1617485425376941, (11, 6) = -0.20769953529189966e-3, (11, 7) = .943481732942917, (11, 8) = 4.005697904346786, (12, 1) = -10.535923687878967, (12, 2) = 9.33003903793159, (12, 3) = 0.8216556954754784e-3, (12, 4) = -0.4870353152936224e-1, (12, 5) = -.15935294476059259, (12, 6) = -0.2050972491895925e-3, (12, 7) = 1.0649469484388718, (12, 8) = 3.9618328730127637, (13, 1) = -10.318644268503194, (13, 2) = 9.035291720141014, (13, 3) = 0.8862738520788469e-3, (13, 4) = -0.4952375726273184e-1, (13, 5) = -.15701520308822925, (13, 6) = -0.20245119599772413e-3, (13, 7) = 1.1861565354219825, (13, 8) = 3.91890390043357, (14, 1) = -10.100677808590822, (14, 2) = 8.739265444735379, (14, 3) = 0.9493974064037139e-3, (14, 4) = -0.5038373603255697e-1, (14, 5) = -.1547408325562145, (14, 6) = -0.1997592796547546e-3, (14, 7) = 1.307077488525317, (14, 8) = 3.8769154636672, (15, 1) = -9.881938657792366, (15, 2) = 8.44191089278885, (15, 3) = 0.10110159694483125e-2, (15, 4) = -0.5128673107073989e-1, (15, 5) = -.15253602169960878, (15, 6) = -0.19701923503350675e-3, (15, 7) = 1.4276729449504248, (15, 8) = 3.8358722947082837, (16, 1) = -9.662334248210717, (16, 2) = 8.143176335355932, (16, 3) = 0.10711183062499317e-2, (16, 4) = -0.52236390170373515e-1, (16, 5) = -.15040773762089543, (16, 6) = -0.19422860849893634e-3, (16, 7) = 1.5479016371741743, (16, 8) = 3.7957794159908445, (17, 1) = -9.441764313523123, (17, 2) = 7.84300750372199, (17, 3) = 0.1129692207694349e-2, (17, 4) = -0.5323680563248345e-1, (17, 5) = -.14836385142769082, (17, 6) = -0.19138473553845733e-3, (17, 7) = 1.6677172492730437, (17, 8) = 3.756642183512638, (18, 1) = -9.220119995148956, (18, 2) = 7.541347462981362, (18, 3) = 0.11867243352790377e-2, (18, 4) = -0.5429258597647446e-1, (18, 5) = -.14641328883245563, (18, 6) = -0.1884847149311544e-3, (18, 7) = 1.7870676556106824, (18, 8) = 3.7184663397232587, (19, 1) = -8.997282812417346, (19, 2) = 7.238136490136707, (19, 3) = 0.12422000327754587e-2, (19, 4) = -0.55408942241977455e-1, (19, 5) = -.14456621200495423, (19, 6) = -0.1855253787522941e-3, (19, 7) = 1.9058940173203145, (19, 8) = 3.6812580782527107, (20, 1) = -8.773123145651379, (20, 2) = 6.933311520127436, (20, 3) = 0.1296103173031917e-2, (20, 4) = -0.5659179427136318e-1, (20, 5) = -.14283423814045193, (20, 6) = -0.18250325295306985e-3, (20, 7) = 2.024129874767431, (20, 8) = 3.6450240719836318, (21, 1) = -8.547495116846914, (21, 2) = 6.62680098533245, (21, 3) = 0.13484167105334115e-2, (21, 4) = -0.57847920007245035e-1, (21, 5) = -.1412306855709895, (21, 6) = -0.17941446444829517e-3, (21, 7) = 2.1417017759161094, (21, 8) = 3.6097710076436407, (22, 1) = -8.320240678523659, (22, 2) = 6.318532534639418, (22, 3) = 0.13991209035697386e-2, (22, 4) = -0.5918508428728764e-1, (22, 5) = -.13977095632367842, (22, 6) = -0.1762547682309569e-3, (22, 7) = 2.2585246497228884, (22, 8) = 3.5755066663441504, (23, 1) = -8.091186638419193, (23, 2) = 6.008431566858392, (23, 3) = 0.14481931697615418e-2, (23, 4) = -0.6061223790223913e-1, (23, 5) = -.1384729411390957, (23, 6) = -0.17301947614876514e-3, (23, 7) = 2.3745004808714447, (23, 8) = 3.5422398837309848, (24, 1) = -7.860141225471557, (24, 2) = 5.696419689498152, (24, 3) = 0.14956077957278856e-2, (24, 4) = -0.6213976760941553e-1, (24, 5) = -.1373575329577541, (24, 6) = -0.16970337150776476e-3, (24, 7) = 2.489516571512958, (24, 8) = 3.5099805714400016, (25, 1) = -7.626891242089342, (25, 2) = 5.382414665153176, (25, 3) = 0.15413352397805932e-2, (25, 4) = -0.637798047696796e-1, (25, 5) = -.13644928766449027, (25, 6) = -0.16630062293968625e-3, (25, 7) = 2.6034427047135407, (25, 8) = 3.478739966949525, (26, 1) = -7.3911986406926715, (26, 2) = 5.066330455357513, (26, 3) = 0.15853412346706881e-2, (26, 4) = -0.6554661868754796e-1, (26, 5) = -.13577726912579813, (26, 6) = -0.16280467963615924e-3, (26, 7) = 2.716127607456917, (26, 8) = 3.4485309585577477, (27, 1) = -7.152796380451475, (27, 2) = 4.74807742070367, (27, 3) = 0.16275856207472155e-2, (27, 4) = -0.674571234009953e-1, (27, 5) = -.13537614190190705, (27, 6) = -0.1592081428926646e-3, (27, 7) = 2.827394497199891, (27, 8) = 3.419368512513733, (28, 1) = -6.911383372700918, (28, 2) = 4.42756276154696, (28, 3) = 0.16680208119225276e-2, (28, 4) = -0.6953153850622007e-1, (28, 5) = -.13528760133118478, (28, 6) = -0.15550260717266782e-3, (28, 7) = 2.9370354171560127, (28, 8) = 3.391270240147849, (29, 1) = -6.666618263523179, (29, 2) = 4.104691330144327, (29, 3) = 0.17065897542556873e-2, (29, 4) = -0.7179426221205132e-1, (29, 5) = -.13556227004617227, (29, 6) = -0.15167846154651797e-3, (29, 7) = 3.044803949190189, (29, 8) = 3.364257159664355, (30, 1) = -6.418103382603729, (30, 2) = 3.7793561499115613, (30, 3) = 0.1743224358738649e-2, (30, 4) = -0.7427512812811199e-1, (30, 5) = -.13626228112158323, (30, 6) = -0.1477245051514262e-3, (30, 7) = 3.150409197055013, (30, 8) = 3.338353889457409, (31, 1) = -6.1662651905312025, (31, 2) = 3.4525904694192335, (31, 3) = 0.17777240796953925e-2, (31, 4) = -0.7700099275416528e-1, (31, 5) = -.13745967707276208, (31, 6) = -0.1436421807070619e-3, (31, 7) = 3.2531474823207085, (31, 8) = 3.313674758474228, (32, 1) = -5.914418136834189, (32, 2) = 3.1291592905499392, (32, 3) = 0.18095475027400977e-2, (32, 4) = -0.7996784934948997e-1, (32, 5) = -.13921376272634411, (32, 6) = -0.13948121276660368e-3, (32, 7) = 3.351185365397115, (32, 8) = 3.2905813196345246, (33, 1) = -5.667836498662318, (33, 2) = 2.816158918809368, (33, 3) = 0.18380699434922846e-2, (33, 4) = -0.8313760842841922e-1, (33, 5) = -.14154469940719672, (33, 6) = -0.13532855134203327e-3, (33, 7) = 3.4421984372403336, (33, 8) = 3.2695150809238167, (34, 1) = -5.426694665746669, (34, 2) = 2.514012577011563, (34, 3) = 0.1863392330849086e-2, (34, 4) = -0.865262692973483e-1, (34, 5) = -.14449407556056482, (34, 6) = -0.13118947875558767e-3, (34, 7) = 3.5260122815916732, (34, 8) = 3.2504010349557984, (35, 1) = -5.191099657841389, (35, 2) = 2.2230331631378526, (35, 3) = 0.18856198963925978e-2, (35, 4) = -0.901521504588012e-1, (35, 5) = -.1481072101415224, (35, 6) = -0.1270682913722888e-3, (35, 7) = 3.6024999103665176, (35, 8) = 3.2331598785439892, (36, 1) = -4.96114830131193, (36, 2) = 1.9434954952957533, (36, 3) = 0.19048529515209689e-2, (36, 4) = -0.940354553392968e-1, (36, 5) = -.15243331760589296, (36, 6) = -0.12296921156236453e-3, (36, 7) = 3.671559523658136, (36, 8) = 3.2177144579749983, (37, 1) = -4.7369101189371525, (37, 2) = 1.6756148478108566, (37, 3) = 0.19211864654759966e-2, (37, 4) = -0.981988490096799e-1, (37, 5) = -.15752651864533807, (37, 6) = -0.11889605114628795e-3, (37, 7) = 3.733119272827664, (37, 8) = 3.203989707807116, (38, 1) = -4.51857610546374, (38, 2) = 1.419720727138479, (38, 3) = 0.19346993037833197e-2, (38, 4) = -.10266471575839575, (38, 5) = -.16344254241229628, (38, 6) = -0.11485493983509032e-3, (38, 7) = 3.787100212369256, (38, 8) = 3.191921770898727, (39, 1) = -4.306352156078865, (39, 2) = 1.1761192837878625, (39, 3) = 0.19454651388260064e-2, (39, 4) = -.10745657389566876, (39, 5) = -.17023989084991697, (39, 6) = -0.11085250843849915e-3, (39, 7) = 3.833456948198187, (39, 8) = 3.1814498670294755, (40, 1) = -4.100387907418821, (40, 2) = .945009216488903, (40, 3) = 0.19535555339499633e-2, (40, 4) = -.11260067854432632, (40, 5) = -.1779821830015198, (40, 6) = -0.10689454397769005e-3, (40, 7) = 3.8721950984216216, (40, 8) = 3.1725132157928178, (41, 1) = -3.9008276007041376, (41, 2) = .7265413084140153, (41, 3) = 0.19590358130240175e-2, (41, 4) = -.1181251347284411, (41, 5) = -.1867372295266705, (41, 6) = -0.10298690608755528e-3, (41, 7) = 3.90335818970938, (41, 8) = 3.165054489461605, (42, 1) = -3.70785389437607, (42, 2) = .5208629313569659, (42, 3) = 0.19619649358512316e-2, (42, 4) = -.12405843092716595, (42, 5) = -.19657464233576682, (42, 6) = -0.991364151372984e-4, (42, 7) = 3.9270245511958914, (42, 8) = 3.159021009990812, (43, 1) = -3.5216408830713277, (43, 2) = .3280619793186643, (43, 3) = 0.19623989035124426e-2, (43, 4) = -.13043019457213534, (43, 5) = -.20756677529335743, (43, 6) = -0.953499825137265e-4, (43, 7) = 3.943319977169306, (43, 8) = 3.15436205631094, (44, 1) = -3.3423297451191445, (44, 2) = .14814153940375263, (44, 3) = 0.19603916525058706e-2, (44, 4) = -.1372717696146719, (44, 5) = -.21978973470964291, (44, 6) = -0.9163411429249956e-4, (44, 7) = 3.9524202290843164, (44, 8) = 3.1510279659757074, (45, 1) = -3.1700257259398015, (45, 2) = -0.18979884777245104e-1, (45, 3) = 0.1955995125909025e-2, (45, 4) = -.1446163276151997, (45, 5) = -.23332376108270214, (45, 6) = -0.8799481601662089e-4, (45, 7) = 3.954548023372877, (45, 8) = 3.1489701084687907, (46, 1) = -3.004760783466385, (46, 2) = -.17349826806933955, (46, 3) = 0.19492576984010141e-2, (46, 4) = -.15250078476088635, (46, 5) = -.24825711968926623, (46, 6) = -0.8443674463093257e-4, (46, 7) = 3.949967104074824, (46, 8) = 3.1481407416631226, (47, 1) = -2.8465595395457512, (47, 2) = -.31565403382504353, (47, 3) = 0.19402257854998634e-2, (47, 4) = -.16096325675344203, (47, 5) = -.2646817562204671, (47, 6) = -0.8096455459361899e-4, (47, 7) = 3.9389756050946607, (47, 8) = 3.1484937786216296, (48, 1) = -2.6954206097919604, (48, 2) = -.4457470096376679, (48, 3) = 0.19289449066879037e-2, (48, 4) = -.1700436294245753, (48, 5) = -.28269446853851843, (48, 6) = -0.7758249617402377e-4, (48, 7) = 3.921903971348493, (48, 8) = 3.14998377571912, (49, 1) = -2.551279992545946, (49, 2) = -.5641612961301012, (49, 3) = 0.19154571389021447e-2, (49, 4) = -.17978603802818882, (49, 5) = -.30240215899068446, (49, 6) = -0.7429355212005932e-4, (49, 7) = 3.8991046189816414, (49, 8) = 3.1525660814008853, (50, 1) = -2.4140393155573205, (50, 2) = -.6713314176419107, (50, 3) = 0.18998019986945422e-2, (50, 4) = -.19023807285873495, (50, 5) = -.3239208230457393, (50, 6) = -0.7109999552198897e-4, (50, 7) = 3.870945618913796, (50, 8) = 3.156196907870208, (51, 1) = -2.2835936435202253, (51, 2) = -.7677149418471476, (51, 3) = 0.18820200870859965e-2, (51, 4) = -.20144893930332186, (51, 5) = -.34737209648732836, (51, 6) = -0.6800400655812307e-4, (51, 7) = 3.837811317401178, (51, 8) = 3.160832194480659, (52, 1) = -2.1598057493677008, (52, 2) = -.8538080071428684, (52, 3) = 0.18621510515982405e-2, (52, 4) = -.2134714750825515, (52, 5) = -.3728876850134597, (52, 6) = -0.6500705403297011e-4, (52, 7) = 3.800093183817349, (52, 8) = 3.1664277239197043, (53, 1) = -2.0425292664201824, (53, 2) = -.9301232308404375, (53, 3) = 0.1840237249500621e-2, (53, 4) = -.22636030541996877, (53, 5) = -.40060579927184303, (53, 6) = -0.6211041770286389e-4, (53, 7) = 3.758191236821894, (53, 8) = 3.172937924977245, (54, 1) = -1.9315737197281984, (54, 2) = -.9972074113750669, (54, 3) = 0.1816317309801373e-2, (54, 4) = -.24017597789349487, (54, 5) = -.4306803670701198, (54, 6) = -0.5931429351758904e-4, (54, 7) = 3.712496862987955, (54, 8) = 3.180317620841466, (55, 1) = -1.8267297361984929, (55, 2) = -1.055617039617152, (55, 3) = 0.17904285651994117e-2, (55, 4) = -.2549836509295822, (55, 5) = -.46327880266090204, (55, 6) = -0.5661834871740492e-4, (55, 7) = 3.663393363853328, (55, 8) = 3.188521365460822, (56, 1) = -1.7278003379724927, (56, 2) = -1.1058975874226693, (56, 3) = 0.17626149590314888e-2, (56, 4) = -.2708488505475968, (56, 5) = -.49857297134294587, (56, 6) = -0.5402250737047715e-4, (56, 7) = 3.6112676288374055, (56, 8) = 3.197500807705304, (57, 1) = -1.6345489109257143, (57, 2) = -1.148608064916329, (57, 3) = 0.1732913161062528e-2, (57, 4) = -.2878455709939334, (57, 5) = -.536757440775034, (57, 6) = -0.5152557694642658e-4, (57, 7) = 3.556481222943897, (57, 8) = 3.2072090647582367, (58, 1) = -1.5467292421274066, (58, 2) = -1.1842983679239154, (58, 3) = 0.1701357221979878e-2, (58, 4) = -.30605378024963725, (58, 5) = -.5780446348754804, (58, 6) = -0.49125965866681355e-4, (58, 7) = 3.499377898232765, (58, 8) = 3.2175993055245797, (59, 1) = -1.4641054233092465, (59, 2) = -1.213498786103746, (59, 3) = 0.16679849241495045e-2, (59, 4) = -.3255559236977825, (59, 5) = -.6226573166475129, (59, 6) = -0.46822207140343194e-4, (59, 7) = 3.4402940070634824, (59, 8) = 3.2286226293591698, (60, 1) = -1.3864362201354752, (60, 2) = -1.2367254813256552, (60, 3) = 0.16328322642358655e-2, (60, 4) = -.3464401362134406, (60, 5) = -.6708361840301169, (60, 6) = -0.44612524295135714e-4, (60, 7) = 3.379547528047742, (60, 8) = 3.240229879462454, (61, 1) = -1.3134769362296963, (61, 2) = -1.2544770546863573, (61, 3) = 0.1595932349810094e-2, (61, 4) = -.36880096524824313, (61, 5) = -.7228420202041441, (61, 6) = -0.4249485397844477e-4, (61, 7) = 3.317436123957681, (61, 8) = 3.252372050490557, (62, 1) = -1.2450300702369754, (62, 2) = -1.267223890396302, (62, 3) = 0.15573431607413585e-2, (62, 4) = -.39272204484497175, (62, 5) = -.7789154327269152, (62, 6) = -0.40468330682627486e-4, (62, 7) = 3.2542823928362745, (62, 8) = 3.264991285633956, (63, 1) = -1.1810528111894785, (63, 2) = -1.2754096647197026, (63, 3) = 0.15172321034708e-2, (63, 4) = -.41821938227086153, (63, 5) = -.8391413400081973, (63, 6) = -0.3853668053836078e-4, (63, 7) = 3.190560127390515, (63, 8) = 3.2779940953641904, (64, 1) = -1.1220597663010925, (64, 2) = -1.279480500411856, (64, 3) = 0.14762258895406905e-2, (64, 4) = -.44499887727115195, (64, 5) = -.902863951853722, (64, 6) = -0.3672116291940936e-4, (64, 7) = 3.127397916538624, (64, 8) = 3.2911422892760847, (65, 1) = -1.067725471093005, (65, 2) = -1.2800213628310853, (65, 3) = 0.14345021295480347e-2, (65, 4) = -.47302827498562805, (65, 5) = -.9700362379301195, (65, 6) = -0.3501790995761074e-4, (65, 7) = 3.0651348910395977, (65, 8) = 3.304349523213025, (66, 1) = -1.0173275068348866, (66, 2) = -1.2775400727711648, (66, 3) = 0.13918798384122259e-2, (66, 4) = -.5025121337357243, (66, 5) = -1.0411820692562799, (66, 6) = -0.33409729977047476e-4, (66, 7) = 3.003559347087377, (66, 8) = 3.317645369223155, (67, 1) = -.9704456806540824, (67, 2) = -1.2724428359153115, (67, 3) = 0.13483221384814946e-2, (67, 4) = -.5335651793652803, (67, 5) = -1.1166191842948479, (67, 6) = -0.3188787793565934e-4, (67, 7) = 2.9426858281264456, (67, 8) = 3.331013390718444, (68, 1) = -.9268971616568793, (68, 2) = -1.265107733001118, (68, 3) = 0.13039748575056395e-2, (68, 4) = -.5661692425091953, (68, 5) = -1.1963458205663775, (68, 6) = -0.30450725130077733e-4, (68, 7) = 2.882772969464229, (68, 8) = 3.344382713447394, (69, 1) = -.886520923130969, (69, 2) = -1.2558971107281165, (69, 3) = 0.12590159701369582e-2, (69, 4) = -.6002678499548033, (69, 5) = -1.2802635581590378, (69, 6) = -0.2909708976452021e-4, (69, 7) = 2.8240891818364418, (69, 8) = 3.357677292075523, (70, 1) = -.84918424235142, (70, 2) = -1.245163532248251, (70, 3) = 0.12136719551360388e-2, (70, 4) = -.6357478563443968, (70, 5) = -1.3681287845855072, (70, 6) = -0.27826484595073752e-4, (70, 7) = 2.7669274660928576, (70, 8) = 3.3708125738902486, (71, 1) = -.8147507764251498, (71, 2) = -1.2332433412788022, (71, 3) = 0.11681863851341426e-2, (71, 4) = -.6724577463222527, (71, 5) = -1.4595943173534174, (71, 6) = -0.2663804405322601e-4, (71, 7) = 2.7115596717899084, (71, 8) = 3.3837061614141226, (72, 1) = -.783094813220846, (72, 2) = -1.220458789385539, (72, 3) = 0.1122836530792872e-2, (72, 4) = -.7101902583627937, (72, 5) = -1.5541632567774641, (72, 6) = -0.2553098447064717e-4, (72, 7) = 2.658255257920214, (72, 8) = 3.3962740605596533, (73, 1) = -.7540945087832966, (73, 2) = -1.207114680936288, (73, 3) = 0.10779246227641428e-2, (73, 4) = -.7486851017913236, (73, 5) = -1.6511924198304486, (73, 6) = -0.24504357670989236e-4, (73, 7) = 2.607268565284486, (73, 8) = 3.4084341671776084, (74, 1) = -.7276238396363006, (74, 2) = -1.193491957696597, (74, 3) = 0.10337610564881649e-2, (74, 4) = -.787640939739465, (74, 5) = -1.749919977426206, (74, 6) = -0.23556744339370826e-4, (74, 7) = 2.558820545281426, (74, 8) = 3.420111305833327, (75, 1) = -.7035510401483496, (75, 2) = -1.179842722039242, (75, 3) = 0.99065219383785e-3, (75, 4) = -.8267265630201315, (75, 5) = -1.8494924421269134, (75, 6) = -0.22686172014267694e-4, (75, 7) = 2.5130898213148916, (75, 8) = 3.431240207282497, (76, 1) = -.6817402740822289, (76, 2) = -1.1663873814567318, (76, 3) = 0.9488918005393285e-3, (76, 4) = -.8655913084264577, (76, 5) = -1.9489909742964273, (76, 6) = -0.2189015961266543e-4, (76, 7) = 2.4702102698293733, (76, 8) = 3.4417668962975068, (77, 1) = -.662042824755988, (77, 2) = -1.1533058119982393, (77, 3) = 0.9087305894525226e-3, (77, 4) = -.9038985358204537, (77, 5) = -2.047518204770012, (77, 6) = -0.2116538992227282e-4, (77, 7) = 2.4302486640707324, (77, 8) = 3.451654929177949, (78, 1) = -.6442962923882716, (78, 2) = -1.1407329489233398, (78, 3) = 0.8703566798461641e-3, (78, 4) = -.9413527790153011, (78, 5) = -2.1442711097721276, (78, 6) = -0.20507677638201647e-4, (78, 7) = 2.393197428794109, (78, 8) = 3.4608879361258595, (79, 1) = -.6283267857233099, (79, 2) = -1.1287578166259165, (79, 3) = 0.8338831799104504e-3, (79, 4) = -.9777218753392471, (79, 5) = -2.238602357527621, (79, 6) = -0.1991206199787067e-4, (79, 7) = 2.3589754694866705, (79, 8) = 3.469470000824635, (80, 1) = -.6139612494410351, (80, 2) = -1.1174325846662971, (80, 3) = 0.7993640286801e-3, (80, 4) = -1.0128306220826722, (80, 5) = -2.330008194359004, (80, 6) = -0.19373294281696026e-4, (80, 7) = 2.327454035842628, (80, 8) = 3.4774195065430313, (81, 1) = -.6010282591377876, (81, 2) = -1.1067755959493013, (81, 3) = 0.7667909844755384e-3, (81, 4) = -1.0465710569835398, (81, 5) = -2.418158818559618, (81, 6) = -0.18885909167426185e-4, (81, 7) = 2.29846144731468, (81, 8) = 3.4847680010509343, (82, 1) = -.589355792884042, (82, 2) = -1.0967723466067563, (82, 3) = 0.7360851105774026e-3, (82, 4) = -1.078917726722845, (82, 5) = -2.5029417643450116, (82, 6) = -0.18444181695843733e-4, (82, 7) = 2.2717817056952025, (82, 8) = 3.4915605087251746, (83, 1) = -.578789960776199, (83, 2) = -1.0873952052385503, (83, 3) = 0.707147323735562e-3, (83, 4) = -1.1098789138425655, (83, 5) = -2.5843367515610653, (83, 6) = -0.1804287736821495e-4, (83, 7) = 2.247202106879539, (83, 8) = 3.497843251271395, (84, 1) = -.5691849764705197, (84, 2) = -1.0785995723637973, (84, 3) = 0.6798389849464869e-3, (84, 4) = -1.1395185764033104, (84, 5) = -2.662474473442519, (84, 6) = -0.17676914320012614e-4, (84, 7) = 2.22449660799971, (84, 8) = 3.503667596468209, (85, 1) = -.5604137750100611, (85, 2) = -1.0703376315750919, (85, 3) = 0.6540186795476277e-3, (85, 4) = -1.167917417113593, (85, 5) = -2.737534971296812, (85, 6) = -0.17341801410285002e-4, (85, 7) = 2.2034562751535516, (85, 8) = 3.5090819961866404, (86, 1) = -.5523629123437115, (86, 2) = -1.0625578917564078, (86, 3) = 0.6295370266698841e-3, (86, 4) = -1.1951775722076161, (86, 5) = -2.809759974550089, (86, 6) = -0.17033473908817785e-4, (86, 7) = 2.1838828343603964, (86, 8) = 3.514133353902306, (87, 1) = -.5449342038024376, (87, 2) = -1.0552101879796942, (87, 3) = 0.6062497820443647e-3, (87, 4) = -1.2214070371330248, (87, 5) = -2.879411533105483, (87, 6) = -0.1674837933429023e-4, (87, 7) = 2.1655972106550445, (87, 8) = 3.518864587492251, (88, 1) = -.5380447962892394, (88, 2) = -1.0482488451141774, (88, 3) = 0.5840264471994243e-3, (88, 4) = -1.2467083387969398, (88, 5) = -2.946741429914113, (88, 6) = -0.16483499058796392e-4, (88, 7) = 2.148443829577664, (88, 8) = 3.5233133014669202, (89, 1) = -.5316213245564512, (89, 2) = -1.0416292687625714, (89, 3) = 0.5627386294721454e-3, (89, 4) = -1.2711902020382264, (89, 5) = -3.0120216753394495, (89, 6) = -0.16236137942538134e-4, (89, 7) = 2.132279396600209, (89, 8) = 3.5275145228463005, (90, 1) = -.5256014783504259, (90, 2) = -1.0353113662555913, (90, 3) = 0.542270488534416e-3, (90, 4) = -1.2949544316717623, (90, 5) = -3.0755091729167408, (90, 6) = -0.16003994917487394e-4, (90, 7) = 2.116979251640104, (90, 8) = 3.5314989232821614, (91, 1) = -.5199338307732643, (91, 2) = -1.029261030678874, (91, 3) = 0.5225235695662516e-3, (91, 4) = -1.318088870384377, (91, 5) = -3.1374263305453485, (91, 6) = -0.1578516475208557e-4, (91, 7) = 2.102439152149924, (91, 8) = 3.5352922388429575, (92, 1) = -.514572832976705, (92, 2) = -1.0234461065617606, (92, 3) = 0.5034038116275458e-3, (92, 4) = -1.3406813901482497, (92, 5) = -3.1979979965921963, (92, 6) = -0.15577951043735027e-4, (92, 7) = 2.0885641772902126, (92, 8) = 3.538918074121483, (93, 1) = -.5094797693979244, (93, 2) = -1.0178383051073647, (93, 3) = 0.484827863408094e-3, (93, 4) = -1.3628117015147625, (93, 5) = -3.257429226140819, (93, 6) = -0.15380907449280186e-4, (93, 7) = 2.0752723733416136, (93, 8) = 3.5423968885776076, (94, 1) = -.5046215944264067, (94, 2) = -1.012412724640734, (94, 3) = 0.4667217350598794e-3, (94, 4) = -1.384552127841542, (94, 5) = -3.3159070059779054, (94, 6) = -0.15192796186471485e-4, (94, 7) = 2.062492785421469, (94, 8) = 3.5457464568387462, (95, 1) = -.4999700540977404, (95, 2) = -1.007147498289823, (95, 3) = 0.44901986346286137e-3, (95, 4) = -1.4059680433874733, (95, 5) = -3.373601137731775, (95, 6) = -0.15012556657430711e-4, (95, 7) = 2.0501639842481003, (95, 8) = 3.548982212146961, (96, 1) = -.49550086696394446, (96, 2) = -1.0020233649172254, (96, 3) = 0.431663902887128e-3, (96, 4) = -1.427118768515364, (96, 5) = -3.430666401205716, (96, 6) = -0.14839275699558921e-4, (96, 7) = 2.0382325581667997, (96, 8) = 3.5521176085940764, (97, 1) = -.4911929653388979, (97, 2) = -.9970231901474031, (97, 3) = 0.4146013082689632e-3, (97, 4) = -1.4480588388760878, (97, 5) = -3.487245778084282, (97, 6) = -0.14672159672421084e-4, (97, 7) = 2.026651607770967, (97, 8) = 3.5551644905833863, (98, 1) = -.48702809711143724, (98, 2) = -.9921318131287031, (98, 3) = 0.39778499029809986e-3, (98, 4) = -1.4688380600377302, (98, 5) = -3.5434704377904884, (98, 6) = -0.14510520159438795e-4, (98, 7) = 2.0153800864193614, (98, 8) = 3.558133245837101, (99, 1) = -.4829904126063248, (99, 2) = -.9873358156381429, (99, 3) = 0.38117269258238233e-3, (99, 4) = -1.4895019584068256, (99, 5) = -3.59946081549782, (99, 6) = -0.14353758827911441e-4, (99, 7) = 2.004382020182567, (99, 8) = 3.561032994168788, (100, 1) = -.47906618275015056, (100, 2) = -.9826233958522987, (100, 3) = 0.3647267120851952e-3, (100, 4) = -1.510091857284914, (100, 5) = -3.655326695710131, (100, 6) = -0.1420135718239464e-4, (100, 7) = 1.9936260171597493, (100, 8) = 3.563871703330231, (101, 1) = -.4752434024883323, (101, 2) = -.9779840641085054, (101, 3) = 0.348412981753825e-3, (101, 4) = -1.5306457928742918, (101, 5) = -3.711169591694131, (101, 6) = -0.1405286170595699e-4, (101, 7) = 1.9830844087599107, (101, 8) = 3.5666564046191414, (102, 1) = -.4715115932211641, (102, 2) = -.9734085414772227, (102, 3) = 0.33220083464903836e-3, (102, 4) = -1.551198623046329, (102, 5) = -3.767082955600177, (102, 6) = -0.13907876608183682e-4, (102, 7) = 1.9727328884458057, (102, 8) = 3.5693932795069077, (103, 1) = -.4678618571616898, (103, 2) = -.9688889477930727, (103, 3) = 0.31606379642765034e-3, (103, 4) = -1.571780843735148, (103, 5) = -3.823148874660779, (103, 6) = -0.13766066271783273e-4, (103, 7) = 1.962550823295072, (103, 8) = 3.5720875697130947, (104, 1) = -.46428588353027334, (104, 2) = -.9644176691429536, (104, 3) = 0.29997564626479495e-3, (104, 4) = -1.5924234681338794, (104, 5) = -3.8794512947105138, (104, 6) = -0.13627116900195335e-4, (104, 7) = 1.9525186114381992, (104, 8) = 3.57474427039465, (105, 1) = -.46077654064513585, (105, 2) = -.9599881597588358, (105, 3) = 0.2839133358400482e-3, (105, 4) = -1.6131542154629932, (105, 5) = -3.936065601255377, (105, 6) = -0.13490759729401707e-4, (105, 7) = 1.9426194250819797, (105, 8) = 3.5773676645257675, (106, 1) = -.4573279439961945, (106, 2) = -.9555951113966485, (106, 3) = 0.2678577269048484e-3, (106, 4) = -1.6339964126143123, (106, 5) = -3.9930555470455578, (106, 6) = -0.13356773838133413e-4, (106, 7) = 1.9328395125462459, (106, 8) = 3.5799612380109296, (107, 1) = -.45393473285993446, (107, 2) = -.9512336014514506, (107, 3) = 0.25179058812482716e-3, (107, 4) = -1.6549727661959404, (107, 5) = -4.050483502574837, (107, 6) = -0.13224958166954622e-4, (107, 7) = 1.92316623844449, (107, 8) = 3.5825281954646466, (108, 1) = -.450592293422326, (108, 2) = -.9468994211673394, (108, 3) = 0.23569584777525442e-3, (108, 4) = -1.6761036687757542, (108, 5) = -4.108405793844188, (108, 6) = -0.13095140287390492e-4, (108, 7) = 1.9135887745796223, (108, 8) = 3.585071274347221, (109, 1) = -.4472967628383211, (109, 2) = -.9425891293410318, (109, 3) = 0.21955987668487428e-3, (109, 4) = -1.6974067361576384, (109, 5) = -4.166871387878052, (109, 6) = -0.12967176631939755e-4, (109, 7) = 1.904098175214336, (109, 8) = 3.5875927223206645, (110, 1) = -.4440441254128591, (110, 2) = -.9382989018933567, (110, 3) = 0.20336722277439212e-3, (110, 4) = -1.7189023892775674, (110, 5) = -4.225937189816941, (110, 6) = -0.12840917462390543e-4, (110, 7) = 1.8946848160457122, (110, 8) = 3.590094975808664, (111, 1) = -.4408315041590287, (111, 2) = -.9340262523825162, (111, 3) = 0.18710710462446062e-3, (111, 4) = -1.740605223800892, (111, 5) = -4.285644328877767, (111, 6) = -0.12716257066217954e-4, (111, 7) = 1.8853421547647906, (111, 8) = 3.5925796591750196, (112, 1) = -.43765636375372463, (112, 2) = -.9297690244670624, (112, 3) = 0.17076972031517185e-3, (112, 4) = -1.7625288032168507, (112, 5) = -4.346031269482991, (112, 6) = -0.12593102830621538e-4, (112, 7) = 1.8760644812760283, (112, 8) = 3.595048180719712, (113, 1) = -.4345166508713483, (113, 2) = -.925525603146276, (113, 3) = 0.15434710629506484e-3, (113, 4) = -1.7846844583652024, (113, 5) = -4.407130479918492, (113, 6) = -0.1247138070442696e-4, (113, 7) = 1.8668473579005807, (113, 8) = 3.5975016144055694, (114, 1) = -.431410436871155, (114, 2) = -.9212944537734362, (114, 3) = 0.13783140621940394e-3, (114, 4) = -1.80708357280677, (114, 5) = -4.468974707871083, (114, 6) = -0.1235102135339778e-4, (114, 7) = 1.8576865989570959, (114, 8) = 3.5999409704646954, (115, 1) = 17.011218861782787, (115, 2) = -.7544591097135369, (115, 3) = -0.2148829833831214e-2, (115, 4) = -1.848294406662808, (115, 5) = -4.559926767391074, (115, 6) = -0.8844405321326364e-4, (115, 7) = 1.6661860508629613, (115, 8) = -13.820173135070192, (116, 1) = 41.69970644844304, (116, 2) = -.3326368013280896, (116, 3) = -0.4651128080304236e-2, (116, 4) = -1.8918126661090864, (116, 5) = -4.654829719782375, (116, 6) = -0.17076041104371247e-3, (116, 7) = 1.4007087604463464, (116, 8) = -38.67731091539104, (117, 1) = 66.57716839052488, (117, 2) = .2334322015708532, (117, 3) = -0.6277268053837211e-2, (117, 4) = -1.9286957225574415, (117, 5) = -4.7400627082745554, (117, 6) = -0.2229194482977896e-3, (117, 7) = 1.1360144483474275, (117, 8) = -63.87927325294748, (118, 1) = 91.77267928452277, (118, 2) = .8539062907266701, (118, 3) = -0.6989608363642923e-2, (118, 4) = -1.9585509455944148, (118, 5) = -4.815037747215345, (118, 6) = -0.24408053248333415e-3, (118, 7) = .8702284444216852, (118, 8) = -89.46356211335792, (119, 1) = 117.41651593259131, (119, 2) = 1.435824876643221, (119, 3) = -0.6751719885759808e-2, (119, 4) = -1.9809863306844795, (119, 5) = -4.879143443849439, (119, 6) = -0.23334326288877667e-3, (119, 7) = .6005553160406651, (119, 8) = -115.46485893129096, (120, 1) = 143.64542706953625, (120, 2) = 1.8811032619767718, (120, 3) = -0.5528825818990553e-2, (120, 4) = -1.9956191650223112, (120, 5) = -4.931761492826114, (120, 6) = -0.18975539773535122e-3, (120, 7) = .3237695974375352, (120, 8) = -141.9187872930707, (121, 1) = 170.5999615965828, (121, 2) = 2.084176962602908, (121, 3) = -0.32880943019728123e-2, (121, 4) = -2.0020759878910397, (121, 5) = -4.972260601929802, (121, 6) = -0.11231407168276927e-3, (121, 7) = 0.36851941267456334e-1, (121, 8) = -168.85751911652036, (122, 1) = 198.4198885128173, (122, 2) = 1.929619987453961, (122, 3) = .0, (122, 4) = -2.0, (122, 5) = -5.0, (122, 6) = .0, (122, 7) = -.2622584425246326, (122, 8) = -196.30355036125616}, datatype = float[8], order = C_order); errproc := proc (x_bvp) local outpoint, X, Y, yout, L, V, i; option `Copyright (c) 2000 by Waterloo Maple Inc. All rights reserved.`; Digits := 15; outpoint := evalf(x_bvp); X := Vector(122, {(1) = .0, (2) = 0.9741435106503429e-2, (3) = 0.19707189158802676e-1, (4) = 0.2990782982757365e-1, (5) = 0.4035468839555765e-1, (6) = 0.51059934946617196e-1, (7) = 0.62036663005486145e-1, (8) = 0.732989850822334e-1, (9) = 0.8486214083876946e-1, (10) = 0.9674261986134969e-1, (11) = .10895833907658463, (12) = .12152886800268148, (13) = .13447543115104388, (14) = .1478212039749837, (15) = .16159156902610294, (16) = .17581440459606146, (17) = .1905204219231735, (18) = .2057435609748033, (19) = .22152145757186412, (20) = .23789602193504325, (21) = .25491439085962175, (22) = .27262932405428647, (23) = .2911002393000661, (24) = .3103944840382796, (25) = .3305888084021936, (26) = .3517711953548975, (27) = .3740431562700764, (28) = .39752264073240134, (29) = .4223477673432611, (30) = .4486825709916404, (31) = .4766224874284011, (32) = .5059299989198147, (33) = .5360639779566353, (34) = .5670339223010088, (35) = .5988564659101844, (36) = .6315490455116444, (37) = .665132714021168, (38) = .6996089370778189, (39) = .7349722211903196, (40) = .7712212602958708, (41) = .8083507944918464, (42) = .8463418431675694, (43) = .885168047571194, (44) = .9247996715263419, (45) = .9652041825220232, (46) = 1.006355960451245, (47) = 1.048221571279199, (48) = 1.0907635687216195, (49) = 1.1339516742031843, (50) = 1.1777571492568144, (51) = 1.2221446362150017, (52) = 1.2670806629233007, (53) = 1.3125263805338878, (54) = 1.3584520199179504, (55) = 1.404830083985476, (56) = 1.451622058971123, (57) = 1.498802953852514, (58) = 1.5463509015029775, (59) = 1.5942373703266048, (60) = 1.6424357424625993, (61) = 1.690921930260093, (62) = 1.7396390535434036, (63) = 1.7884019443410892, (64) = 1.8365148980229262, (65) = 1.8838664336932738, (66) = 1.9307382864102527, (67) = 1.9772200785721323, (68) = 2.0231982707759397, (69) = 2.068533909383313, (70) = 2.113050269923841, (71) = 2.156567546064062, (72) = 2.198888212916297, (73) = 2.23980728091143, (74) = 2.279128120258343, (75) = 2.316672074587299, (76) = 2.352283612876669, (77) = 2.3858528111599733, (78) = 2.4173263519948054, (79) = 2.4467118515199453, (80) = 2.474059951351264, (81) = 2.4994631784630887, (82) = 2.5230595210833147, (83) = 2.5449916887106143, (84) = 2.565421886715661, (85) = 2.5845042984516353, (86) = 2.6023900332269765, (87) = 2.61921851178031, (88) = 2.635112503713722, (89) = 2.6501876068068095, (90) = 2.664545654245356, (91) = 2.6782722885189303, (92) = 2.6914468043182116, (93) = 2.7041382854495692, (94) = 2.7164070629279187, (95) = 2.7283057857332493, (96) = 2.7398805934676407, (97) = 2.7511723491714175, (98) = 2.762217098566082, (99) = 2.773046677277982, (100) = 2.7836890609808993, (101) = 2.794169101930963, (102) = 2.8045087959121373, (103) = 2.8147268856055696, (104) = 2.824841442748569, (105) = 2.8348680735443472, (106) = 2.8448195459526886, (107) = 2.8547077266056764, (108) = 2.8645428448478993, (109) = 2.874333374077579, (110) = 2.8840886491995987, (111) = 2.893814960611468, (112) = 2.903517841082119, (113) = 2.913201583880822, (114) = 2.922870293058419, (115) = 2.9325283060532534, (116) = 2.9421787975362634, (117) = 2.951823224967565, (118) = 2.961463174210137, (119) = 2.971099265323444, (120) = 2.9807331838318056, (121) = 2.9903666649653213, (122) = 3.0}, datatype = float[8], order = C_order); Y := Matrix(122, 8, {(1, 1) = .0, (1, 2) = .0, (1, 3) = 0.13663290934061047e-7, (1, 4) = 0.2840613476962464e-8, (1, 5) = 0.7832779670886352e-9, (1, 6) = 0.8023128222593346e-8, (1, 7) = .0, (1, 8) = .0, (2, 1) = -0.11238635970440408e-13, (2, 2) = -0.20681260572059392e-15, (2, 3) = 0.1366276360005577e-7, (2, 4) = 0.2876599640819444e-8, (2, 5) = 0.842654323402778e-9, (2, 6) = 0.7945121074506108e-8, (2, 7) = 0.5529498049196326e-13, (2, 8) = 0.5559666682296526e-12, (3, 1) = 0.45158215231027306e-13, (3, 2) = -0.6222088687302642e-16, (3, 3) = 0.13662232957694633e-7, (3, 4) = 0.29138857508801694e-8, (3, 5) = 0.9034260117585899e-9, (3, 6) = 0.7866102531140166e-8, (3, 7) = -0.5447409630936962e-13, (3, 8) = -0.6179797285408453e-12, (4, 1) = 0.2274580086724899e-12, (4, 2) = 0.56185893726191795e-15, (4, 3) = 0.13661698825987777e-7, (4, 4) = 0.29525515645363185e-8, (4, 5) = 0.965676636065482e-9, (4, 6) = 0.7786035513119211e-8, (4, 7) = 0.6056977974615334e-13, (4, 8) = -0.5897576335942579e-12, (5, 1) = 0.6020998347831761e-12, (5, 2) = 0.4572696400554565e-14, (5, 3) = 0.13661161031826777e-7, (5, 4) = 0.2992679978325052e-8, (5, 5) = 0.10295117854276237e-8, (5, 6) = 0.7704880667456252e-8, (5, 7) = -0.4728090754982436e-13, (5, 8) = -0.10304937243257108e-11, (6, 1) = 0.12455351784784966e-11, (6, 2) = 0.15044166742382447e-13, (6, 3) = 0.1366061936321946e-7, (6, 4) = 0.3034367656623954e-8, (6, 5) = 0.10950264518291044e-8, (6, 6) = 0.7622596171670288e-8, (6, 7) = 0.283686756357706e-13, (6, 8) = -0.14110254383640684e-11, (7, 1) = 0.22151336854212052e-11, (7, 2) = 0.3718532185620284e-13, (7, 3) = 0.13660073611080185e-7, (7, 4) = 0.30777114655985003e-8, (7, 5) = 0.11623503380880362e-8, (7, 6) = 0.7539137513287336e-8, (7, 7) = 0.6990910845812832e-13, (7, 8) = -0.2628005525584302e-11, (8, 1) = 0.35927201860656965e-11, (8, 2) = 0.7533636080651885e-13, (8, 3) = 0.13659523532517088e-7, (8, 4) = 0.3122826997679884e-8, (8, 5) = 0.12316051552765646e-8, (8, 6) = 0.7454457246428872e-8, (8, 7) = -0.3467210759661602e-13, (8, 8) = -0.36187042342607146e-11, (9, 1) = 0.5479857105591861e-11, (9, 2) = 0.13716672354796869e-12, (9, 3) = 0.13658968881960653e-7, (9, 4) = 0.31698361912569006e-8, (9, 5) = 0.13029345021572682e-8, (9, 6) = 0.7368504717249204e-8, (9, 7) = -0.20893583043358448e-13, (9, 8) = -0.50186435264889515e-11, (10, 1) = 0.7944945309651744e-11, (10, 2) = 0.23105811815255007e-12, (10, 3) = 0.1365840936935341e-7, (10, 4) = 0.3218867796244697e-8, (10, 5) = 0.13764937832293395e-8, (10, 6) = 0.7281225756995973e-8, (10, 7) = -0.52591164888567735e-13, (10, 8) = -0.8199827028252814e-11, (11, 1) = 0.1105979751237137e-10, (11, 2) = 0.3688276726753796e-12, (11, 3) = 0.13657844712817272e-7, (11, 4) = 0.32700746919507736e-8, (11, 5) = 0.14524572561812692e-8, (11, 6) = 0.7192562069334237e-8, (11, 7) = 0.6965543752011837e-13, (11, 8) = -0.12283976980796131e-10, (12, 1) = 0.14959923481693695e-10, (12, 2) = 0.5633015325975054e-12, (12, 3) = 0.1365727456395426e-7, (12, 4) = 0.33236168182246426e-8, (12, 5) = 0.15310126416423885e-8, (12, 6) = 0.7102450390172754e-8, (12, 7) = -0.8845579376572911e-13, (12, 8) = -0.15529806776377507e-10, (13, 1) = 0.1970872095565628e-10, (13, 2) = 0.8294234696853228e-12, (13, 3) = 0.13656698571735185e-7, (13, 4) = 0.33796775217796503e-8, (13, 5) = 0.1612375477423093e-8, (13, 6) = 0.70108233714995506e-8, (13, 7) = -0.10362996818604134e-13, (13, 8) = -0.20549847753347836e-10, (14, 1) = 0.2539788219904298e-10, (14, 2) = 0.11870145539196632e-11, (14, 3) = 0.13656116337149589e-7, (14, 4) = 0.34384523294426313e-8, (14, 5) = 0.16967916958197657e-8, (14, 6) = 0.6917608460389438e-8, (14, 7) = 0.24705369018469077e-13, (14, 8) = -0.27052399354896318e-10, (15, 1) = 0.3215972512384491e-10, (15, 2) = 0.1654838196241076e-11, (15, 3) = 0.13655527431233317e-7, (15, 4) = 0.35001666403720777e-8, (15, 5) = 0.17845073587547316e-8, (15, 6) = 0.6822727253353692e-8, (15, 7) = 0.10102230509455175e-12, (15, 8) = -0.33734857565586684e-10, (16, 1) = 0.4010141787279162e-10, (16, 2) = 0.22638675783457525e-11, (16, 3) = 0.13654931377959242e-7, (16, 4) = 0.3565072894183711e-8, (16, 5) = 0.18758379804485264e-8, (16, 6) = 0.6726094825451087e-8, (16, 7) = -0.15367250387436867e-14, (16, 8) = -0.4211664697518298e-10, (17, 1) = 0.493314861312902e-10, (17, 2) = 0.30378455433345046e-11, (17, 3) = 0.13654327651720458e-7, (17, 4) = 0.36334444975021726e-8, (17, 5) = 0.1971115047979055e-8, (17, 6) = 0.6627618955168632e-8, (17, 7) = 0.7690842388038566e-13, (17, 8) = -0.52317294321791626e-10, (18, 1) = 0.5998533447447231e-10, (18, 2) = 0.4013192686192327e-11, (18, 3) = 0.13653715671627617e-7, (18, 4) = 0.3705600910366286e-8, (18, 5) = 0.20707186154467518e-8, (18, 6) = 0.6527199232125872e-8, (18, 7) = 0.15942669363536818e-12, (18, 8) = -0.6505708704369978e-10, (19, 1) = 0.7217722169662201e-10, (19, 2) = 0.5228068695130795e-11, (19, 3) = 0.13653094785734708e-7, (19, 4) = 0.3781895174347084e-8, (19, 5) = 0.2175077281042318e-8, (19, 6) = 0.6424726020586333e-8, (19, 7) = 0.2621364598559845e-12, (19, 8) = -0.7774620332889269e-10, (20, 1) = 0.8605063462713938e-10, (20, 2) = 0.67364692723485184e-11, (20, 3) = 0.13652464273783446e-7, (20, 4) = 0.3862733055958956e-8, (20, 5) = 0.22846948794264993e-8, (20, 6) = 0.6320079095089122e-8, (20, 7) = 0.3107977495385916e-12, (20, 8) = -0.93943019880518e-10, (21, 1) = 0.10173773820501315e-9, (21, 2) = 0.8589677748538187e-11, (21, 3) = 0.13651823313031122e-7, (21, 4) = 0.3948578140881567e-8, (21, 5) = 0.2400132871167261e-8, (21, 6) = 0.6213124426718848e-8, (21, 7) = 0.5904952061087832e-12, (21, 8) = -0.11119877537359676e-9, (22, 1) = 0.1193930699783633e-9, (22, 2) = 0.10845737091205832e-10, (22, 3) = 0.1365117098271215e-7, (22, 4) = 0.403996178913151e-8, (22, 5) = 0.25220484580072216e-8, (22, 6) = 0.6103715126030343e-8, (22, 7) = 0.675959431297676e-12, (22, 8) = -0.1322712116315134e-9, (23, 1) = 0.13915655123710002e-9, (23, 2) = 0.1358164077184352e-10, (23, 3) = 0.13650506254286056e-7, (23, 4) = 0.41374933052667245e-8, (23, 5) = 0.26511965972828865e-8, (23, 6) = 0.5991688978665936e-8, (23, 7) = 0.9559113964927571e-12, (23, 8) = -0.15325932804480563e-9, (24, 1) = 0.161193913636883e-9, (24, 2) = 0.1687948418250352e-10, (24, 3) = 0.13649827954619419e-7, (24, 4) = 0.4241881870050213e-8, (24, 5) = 0.27884663731774027e-8, (24, 6) = 0.5876865496323793e-8, (24, 7) = 0.126001699728362e-11, (24, 8) = -0.18017793513648325e-9, (25, 1) = 0.18565910833734706e-9, (25, 2) = 0.2084951633220518e-10, (25, 3) = 0.13649134729447283e-7, (25, 4) = 0.4353955474134664e-8, (25, 5) = 0.29348975546787274e-8, (25, 6) = 0.5759042940109777e-8, (25, 7) = 0.14837683890614548e-11, (25, 8) = -0.20976472031979619e-9, (26, 1) = 0.2127199788563376e-9, (26, 2) = 0.255885210801166e-10, (26, 3) = 0.13648425048930662e-7, (26, 4) = 0.4474692621674139e-8, (26, 5) = 0.3091722673046245e-8, (26, 6) = 0.5637994703195635e-8, (26, 7) = 0.2017599161044093e-11, (26, 8) = -0.2414272699715309e-9, (27, 1) = 0.2425245196971148e-9, (27, 2) = 0.3124846575080024e-10, (27, 3) = 0.13647697129588252e-7, (27, 4) = 0.4605243250627301e-8, (27, 5) = 0.32604047276049538e-8, (27, 6) = 0.5513464876002003e-8, (27, 7) = 0.26895508645876876e-11, (27, 8) = -0.27797610877948833e-9, (28, 1) = 0.2752480708923535e-9, (28, 2) = 0.3797946007360824e-10, (28, 3) = 0.13646948907712763e-7, (28, 4) = 0.4746991799939174e-8, (28, 5) = 0.34427175094983523e-8, (28, 6) = 0.5385162760258525e-8, (28, 7) = 0.35335256597058515e-11, (28, 8) = -0.3187042749104985e-9, (29, 1) = 0.3110245141657333e-9, (29, 2) = 0.45966459751981425e-10, (29, 3) = 0.1364617796341987e-7, (29, 4) = 0.4901600002021004e-8, (29, 5) = 0.36407967915589472e-8, (29, 6) = 0.5252756020163271e-8, (29, 7) = 0.4586690823839645e-11, (29, 8) = -0.3631503465263382e-9, (30, 1) = 0.34998678402071504e-9, (30, 2) = 0.5542655235876155e-10, (30, 3) = 0.13645381411588585e-7, (30, 4) = 0.5071109836654818e-8, (30, 5) = 0.3857282744481353e-8, (30, 6) = 0.5115857403050919e-8, (30, 7) = 0.5897912100549761e-11, (30, 8) = -0.4132598383135113e-9, (31, 1) = 0.39210683972348395e-9, (31, 2) = 0.6658635815301536e-10, (31, 3) = 0.13644558736604564e-7, (31, 4) = 0.5257346963598829e-8, (31, 5) = 0.4094592803433056e-8, (31, 6) = 0.4974517338202902e-8, (31, 7) = 0.7650887520670183e-11, (31, 8) = -0.4695721826657946e-9, (32, 1) = 0.4367116735740726e-9, (32, 2) = 0.7950622636418878e-10, (32, 3) = 0.13643718934128297e-7, (32, 4) = 0.5460039177551084e-8, (32, 5) = 0.4352513245908356e-8, (32, 6) = 0.4830456993761937e-8, (32, 7) = 0.9861196759749044e-11, (32, 8) = -0.5291283964993496e-9, (33, 1) = 0.4825471222467274e-9, (33, 2) = 0.9406277087367918e-10, (33, 3) = 0.13642878439072114e-7, (33, 4) = 0.56765870173047806e-8, (33, 5) = 0.4627937584700027e-8, (33, 6) = 0.4686685295817948e-8, (33, 7) = 0.124663823857249e-10, (33, 8) = -0.5931721176165988e-9, (34, 1) = 0.5291409445330616e-9, (34, 2) = 0.11031331980428313e-9, (34, 3) = 0.13642037228729104e-7, (34, 4) = 0.5908080937450966e-8, (34, 5) = 0.4922515426169168e-8, (34, 6) = 0.45433851066553745e-8, (34, 7) = 0.15655328805420022e-10, (34, 8) = -0.6601168437709018e-9, (35, 1) = 0.5759764930151261e-9, (35, 2) = 0.12830718052284315e-9, (35, 3) = 0.13641195044240374e-7, (35, 4) = 0.6155770583241383e-8, (35, 5) = 0.5238147699208671e-8, (35, 6) = 0.4400705165001387e-8, (35, 7) = 0.19562725059440673e-10, (35, 8) = -0.7295119736754886e-9, (36, 1) = 0.6224783640465343e-9, (36, 2) = 0.148049748899329e-9, (36, 3) = 0.13640351618242265e-7, (36, 4) = 0.6421030683166829e-8, (36, 5) = 0.5576916481411804e-8, (36, 6) = 0.4258791642038733e-8, (36, 7) = 0.2411979378266511e-10, (36, 8) = -0.8013141691057489e-9, (37, 1) = 0.6680259107998686e-9, (37, 2) = 0.16953604459942696e-9, (37, 3) = 0.13639506581651332e-7, (37, 4) = 0.67054126108355105e-8, (37, 5) = 0.59412018461215775e-8, (37, 6) = 0.4117776498566266e-8, (37, 7) = 0.29601226511675416e-10, (37, 8) = -0.8751304758598098e-9, (38, 1) = 0.7119422043138452e-9, (38, 2) = 0.19271429250434951e-9, (38, 3) = 0.13638660110157705e-7, (38, 4) = 0.70104368264586655e-8, (38, 5) = 0.6333394435799495e-8, (38, 6) = 0.3977871873365029e-8, (38, 7) = 0.3596549265175757e-10, (38, 8) = -0.9504069255836248e-9, (39, 1) = 0.7534880661403736e-9, (39, 2) = 0.21749212481186242e-9, (39, 3) = 0.13637812506457674e-7, (39, 4) = 0.73377104625155905e-8, (39, 5) = 0.67560540002406385e-8, (39, 6) = 0.3839307222233205e-8, (39, 7) = 0.4315296317295524e-10, (39, 8) = -0.10257914393841426e-8, (40, 1) = 0.7919326579597411e-9, (40, 2) = 0.24372044239345073e-9, (40, 3) = 0.13636964008202576e-7, (40, 4) = 0.7689025346149675e-8, (40, 5) = 0.7212046200646013e-8, (40, 6) = 0.37022827919558404e-8, (40, 7) = 0.5175366847308646e-10, (40, 8) = -0.1100781665452158e-8, (41, 1) = 0.8265120428590482e-9, (41, 2) = 0.2712519299087578e-9, (41, 3) = 0.13636114987423495e-7, (41, 4) = 0.8066291842717188e-8, (41, 5) = 0.7704461072958108e-8, (41, 6) = 0.35670013231182565e-8, (41, 7) = 0.6148157353484771e-10, (41, 8) = -0.11741374639788406e-8, (42, 1) = 0.8564709233769378e-9, (42, 2) = 0.2998205932678275e-9, (42, 3) = 0.13635266171397831e-7, (42, 4) = 0.8471457630204545e-8, (42, 5) = 0.8236491115770974e-8, (42, 6) = 0.34336987662515776e-8, (42, 7) = 0.7250756631036952e-10, (42, 8) = -0.12462701104353503e-8, (43, 1) = 0.8810519710701502e-9, (43, 2) = 0.3291552745649376e-9, (43, 3) = 0.1363441851540569e-7, (43, 4) = 0.8906535275652571e-8, (43, 5) = 0.881150390221066e-8, (43, 6) = 0.33026141951160743e-8, (43, 7) = 0.8509059653720058e-10, (43, 8) = -0.1313479988204121e-8, (44, 1) = 0.8995528993237107e-9, (44, 2) = 0.35892975114509724e-9, (44, 3) = 0.13633573113183733e-7, (44, 4) = 0.9373665127495466e-8, (44, 5) = 0.9433093482797862e-8, (44, 6) = 0.3173972641178364e-8, (44, 7) = 0.9885974236689092e-10, (44, 8) = -0.13780330295639911e-8, (45, 1) = 0.911297388657969e-9, (45, 2) = 0.3887606865707956e-9, (45, 3) = 0.13632731214068014e-7, (45, 4) = 0.9875103326643893e-8, (45, 5) = 0.10105095959670809e-7, (45, 6) = 0.30479818029103016e-8, (45, 7) = 0.1142771398646938e-9, (45, 8) = -0.14379403755868077e-8, (46, 1) = 0.9156970482867066e-9, (46, 2) = 0.41829358190845295e-9, (46, 3) = 0.13631894053032037e-7, (46, 4) = 0.1041336911578076e-7, (46, 5) = 0.10831729142889312e-7, (46, 6) = 0.29248027208519888e-8, (46, 7) = 0.13122530427282014e-9, (46, 8) = -0.1491498602522484e-8, (47, 1) = 0.9122132493574453e-9, (47, 2) = 0.4470537950137312e-9, (47, 3) = 0.13631063169297425e-7, (47, 4) = 0.1099105411245314e-7, (47, 5) = 0.1161743381863311e-7, (47, 6) = 0.2804596333478839e-8, (47, 7) = 0.14969108006213947e-9, (47, 8) = -0.15363713612941261e-8, (48, 1) = 0.9003983599909326e-9, (48, 2) = 0.4746059212023487e-9, (48, 3) = 0.13630240345146258e-7, (48, 4) = 0.11610878658893397e-7, (48, 5) = 0.12466861776639174e-7, (48, 6) = 0.2687509587963845e-8, (48, 7) = 0.1697561937323775e-9, (48, 8) = -0.1575251533972342e-8, (49, 1) = 0.8798797326144408e-9, (49, 2) = 0.5004817946564956e-9, (49, 3) = 0.13629427406858435e-7, (49, 4) = 0.12275847665630304e-7, (49, 5) = 0.13385145408545205e-7, (49, 6) = 0.2573645589312668e-8, (49, 7) = 0.19122465062814813e-9, (49, 8) = -0.16049675921865292e-8, (50, 1) = 0.850365009989209e-9, (50, 2) = 0.5241948164866338e-9, (50, 3) = 0.13628626363556357e-7, (50, 4) = 0.12989201969628642e-7, (50, 5) = 0.14377819693569832e-7, (50, 6) = 0.24630828951125382e-8, (50, 7) = 0.21408415341280654e-9, (50, 8) = -0.16251603310528655e-8, (51, 1) = 0.8116535431600781e-9, (51, 2) = 0.5452775190705163e-9, (51, 3) = 0.13627839566672688e-7, (51, 4) = 0.1375429143789184e-7, (51, 5) = 0.1545063708587378e-7, (51, 6) = 0.2355896844459461e-8, (51, 7) = 0.2383225079938667e-9, (51, 8) = -0.16343124954774668e-8, (52, 1) = 0.7636295586838084e-9, (52, 2) = 0.5632433888539389e-9, (52, 3) = 0.13627069561727441e-7, (52, 4) = 0.14574711842118519e-7, (52, 5) = 0.16609780993176717e-7, (52, 6) = 0.22521381742027384e-8, (52, 7) = 0.2637136421094906e-9, (52, 8) = -0.16321761993122757e-8, (53, 1) = 0.7062507094626524e-9, (53, 2) = 0.5776275134235732e-9, (53, 3) = 0.13626319227409415e-7, (53, 4) = 0.15454186202147017e-7, (53, 5) = 0.17861690945489336e-7, (53, 6) = 0.21518510820436573e-8, (53, 7) = 0.29028407504864883e-9, (53, 8) = -0.16189587352802707e-8, (54, 1) = 0.6395609828288718e-9, (54, 2) = 0.5879934390386754e-9, (54, 3) = 0.13625591527546593e-7, (54, 4) = 0.16396832330567827e-7, (54, 5) = 0.1921343952955725e-7, (54, 6) = 0.20550422911806494e-8, (54, 7) = 0.3175177274655451e-9, (54, 8) = -0.15921735949442564e-8, (55, 1) = 0.5636519049035958e-9, (55, 2) = 0.5939200338189232e-9, (55, 3) = 0.13624889664184675e-7, (55, 4) = 0.17407088874491737e-7, (55, 5) = 0.2067264793309017e-7, (55, 6) = 0.1961700244630562e-8, (55, 7) = 0.34551887868084316e-9, (55, 8) = -0.15528014422279912e-8, (56, 1) = 0.4787009351693225e-9, (56, 2) = 0.5950128096107439e-9, (56, 3) = 0.13624217259710914e-7, (56, 4) = 0.18489413877710267e-7, (56, 5) = 0.2224703009495397e-7, (56, 6) = 0.1871822266318597e-8, (56, 7) = 0.3739133835369414e-9, (56, 8) = -0.15002101386489747e-8, (57, 1) = 0.38492922618886507e-9, (57, 2) = 0.5909039225557932e-9, (57, 3) = 0.13623577999718242e-7, (57, 4) = 0.1964884188798869e-7, (57, 5) = 0.2394523845152672e-7, (57, 6) = 0.1785367076105051e-8, (57, 7) = 0.4026237701582189e-9, (57, 8) = -0.1432753154674881e-8, (58, 1) = 0.2825730141358609e-9, (58, 2) = 0.5812687832797649e-9, (58, 3) = 0.13622975826395272e-7, (58, 4) = 0.2089081867806162e-7, (58, 5) = 0.25776588224694366e-7, (58, 6) = 0.17022795988055656e-8, (58, 7) = 0.430972353833696e-9, (58, 8) = -0.13507815015674318e-8, (59, 1) = 0.17193104924991375e-9, (59, 2) = 0.565814775318554e-9, (59, 3) = 0.1362241505514843e-7, (59, 4) = 0.2222094858329732e-7, (59, 5) = 0.2775074893657316e-7, (59, 6) = 0.16225090689754229e-8, (59, 7) = 0.4590292294454922e-9, (59, 8) = -0.12554365458660128e-8, (60, 1) = 0.5333092899921627e-10, (60, 2) = 0.5442913859870276e-9, (60, 3) = 0.13621900259472728e-7, (60, 4) = 0.23645232495565317e-7, (60, 5) = 0.2987802072032895e-7, (60, 6) = 0.15459940239070262e-8, (60, 7) = 0.4864338708362562e-9, (60, 8) = -0.11446162922904984e-8, (61, 1) = -0.7288697081934761e-10, (61, 2) = 0.5164747057841229e-9, (61, 3) = 0.13621436277012346e-7, (61, 4) = 0.2517010564957243e-7, (61, 5) = 0.3216945559040551e-7, (61, 6) = 0.14726630842131175e-8, (61, 7) = 0.5125938191190721e-9, (61, 8) = -0.10177174217391962e-8, (62, 1) = -0.2062703866692985e-9, (62, 2) = 0.4822166682099886e-9, (62, 3) = 0.1362102850532486e-7, (62, 4) = 0.2680125383980365e-7, (62, 5) = 0.3463505560248911e-7, (62, 6) = 0.14024862907500255e-8, (62, 7) = 0.537579018954649e-9, (62, 8) = -0.8763565012326953e-9, (63, 1) = -0.34597901893081887e-9, (63, 2) = 0.4415293096016262e-9, (63, 3) = 0.13620683290841564e-7, (63, 4) = 0.2853976410371815e-7, (63, 5) = 0.3727783050455102e-7, (63, 6) = 0.13355924586797303e-8, (63, 7) = 0.560559581749256e-9, (63, 8) = -0.7200678306796231e-9, (64, 1) = -0.4895217530847365e-9, (64, 2) = 0.3950777492365674e-9, (64, 3) = 0.13620408912759817e-7, (64, 4) = 0.30365630077324986e-7, (64, 5) = 0.4006835784512907e-7, (64, 6) = 0.12727167445331678e-8, (64, 7) = 0.5810794931271896e-9, (64, 8) = -0.5499612825752592e-9, (65, 1) = -0.6359847221855768e-9, (65, 2) = 0.3432406490566445e-9, (65, 3) = 0.13620207710348933e-7, (65, 4) = 0.32276657419009145e-7, (65, 5) = 0.43003867046211034e-7, (65, 6) = 0.12137255555741203e-8, (65, 7) = 0.5988974587134133e-9, (65, 8) = -0.3690138981307799e-9, (66, 1) = -0.7857359017225751e-9, (66, 2) = 0.2859505302567853e-9, (66, 3) = 0.1362008048342512e-7, (66, 4) = 0.34286770305782356e-7, (66, 5) = 0.46106355436922914e-7, (66, 6) = 0.11580244613709986e-8, (66, 7) = 0.6141055326975615e-9, (66, 8) = -0.17687863696203786e-9, (67, 1) = -0.9386536803835842e-9, (67, 2) = 0.22329713797472972e-9, (67, 3) = 0.13620029836141672e-7, (67, 4) = 0.36403776805518136e-7, (67, 5) = 0.4938860221776817e-7, (67, 6) = 0.11053110714306194e-8, (67, 7) = 0.6260249482506498e-9, (67, 8) = 0.2809339887205694e-10, (68, 1) = -0.10939989164220136e-8, (68, 2) = 0.15563498857397e-9, (68, 3) = 0.13620058709709244e-7, (68, 4) = 0.3862644166860055e-7, (68, 5) = 0.5284936124946568e-7, (68, 6) = 0.10555291198120513e-8, (68, 7) = 0.6349573798882234e-9, (68, 8) = 0.24256093040907477e-9, (69, 1) = -0.12509308105938655e-8, (69, 2) = 0.8342817636959496e-10, (69, 3) = 0.13620169168999631e-7, (69, 4) = 0.4095092304785606e-7, (69, 5) = 0.5648316910140914e-7, (69, 6) = 0.10086378157568976e-8, (69, 7) = 0.6406162056475118e-9, (69, 8) = 0.4695808919490667e-9, (70, 1) = -0.14084709329530503e-8, (70, 2) = 0.7280346464396202e-11, (70, 3) = 0.13620361978334213e-7, (70, 4) = 0.4336952879386154e-7, (70, 5) = 0.602782860929386e-7, (70, 6) = 0.9646204196936918e-9, (70, 7) = 0.6425407024591349e-9, (70, 8) = 0.7025558824188306e-9, (71, 1) = -0.15656188944455298e-8, (71, 2) = -0.7213914230318734e-10, (71, 3) = 0.13620636345002078e-7, (71, 4) = 0.4587194655898888e-7, (71, 5) = 0.6421859608221195e-7, (71, 6) = 0.9234471313277936e-9, (71, 7) = 0.641079871903196e-9, (71, 8) = 0.943821691456211e-9, (72, 1) = -0.17212986664936047e-8, (72, 2) = -0.1540311185323536e-9, (72, 3) = 0.136209896002123e-7, (72, 4) = 0.48444078029923754e-7, (72, 5) = 0.6828169776679001e-7, (72, 6) = 0.8850910127257023e-9, (72, 7) = 0.6361571138701643e-9, (72, 8) = 0.11889697141891851e-8, (73, 1) = -0.18743952447309424e-8, (73, 2) = -0.23752023051470064e-9, (73, 3) = 0.13621417000536351e-7, (73, 4) = 0.51068202413550234e-7, (73, 5) = 0.7243915632336104e-7, (73, 6) = 0.8495194622104489e-9, (73, 7) = 0.628058765519808e-9, (73, 8) = 0.14371304785519257e-8, (74, 1) = -0.20238155049884107e-8, (74, 2) = -0.3216846763984625e-9, (74, 3) = 0.13621911760870575e-7, (74, 4) = 0.5372380432416277e-7, (74, 5) = 0.7665778219597059e-7, (74, 6) = 0.8166835966447373e-9, (74, 7) = 0.6168305961866468e-9, (74, 8) = 0.1686141066886748e-8, (75, 1) = -0.21685295171850983e-8, (75, 2) = -0.40559999075863017e-9, (75, 3) = 0.13622465235502798e-7, (75, 4) = 0.5638832946240173e-7, (75, 5) = 0.8090085147192828e-7, (75, 6) = 0.7865154005160086e-9, (75, 7) = 0.6028125126612214e-9, (75, 8) = 0.1932356566212446e-8, (76, 1) = -0.23076031121494265e-8, (76, 2) = -0.488367754942276e-9, (76, 3) = 0.13623067206346914e-7, (76, 4) = 0.5903788858890103e-7, (76, 5) = 0.851292585102532e-7, (76, 6) = 0.7589292521609631e-9, (76, 7) = 0.5866382507936287e-9, (76, 8) = 0.2174513331193806e-8, (77, 1) = -0.24402780174526014e-8, (77, 2) = -0.5691795416274992e-9, (77, 3) = 0.13623706642805095e-7, (77, 4) = 0.616495419827967e-7, (77, 5) = 0.8930523552112798e-7, (77, 6) = 0.7338105654134193e-9, (77, 7) = 0.5684950972598225e-9, (77, 8) = 0.24100468987976895e-8, (78, 1) = -0.25660434588350527e-8, (78, 2) = -0.6473768181093075e-9, (78, 3) = 0.13624372539613487e-7, (78, 4) = 0.6420314664018979e-7, (78, 5) = 0.9339537854295113e-7, (78, 6) = 0.7110146600012718e-9, (78, 7) = 0.5489454005828128e-9, (78, 8) = 0.2638026339220376e-8, (79, 1) = -0.268465362317246e-8, (79, 2) = -0.7224825285891991e-9, (79, 3) = 0.1362505474316453e-7, (79, 4) = 0.6668286550484515e-7, (79, 5) = 0.9737314895967868e-7, (79, 6) = 0.6903699493277994e-9, (79, 7) = 0.5283151260563883e-9, (79, 8) = 0.285647402729184e-8, (80, 1) = -0.27960626050484536e-8, (80, 2) = -0.794184447110468e-9, (80, 3) = 0.13625744224083073e-7, (80, 4) = 0.6907674291652884e-7, (80, 5) = 0.10121827419820674e-6, (80, 6) = 0.6716948157546984e-9, (80, 7) = 0.5072290825423898e-9, (80, 8) = 0.3065307560670624e-8, (81, 1) = -0.2900431429693554e-8, (81, 2) = -0.862331022710004e-9, (81, 3) = 0.13626433563322901e-7, (81, 4) = 0.7137740364566014e-7, (81, 5) = 0.10491792277720472e-6, (81, 6) = 0.6548000800579978e-9, (81, 7) = 0.4856696122890922e-9, (81, 8) = 0.32633128075012725e-8, (82, 1) = -0.2998131649638252e-8, (82, 2) = -0.9269478849162632e-9, (82, 3) = 0.13627117509080193e-7, (82, 4) = 0.7358309621945097e-7, (82, 5) = 0.10846841013018732e-6, (82, 6) = 0.639487511333121e-9, (82, 7) = 0.46410365315385186e-9, (82, 8) = 0.34504644802987357e-8, (83, 1) = -0.30895984586505714e-8, (83, 2) = -0.98813668306776e-9, (83, 3) = 0.1362779211050395e-7, (83, 4) = 0.7569437024087924e-7, (83, 5) = 0.11186989153302417e-6, (83, 6) = 0.625575824848033e-9, (83, 7) = 0.44272887167945774e-9, (83, 8) = 0.36286448601141655e-8, (84, 1) = -0.31753698308364556e-8, (84, 2) = -0.10461104743326869e-8, (84, 3) = 0.13628455222444051e-7, (84, 4) = 0.777155738899366e-7, (84, 5) = 0.11512875245111392e-6, (84, 6) = 0.6128889854059593e-9, (84, 7) = 0.42145727059489196e-9, (84, 8) = 0.3798364733653945e-8, (85, 1) = -0.32559778816017888e-8, (85, 2) = -0.11010982391406696e-8, (85, 3) = 0.13629105662535011e-7, (85, 4) = 0.7965220111460175e-7, (85, 5) = 0.11825333870148793e-6, (85, 6) = 0.6012713985726558e-9, (85, 7) = 0.40055695935079207e-9, (85, 8) = 0.3957842957459699e-8, (86, 1) = -0.33319712979635475e-8, (86, 2) = -0.11533750905942853e-8, (86, 3) = 0.13629743264747681e-7, (86, 4) = 0.815112059008639e-7, (86, 5) = 0.12125445285576258e-6, (86, 6) = 0.5905822250097337e-9, (86, 7) = 0.3799577398955201e-9, (86, 8) = 0.4110325450448874e-8, (87, 1) = -0.34038590790717e-8, (87, 2) = -0.12032028252543423e-8, (87, 3) = 0.13630368468981205e-7, (87, 4) = 0.832999474420837e-7, (87, 5) = 0.12414363387247352e-6, (87, 6) = 0.5806983622865403e-9, (87, 7) = 0.3596956839007137e-9, (87, 8) = 0.4254695195048654e-8, (88, 1) = -0.3472101012734901e-8, (88, 2) = -0.12508339976231308e-8, (88, 3) = 0.13630981984384503e-7, (88, 4) = 0.8502541078567928e-7, (88, 5) = 0.12693188937771124e-6, (88, 6) = 0.571515199591773e-9, (88, 7) = 0.3399144211725655e-9, (88, 8) = 0.4394577491560866e-8, (89, 1) = -0.35371439120960317e-8, (89, 2) = -0.12965227947577423e-8, (89, 3) = 0.13631585004546591e-7, (89, 4) = 0.8669500615323026e-7, (89, 5) = 0.12963095797726101e-6, (89, 6) = 0.5629393299003818e-9, (89, 7) = 0.320346491629758e-9, (89, 8) = 0.4527222263274565e-8, (90, 1) = -0.3599373331974051e-8, (90, 2) = -0.13405000825052795e-8, (90, 3) = 0.13632178843740757e-7, (90, 4) = 0.8831567424471482e-7, (90, 5) = 0.1322518784401182e-6, (90, 6) = 0.5548909996389115e-9, (90, 7) = 0.30084295777900353e-9, (90, 8) = 0.4656194799050924e-8, (91, 1) = -0.36591311329187562e-8, (91, 2) = -0.13829572375956092e-8, (91, 3) = 0.1363276470201446e-7, (91, 4) = 0.89893400980218e-7, (91, 5) = 0.13480417535903267e-6, (91, 6) = 0.5473041720127595e-9, (91, 7) = 0.2818610626978135e-9, (91, 8) = 0.4781408333845328e-8, (92, 1) = -0.3716726058724695e-8, (92, 2) = -0.14240916731613213e-8, (92, 3) = 0.1363334397684623e-7, (92, 4) = 0.9143417722979468e-7, (92, 5) = 0.13729741050864532e-6, (92, 6) = 0.5401200460576736e-9, (92, 7) = 0.2629504473543858e-9, (92, 8) = 0.4900571684088127e-8, (93, 1) = -0.37724350175585566e-8, (93, 2) = -0.14640709316061495e-8, (93, 3) = 0.13633918020198935e-7, (93, 4) = 0.9294343920371389e-7, (93, 5) = 0.13974027596435434e-6, (93, 6) = 0.5332884869325151e-9, (93, 7) = 0.2442887198832774e-9, (93, 8) = 0.50188386279285e-8, (94, 1) = -0.3826500935047674e-8, (94, 2) = -0.15030446248240265e-8, (94, 3) = 0.13634488133576416e-7, (94, 4) = 0.9442611643475284e-7, (94, 5) = 0.14214065743912287e-6, (94, 6) = 0.5267665879990628e-9, (94, 7) = 0.22562183728015598e-9, (94, 8) = 0.51332745031572245e-8, (95, 1) = -0.38791370203221685e-8, (95, 2) = -0.15411535138154652e-8, (95, 3) = 0.13635055550180868e-7, (95, 4) = 0.9588666599208073e-7, (95, 5) = 0.14450570016658982e-6, (95, 6) = 0.52051758385371e-9, (95, 7) = 0.2071649746066032e-9, (95, 8) = 0.5244795860798956e-8, (96, 1) = -0.39305296587320514e-8, (96, 2) = -0.15785117561079549e-8, (96, 3) = 0.13635621439939172e-7, (96, 4) = 0.9732913461987142e-7, (96, 5) = 0.14684188698989948e-6, (96, 6) = 0.5145098193274705e-9, (96, 7) = 0.18879387320891068e-9, (96, 8) = 0.5355134301537619e-8, (97, 1) = -0.3980849798117849e-8, (97, 2) = -0.16152303492790777e-8, (97, 3) = 0.1363618692671096e-7, (97, 4) = 0.9875723901149639e-7, (97, 5) = 0.14915517998782883e-6, (97, 6) = 0.5087157820737858e-9, (97, 7) = 0.17043759028265384e-9, (97, 8) = 0.5463294582800586e-8, (98, 1) = -0.4030241584851162e-8, (98, 2) = -0.16514136803799338e-8, (98, 3) = 0.13636753076643476e-7, (98, 4) = 0.1001743760575566e-6, (98, 5) = 0.1514510344274633e-6, (98, 6) = 0.5031116071331624e-9, (98, 7) = 0.15212406895180327e-9, (98, 8) = 0.5570888357663054e-8, (99, 1) = -0.4078841598080954e-8, (99, 2) = -0.16871344334390646e-8, (99, 3) = 0.13637320898390627e-7, (99, 4) = 0.10158364937952258e-6, (99, 5) = 0.1537344316404319e-6, (99, 6) = 0.4976765522048658e-9, (99, 7) = 0.13356981959785522e-9, (99, 8) = 0.5675748518643261e-8, (100, 1) = -0.4126765761495817e-8, (100, 2) = -0.17224858206990074e-8, (100, 3) = 0.1363789133742023e-7, (100, 4) = 0.10298787769613985e-6, (100, 5) = 0.15600989899416723e-6, (100, 6) = 0.492392642470738e-9, (100, 7) = 0.11500221807437215e-9, (100, 8) = 0.5780079579715051e-8, (101, 1) = -0.4174121670808141e-8, (101, 2) = -0.17575241955311276e-8, (101, 3) = 0.1363846529218782e-7, (101, 4) = 0.10438965504056364e-6, (101, 5) = 0.15828160100754653e-6, (101, 6) = 0.4872441556717874e-9, (101, 7) = 0.9646097401203955e-10, (101, 8) = 0.5883561924586103e-8, (102, 1) = -0.4220998857682868e-8, (102, 2) = -0.17923256188653095e-8, (102, 3) = 0.13639043610155867e-7, (102, 4) = 0.10579135729046987e-6, (102, 5) = 0.1605533559363973e-6, (102, 6) = 0.4822173706197451e-9, (102, 7) = 0.7778103951782486e-10, (102, 8) = 0.59870555212147165e-8, (103, 1) = -0.4267481829481471e-8, (103, 2) = -0.18269311654002867e-8, (103, 3) = 0.13639627049843995e-7, (103, 4) = 0.10719506476261013e-6, (103, 5) = 0.1628285035084946e-6, (103, 6) = 0.4773006521805942e-9, (103, 7) = 0.5893183698658563e-10, (103, 8) = 0.60893879067943296e-8, (104, 1) = -0.4313645249362169e-8, (104, 2) = -0.18614061615092586e-8, (104, 3) = 0.13640216413243383e-7, (104, 4) = 0.10860289257327289e-6, (104, 5) = 0.16511043837666166e-6, (104, 6) = 0.4724831215758917e-9, (104, 7) = 0.3982198713684822e-10, (104, 8) = 0.6192466551374862e-8, (105, 1) = -0.43595563653060606e-8, (105, 2) = -0.189579584829083e-8, (105, 3) = 0.13640812435042763e-7, (105, 4) = 0.11001673036777126e-6, (105, 5) = 0.16740219536044608e-6, (105, 6) = 0.4677554612323635e-9, (105, 7) = 0.206372442924139e-10, (105, 8) = 0.6294037221545482e-8, (106, 1) = -0.4405276502579238e-8, (106, 2) = -0.19301280319274524e-8, (106, 3) = 0.13641415745608679e-7, (106, 4) = 0.11143816891618492e-6, (106, 5) = 0.16970632175454483e-6, (106, 6) = 0.4631100121049547e-9, (106, 7) = 0.12621977276446718e-11, (106, 8) = 0.6397326442722726e-8, (107, 1) = -0.4450854460118647e-8, (107, 2) = -0.196444887319807e-8, (107, 3) = 0.13642026978559734e-7, (107, 4) = 0.11286875791244531e-6, (107, 5) = 0.1720252996574665e-6, (107, 6) = 0.4585398037821778e-9, (107, 7) = -0.18457887989049598e-10, (107, 8) = 0.6498176574129173e-8, (108, 1) = -0.4496337013772132e-8, (108, 2) = -0.19987928123069e-8, (108, 3) = 0.13642646714402866e-7, (108, 4) = 0.11430988611884895e-6, (108, 5) = 0.174361353449448e-6, (108, 6) = 0.4540388584032254e-9, (108, 7) = -0.3824631692237397e-10, (108, 8) = 0.6600984742630873e-8, (109, 1) = -0.45417578940610765e-8, (109, 2) = -0.20331761896634165e-8, (109, 3) = 0.13643275469425966e-7, (109, 4) = 0.11576275577118547e-6, (109, 5) = 0.17671640036893873e-6, (109, 6) = 0.4496021986133352e-9, (109, 7) = -0.5839850504193421e-10, (109, 8) = 0.6703648040921233e-8, (110, 1) = -0.4587168832146701e-8, (110, 2) = -0.2067630437408613e-8, (110, 3) = 0.13643913856086393e-7, (110, 4) = 0.11722875992003276e-6, (110, 5) = 0.1790926643914345e-6, (110, 6) = 0.44522463318333e-9, (110, 7) = -0.7881726268736357e-10, (110, 8) = 0.680742617774897e-8, (111, 1) = -0.46325915846751545e-8, (111, 2) = -0.21021804034530134e-8, (111, 3) = 0.13644562325412703e-7, (111, 4) = 0.11870889316709051e-6, (111, 5) = 0.1814917291294405e-6, (111, 6) = 0.44090249719512724e-9, (111, 7) = -0.9946143812881988e-10, (111, 8) = 0.691120741854375e-8, (112, 1) = -0.46780541702176694e-8, (112, 2) = -0.21368442673555855e-8, (112, 3) = 0.13645221309121346e-7, (112, 4) = 0.12020408052526907e-6, (112, 5) = 0.18391505968211547e-6, (112, 6) = 0.4366325798095683e-9, (112, 7) = -0.12049984603088775e-9, (112, 8) = 0.7014859165439783e-8, (113, 1) = -0.47235784221467355e-8, (113, 2) = -0.2171632500902264e-8, (113, 3) = 0.13645891178002603e-7, (113, 4) = 0.12171509525111253e-6, (113, 5) = 0.18636387496647648e-6, (113, 6) = 0.432412313786537e-9, (113, 7) = -0.14172296798454642e-9, (113, 8) = 0.71197121709601614e-8, (114, 1) = -0.47691828280327555e-8, (114, 2) = -0.22065627464878767e-8, (114, 3) = 0.13646572314142663e-7, (114, 4) = 0.1232427133727179e-6, (114, 5) = 0.18883939830078884e-6, (114, 6) = 0.4282392953353542e-9, (114, 7) = -0.16329283704427806e-9, (114, 8) = 0.7225176507630029e-8, (115, 1) = -0.21295673120958134e-4, (115, 2) = 0.10314499776881113e-4, (115, 3) = 0.11083329819173759e-10, (115, 4) = 0.2357715451065243e-9, (115, 5) = 0.3025979433170464e-9, (115, 6) = 0.10568081205680945e-11, (115, 7) = 0.1805927409101274e-6, (115, 8) = 0.10425335141170328e-4, (116, 1) = -0.2096334070800671e-4, (116, 2) = 0.999735137461245e-5, (116, 3) = 0.8799985920819926e-11, (116, 4) = 0.177711918309026e-9, (116, 5) = 0.2375888110242631e-9, (116, 6) = 0.7817048296620257e-12, (116, 7) = 0.26659081186907696e-6, (116, 8) = 0.10328853196822486e-4, (117, 1) = -0.20664451671330532e-4, (117, 2) = 0.9723750624460099e-5, (117, 3) = 0.6901787695342353e-11, (117, 4) = 0.12936941550770665e-9, (117, 5) = 0.17990130018702041e-9, (117, 6) = 0.5550681587550805e-12, (117, 7) = 0.33811447950510644e-6, (117, 8) = 0.1023672596186403e-4, (118, 1) = -0.2039926296400563e-4, (118, 2) = 0.9492128392590513e-5, (118, 3) = 0.53823286444433215e-11, (118, 4) = 0.9042967098846591e-10, (118, 5) = 0.1305334899168872e-9, (118, 6) = 0.37625695406945256e-12, (118, 7) = 0.39600507131953733e-6, (118, 8) = 0.10149935158951914e-4, (119, 1) = -0.20167989367118127e-4, (119, 2) = 0.9301331393581157e-5, (119, 3) = 0.4138245085845679e-11, (119, 4) = 0.5984537990330507e-10, (119, 5) = 0.8930891566325906e-10, (119, 6) = 0.2403748433137482e-12, (119, 7) = 0.44090926472577804e-6, (119, 8) = 0.10069201117536548e-4, (120, 1) = -0.19970757740855715e-4, (120, 2) = 0.9150574007303642e-5, (120, 3) = 0.2988929608912406e-11, (120, 4) = 0.3598143341924873e-10, (120, 5) = 0.5509692987221804e-10, (120, 6) = 0.13931615303854363e-12, (120, 7) = 0.4732968126649656e-6, (120, 8) = 0.9994962278580735e-5, (121, 1) = -0.19807644712669283e-4, (121, 2) = 0.9039470528917605e-5, (121, 3) = 0.1698673368957013e-11, (121, 4) = 0.16790690160890457e-10, (121, 5) = 0.26073710240838226e-10, (121, 6) = 0.6289892281891023e-13, (121, 7) = 0.4934547152888324e-6, (121, 8) = 0.9927396008232281e-5, (122, 1) = -0.19678691803369548e-4, (122, 2) = 0.8968043340129707e-5, (122, 3) = .0, (122, 4) = .0, (122, 5) = .0, (122, 6) = .0, (122, 7) = 0.5014858375196127e-6, (122, 8) = 0.9866416565412629e-5}, datatype = float[8], order = C_order); if not type(outpoint, 'numeric') then if outpoint = "start" or outpoint = "left" then return X[1] elif outpoint = "right" then return X[122] elif outpoint = "order" then return 8 elif outpoint = "error" then return HFloat(2.1295673120958134e-5) elif outpoint = "errorproc" then error "this is already the error procedure" elif outpoint = "rawdata" then return [8, 122, [e(t), i(t), lambda[1](t), lambda[2](t), lambda[3](t), lambda[4](t), p(t), s(t)], X, Y] else return ('procname')(x_bvp) end if end if; if outpoint < X[1] or X[122] < outpoint then error "solution is only defined in the range %1..%2", X[1], X[122] end if; V := array([1 = 4, 2 = 0]); if Digits <= trunc(evalhf(Digits)) then L := Vector(4, 'datatype' = 'float'[8]); yout := Vector(8, 'datatype' = 'float'[8]); evalhf(`dsolve/numeric/lagrange`(122, 8, X, Y, outpoint, var(yout), var(L), var(V))) else L := Vector(4, 'datatype' = 'sfloat'); yout := Vector(8, 'datatype' = 'sfloat'); `dsolve/numeric/lagrange`(122, 8, X, Y, outpoint, yout, L, V) end if; [t = outpoint, seq('[e(t), i(t), lambda[1](t), lambda[2](t), lambda[3](t), lambda[4](t), p(t), s(t)]'[i] = yout[i], i = 1 .. 8)] end proc; if not type(outpoint, 'numeric') then if outpoint = "start" or outpoint = "left" then return X[1] elif outpoint = "method" then return "bvp" elif outpoint = "right" then return X[122] elif outpoint = "order" then return 8 elif outpoint = "error" then return HFloat(2.1295673120958134e-5) elif outpoint = "errorproc" then return eval(errproc) elif outpoint = "rawdata" then return [8, 122, "depnames", X, Y, YP] else error "non-numeric value" end if end if; if outpoint < X[1] or X[122] < outpoint then error "solution is only defined in the range %1..%2", X[1], X[122] end if; if Digits <= trunc(evalhf(Digits)) and (_EnvInFsolve <> true or _EnvDSNumericSaveDigits <= trunc(evalhf(Digits))) then V := array( 1 .. 6, [( 1 ) = (7), ( 2 ) = (0), ( 3 ) = (false), ( 4 ) = (false), ( 5 ) = (false), ( 6 ) = (false)  ] ); L := Matrix(7, 2, {(1, 1) = .0, (1, 2) = .0, (2, 1) = .0, (2, 2) = .0, (3, 1) = .0, (3, 2) = .0, (4, 1) = .0, (4, 2) = .0, (5, 1) = .0, (5, 2) = .0, (6, 1) = .0, (6, 2) = .0, (7, 1) = .0, (7, 2) = .0}, datatype = float[8], order = C_order); yout := Vector(8, {(1) = .0, (2) = .0, (3) = .0, (4) = .0, (5) = .0, (6) = .0, (7) = .0, (8) = .0}, datatype = float[8]); evalhf(`dsolve/numeric/hermite`(122, 8, X, Y, YP, outpoint, var(yout), var(L), var(V))) else if _EnvInFsolve = true then Digits := _EnvDSNumericSaveDigits end if; V := array( 1 .. 6, [( 1 ) = (7), ( 2 ) = (0), ( 3 ) = (false), ( 4 ) = (false), ( 5 ) = (false), ( 6 ) = (false)  ] ); L := Matrix(7, 2, {(1, 1) = 0., (1, 2) = 0., (2, 1) = 0., (2, 2) = 0., (3, 1) = 0., (3, 2) = 0., (4, 1) = 0., (4, 2) = 0., (5, 1) = 0., (5, 2) = 0., (6, 1) = 0., (6, 2) = 0., (7, 1) = 0., (7, 2) = 0.}, order = C_order); yout := Vector(8, {(1) = 0., (2) = 0., (3) = 0., (4) = 0., (5) = 0., (6) = 0., (7) = 0., (8) = 0.}); `dsolve/numeric/hermite`(122, 8, X, Y, YP, outpoint, yout, L, V) end if; [outpoint, seq(yout[i], i = 1 .. 8)] end proc, (2) = Array(0..0, {}), (3) = [t, e(t), i(t), lambda[1](t), lambda[2](t), lambda[3](t), lambda[4](t), p(t), s(t)], (4) = 0}); solnproc := data[1]; if not type(outpoint, 'numeric') then if outpoint = "solnprocedure" then return eval(solnproc) elif member(outpoint, ["start", "left", "right", "errorproc", "rawdata", "order", "error"]) then return solnproc(x_bvp) elif outpoint = "sysvars" then return data[3] elif procname <> unknown then return ('procname')(x_bvp) else _ndsol := pointto(data[2][0]); return ('_ndsol')(x_bvp) end if end if; try res := solnproc(outpoint); [t = res[1], seq('[e(t), i(t), lambda[1](t), lambda[2](t), lambda[3](t), lambda[4](t), p(t), s(t)]'[i] = res[i+1], i = 1 .. 8)] catch: error  end try end proc

(1)

plots:-odeplot(p1, [t, e(t)],t=0..3);
plots:-odeplot(p1, [t, i(t)],t=0..3);
plots:-odeplot(p1, [t, p(t)],t=0..3);
plots:-odeplot(p1, [t, s(t)],t=0..3);
plots:-odeplot(p1, [t, lambda[1](t)],t=0..3);
plots:-odeplot(p1, [t, lambda[2](t)],t=0..3);
plots:-odeplot(p1, [t, lambda[3](t)],t=0..3);
plots:-odeplot(p1, [t, lambda[4](t)],t=0..3);

 

 

 

 

 

 

 

 

 


 

Download odeSol.mw

 

First 108 109 110 111 112 113 114 Last Page 110 of 207