Missing particles in VTK

Asked by Przemek

Hi,

I've a problem with exporting to VTK formt. After convertion from text file to vtk file some particles are missing.
How can I solve this problem?
I used this code:

export.textExt('test.txt', format='x_y_z_r_attrs', attrs=['b.getTemp()'], comment='temp')
export.text2vtk('test.txt', 'test.vtk')

BR
Przemek

Question information

Language:
English Edit question
Status:
Solved
For:
Yade Edit question
Assignee:
No assignee Edit question
Solved by:
Przemek
Solved:
Last query:
Last reply:
Revision history for this message
Jan Stránský (honzik) said :
#1

Hello,

> some particles are missing.

How do you know? From the vtk file content, of from Paraview view?
If there are "many" (5000 I think) particles, Paraview shows only a limited amount (5000 I think) of particles by default.
Are there all particles in the txt file?

If the Paraview "hiding" is not the issue, please provide more information [1]:
- complete script generating the saved data
- Yade (and maybe OS) version

cheers
Jan

[1] https://www.yade-dem.org/wiki/Howtoask

Revision history for this message
Przemek (przemekn) said :
#2

Hi Jan,

I checked the text file which contents 36 particles and in vtk file 1 particle was missed. For a higher number of particles more of them were missed.

I will send the script tomorrow when I'll be in work ;)

BR
Przemek

Revision history for this message
Przemek (przemekn) said :
#3

Hi Jan,

check the script below:

T = inv(H).dot(F)
 for tp in O.bodies:
 if isinstance(tp.shape, Box) == True:
            pass
        else:
            tp.setTemp(T[tp.id])

Revision history for this message
Przemek (przemekn) said :
#4

Sorry by the indentation. It should looks like:

    for tp in O.bodies:
        if isinstance(tp.shape, Box) == True:
            pass
        else:
            tp.setTemp(T[tp.id])

BR
Przemek

Revision history for this message
Robert Caulk (rcaulk) said :
#5

Please provide a complete script.

Revision history for this message
Przemek (przemekn) said :
#6

import math
import numpy as np
from scipy.sparse.linalg import spsolve
from numpy.linalg import norm
from numpy.linalg import inv
from yade import pack, export

# Properties and parameters
kappa = 10. # heat conductivity
beta = 1.
T_inf = 20. # ambient temperature
q_v = 0.5e1 # heat flux
convection1 = 0. # x-position of convection
convection2 = 0. # y-position of convection

tPoint = [2, 2, 0]
avTemp = 0

# Plate dimension
boxMax = (5.0, 5.0, 0.5)
# Spheres
color = [0.21, 0.22, 0.1]
sphereRadius = 0.1 # cm
r = 0.11
ndiv_x = boxMax[0] / (2 * sphereRadius) + 1
ndiv_y = boxMax[1] / (2 * sphereRadius) + 1
ndiv_z = boxMax[2] / (2 * sphereRadius) + 1
nbSpheres = (int(ndiv_x), int(ndiv_y), int(ndiv_z))
num = 0
for i in range(nbSpheres[0]):
    for j in range(nbSpheres[1]):
        for jj in range(nbSpheres[2]):
            x = (2.0 * sphereRadius * i)
            y = (2.0 * sphereRadius * j)
            z = (2.0 * sphereRadius * jj)
            num += 1
            plate = utils.sphere([x, y, z], r, color=color, fixed=fixed)
            O.bodies.append(plate)
conv1 = box(center=(convection1, boxMax[1] / 2, boxMax[2] / 2), extents=(0., boxMax[1] / 2 + sphereRadius, boxMax[2] / 2 + sphereRadius),
            fixed=True, wire=True, mask=3),
conv2 = box(center=(boxMax[0] / 2, convection2, boxMax[2] / 2), extents=(boxMax[0] / 2 + sphereRadius, 0., boxMax[2] / 2 + sphereRadius),
            fixed=True, wire=True, mask=3),
heat1 = facet(vertices=[(boxMax[0] + sphereRadius, -sphereRadius, -sphereRadius),
                        (boxMax[0] + sphereRadius, boxMax[0] + sphereRadius, -sphereRadius),
                        (boxMax[0] + sphereRadius, -sphereRadius, boxMax[2] + sphereRadius)], fixed=True, wire=True, mask=55)
heat2 = facet(vertices=[(boxMax[0] + sphereRadius, boxMax[0] + sphereRadius, boxMax[2] + sphereRadius),
                        (boxMax[0] + sphereRadius, boxMax[0] + sphereRadius, -sphereRadius),
                        (boxMax[0] + sphereRadius, -sphereRadius, boxMax[2] + sphereRadius)], fixed=True, wire=True, mask=55)
O.bodies.append(heat1)
O.bodies.append(heat2)
O.bodies.append(conv1)
O.bodies.append(conv2)
nBox = 2 # number of boxes

###
def convComp():
    betaDiffx = 0
    betaDiffy = 0
    for b in O.bodies:
        if isinstance(b.shape, Sphere):
            if b.state.pos[0] == convection1:
                betaDiffx += 1
            elif b.state.pos[1] == convection2:
                betaDiffy += 1
            else:
                pass
    beta_x = beta / betaDiffx
    beta_y = beta / betaDiffy
    return beta_x, beta_y
###

beta_x = convComp()[0]
beta_y = convComp()[1]

# Solver
O.engines = [
    ForceResetter(),
    InsertionSortCollider([Bo1_Sphere_Aabb(), Bo1_Box_Aabb(), Bo1_Facet_Aabb()]),
    InteractionLoop(
        [Ig2_Sphere_Sphere_ScGeom(), Ig2_Box_Sphere_ScGeom(), Ig2_Facet_Sphere_ScGeom()],
        [Ip2_FrictMat_FrictMat_FrictPhys()],
        [Law2_ScGeom_FrictPhys_CundallStrack()]
    ),
    NewtonIntegrator(gravity=(0, 0, -9.81), damping=0.1),
    PyRunner(command='intCounter()', realPeriod=1),
    PyRunner(command='tempCalc()', realPeriod=1),
    PyRunner(command='checkTempPoint(tPoint, sphereRadius)', realPeriod=1)
]
# Make a step
O.step()

###
def intCounter(): # counter of body (Sphere and Facet) real interactions
    for b in O.bodies:
        if isinstance(b.shape, Sphere) == True:
            countI = 0
            bInCon = []
            for i in O.interactions:
                if i.isReal:
                    if (i.id1 == b.id):
                        if isinstance(O.bodies[i.id2].shape, Facet) == True:
                            countI += 1
                            bInCon.append(i.id2)
                        else:
                            pass
                    elif (i.id2 == b.id):
                        if isinstance(O.bodies[i.id1].shape, Facet) == True:
                            countI += 1
                            bInCon.append(i.id1)
                        else:
                            pass
                    else:
                        pass
            b.realInt(countI)
            b.bodiesInContact(bInCon)
        elif isinstance(b.shape, Facet) == True:
            countI = 0
            bInCon = []
            for i in O.interactions:
                if i.isReal:
                    if (i.id1 == b.id):
                        countI += 1
                        bInCon.append(i.id2)
                    elif (i.id2 == b.id):
                        countI += 1
                        bInCon.append(i.id1)
                    else:
                        pass
            b.realInt(countI)
            b.bodiesInContact(bInCon)
        else:
            pass
###

###
def volumefraction(fID, sID):
    ns = O.bodies[fID].countI
    nsd = 0
    # Ai = pi * math.pow(r * math.sin(math.acos((r - O.interactions[sID, fID].geom.penetrationDepth) / r)), 2) # Area of penetraded particle
    for b in O.bodies[fID].bInCon:
        if O.bodies[b].countI > 1:
            nsd += 1
        else:
            pass
    nsn = ns - nsd
    if O.bodies[sID].countI > 1:
        vf = [O.interactions[sID, fID].geom.penetrationDepth]
        for fCon in O.bodies[sID].bInCon:
            if fCon != fID:
                vf.append(O.interactions[sID, fCon].geom.penetrationDepth)
            else:
                pass
        psi = vf[0] / sum(vf) / ns
    else:
        psi_prime = []
        for sCon in O.bodies[fID].bInCon:
            if sCon != sID:
                if O.bodies[sCon].countI > 1:
                    vf = [O.interactions[sCon, fID].geom.penetrationDepth]
                    for fCon in O.bodies[sCon].bInCon:
                        if fCon != fID:
                            vf.append(O.interactions[sCon, fCon].geom.penetrationDepth)
                        else:
                            pass
                    psi_prime.append(vf[0] / sum(vf))
                else:
                    pass
            else:
                pass

        psi = (1 - (sum(psi_prime) / ns)) / float(nsn)
    return psi
###

###
def tempCalc():
    def interNumber(): # is needed???
        tmp = 0
        vec = []
        for i in O.interactions:
            if i.isReal:
                vec.append([i.id1, i.id2])
                tmp += 1
            else:
                pass
        return tmp, vec

    realInt = interNumber()[0] # real number of interactions
    interList = interNumber()[1] # list of bodies IDs in interactions

    def interactionsDef(ii, jj):
        conPoint = O.interactions[ii, jj].geom.contactPoint # coordinates of contact point
        penDist = O.interactions[ii, jj].geom.penetrationDepth / 2. # penetration distance of current particle
        alphaI = math.acos(1 - penDist / r) # contact angle - alpha_i
        ###
        # ui = (conPoint - xi) / 2.
        xi = O.bodies[ii].state.pos # current position of body 1
        xj = O.bodies[jj].state.pos # current position of body 1
        ri = xj - xi
        ui = np.array([1., 0., 0.]) # basis vector x
        vi = np.array([0., 1., 0.]) # basis vector y
        wi = np.array([0., 0., 1.]) # basis vector z
        teta_1 = np.arccos(
            (ri.dot(vi.T)) / (norm(ri) * norm(vi))) # angle of contact position theta_i - direction 1
        teta_2 = np.arccos(
            (ri.dot(wi.T)) / (norm(ri) * norm(wi))) # angle of contact position theta_i - direction 2

        cx = (ri.dot(ui.T)) / (norm(ri) * norm(ui))
        cy = (ri.dot(vi.T)) / (norm(ri) * norm(vi))
        cz = (ri.dot(wi.T)) / (norm(ri) * norm(wi))

        c11 = cx * cx
        c22 = cy * cy
        c33 = cz * cz
        c12 = cx * cy
        c13 = cx * cz
        c23 = cy * cz

        cosMatrix = np.array([[c11, c12, c13, -c11, -c12, -c13],
                              [c12, c22, c23, -c12, -c22, -c23],
                              [c13, c23, c33, -c13, -c23, -c33],
                              [-c11, -c12, -c13, c11, c12, c13],
                              [-c12, -c22, -c23, c12, c22, c23],
                              [-c13, -c23, -c33, c13, c23, c33]])

        return alphaI, cosMatrix

    H = np.zeros([len(O.bodies) - nBox, len(O.bodies) - nBox]) # definition of thermal resistance matrix
    F = np.zeros(len(O.bodies) - nBox) # definition of thermal force vector

    def thResMatrix():
        for con in O.interactions: # loop over all interactions
            if con.isReal:
                idBodies = [con.id1, con.id2] # Allocation vector
                ii = idBodies[0] # ID of body 1
                jj = idBodies[1] # ID of body 2
                if isinstance(O.bodies[ii].shape, Sphere) and isinstance(O.bodies[jj].shape,
                                                                         Sphere) == True: # only spheres
                    alphaI = interactionsDef(ii, jj)[0]
                    K_el = np.power(2 / math.pi / kappa * (3 / 2 + np.power(alphaI, 2) / 36.
                                                           + np.power(alphaI, 4) / 2700. + np.power(alphaI, 6) / 79380.
                                                           + np.power(alphaI, 8) / 252000. - np.log(alphaI)), -1)
                    H[ii][ii] += K_el
                    H[ii][jj] += -K_el
                    H[jj][ii] += -K_el
                    H[jj][jj] += K_el
                    for conv in range(2):
                        if O.bodies[idBodies[conv]].state.pos[0] == convection1:
                            H[idBodies[conv]][idBodies[conv]] += beta_x
                            F[idBodies[conv]] += beta_x * T_inf
                            if O.bodies[idBodies[conv]].state.pos[1] == convection2:
                                H[idBodies[conv]][idBodies[conv]] += beta_y
                                F[idBodies[conv]] += beta_y * T_inf
                            else:
                                pass
                        elif O.bodies[idBodies[conv]].state.pos[1] == convection2:
                            H[idBodies[conv]][idBodies[conv]] += beta_y
                            F[idBodies[conv]] += beta_y * T_inf
                            if O.bodies[idBodies[conv]].state.pos[0] == convection1:
                                H[idBodies[conv]][idBodies[conv]] += beta_x
                                F[idBodies[conv]] += beta_x * T_inf
                            else:
                                pass
                        else:
                            pass
                elif (isinstance(O.bodies[ii].shape, Facet) or isinstance(O.bodies[jj].shape, Facet)) == True: # facets
                    alphaI = interactionsDef(ii, jj)[0]
                    K_el = np.power(1 / math.pi / kappa * (3 / 2 + np.power(alphaI, 2) / 36.
                                                           + np.power(alphaI, 4) / 2700. + np.power(alphaI, 6) / 79380.
                                                           + np.power(alphaI, 8) / 252000. - np.log(alphaI)), -1)
                    H[ii][ii] += K_el
                    H[ii][jj] += -K_el
                    H[jj][ii] += -K_el
                    H[jj][jj] += K_el
                    for conv in range(2):
                        if isinstance(O.bodies[idBodies[conv]].shape, Facet) == True:
                            volFrac = volumefraction(idBodies[conv], idBodies[1 - conv])
                            F[idBodies[conv]] += q_v * volFrac
                        else:
                            pass
                else:
                    pass
            else:
                pass

    def boundaryCon():
        for bon in O.interactions: # loop over all bodies
            if bon.isReal:
                idBodies = [bon.id1, bon.id2] # Allocation vector
                if isinstance(O.bodies[idBodies[0]].shape, Sphere) or isinstance(O.bodies[idBodies[1]].shape,
                                                                                 Sphere) != True:
                    ii = i.id # body ID
                    xi = i.state.pos # current position of body
                    for j in range(len(i.intrs())): # loop over all bodies in interaction with current body
                        k = utils.getBodyIdsContacts(ii)[j] # ID of contact particle
                        if O.interactions[ii, k].isReal:
                            if isinstance(i.shape, Sphere): # only spheres
                                alphaI = interactionsDef(ii, xi, k)
                                H[ii] += 2 / math.pi / kappa * (3 / 2 + np.power(alphaI, 2) / 36.
                                                                + np.power(alphaI, 4) / 2700. + np.power(alphaI,
                                                                                                         6) / 79380.
                                                                + np.power(alphaI, 8) / 252000. - np.log(alphaI))
                            else: # other shapes - facets, boxes
                                alphaI = interactionsDef(ii, xi, k)
                                H[k] += 1 / math.pi / kappa * (3 / 2 + np.power(alphaI, 2) / 36.
                                                               + np.power(alphaI, 4) / 2700. + np.power(alphaI,
                                                                                                        6) / 79380.
                                                               + np.power(alphaI, 8) / 252000. - np.log(alphaI))
                                if i.mask == 45:
                                    H[k] += + beta
                                else:
                                    pass
                        else:
                            pass

    thResMatrix()

    #T = inv(H).dot(F) # add a module to solve the sparse matrix
    T = spsolve(H, F)
    minT = min(T)
    maxT = max(T)
    #ran = floor(max(T) - minT)
    ran = maxT - minT

    for tp in O.bodies:
        if isinstance(tp.shape, Box) == True:
            pass
        else:
            tp.setTemp(T[tp.id])
            colMap = (T[tp.id] - minT) / ran * 255
            n = 4 * colMap / 256
            red = 255 * min(max(min(n - 1.5, -n + 4.5), 0), 1)
            green = 255 * min(max(min(n - 0.5, -n + 3.5), 0), 1)
            blue = 255 * min(max(min(n + 0.5, -n + 2.5), 0), 1)
            tp.shape.color = (red, green, blue)

    export.textExt('test.txt', format='x_y_z_r_attrs', attrs=['b.getTemp()'], comment='temp')
    export.text2vtk('test.txt', 'test.vtk')
    print(maxT - minT)
###

###
def checkTempPoint(tPoint, r):
    scaleFactor = 1.5
    inflRad = scaleFactor * r
    avTemp = []
    for b in O.bodies:
        if type(b.shape) == Sphere:
            bRad = norm(b.state.pos - tPoint)
            if bRad <= inflRad:
                avTemp.append(b.getTemp())
            else:
                pass
    avTemp = np.mean(avTemp)
    print(avTemp)
###

from yade import pack, qt

v = qt.View()
v.axes = False

Revision history for this message
Przemek (przemekn) said :
#7

It is long :)

Revision history for this message
Robert Caulk (rcaulk) said :
#8

It is too long, MWE means minimal working example. I don't have time to go through it but maybe someone else will ;-)

Revision history for this message
Przemek (przemekn) said :
#9

The code works but there is problem only with export data from the text file to vtk. Like i wrote, in txt file I had 36 particles and after convertion one particle was missed.
I don't know what is the reason of it.

Revision history for this message
Robert Caulk (rcaulk) said :
#10

Well we cannot reproduce your problem because you are using a custom installation of Yade with custom body attributes. If you desire assistance, it would be helpful if you isolate the issue in a reproducible MWE.

Have you tried using [1]?

[1]https://yade-dem.org/doc/yade.export.html#yade.export.VTKExporter

Revision history for this message
Przemek (przemekn) said :
#11

 I just tried to use this:

vtkExporter = export.VTKExporter('/tmp/vtkExporterTesting')
vtkExporter.exportSpheres(what=dict(dist='b.state.pos.norm()'))

But I had an error:

ValueError Traceback (most recent call last)
/usr/bin/yade in <module>()

/usr/bin/yade in tempCalc()
    202
    203 vtkExporter = export.VTKExporter('vtkExporterTesting')
--> 204 vtkExporter.exportSpheres(what=dict(dist='b.state.pos.norm()'))
    205
    206 #export.textExt('test.txt', format='x_y_z_r_attrs', attrs=['b.getTemp()'], comment='temp')

/usr/lib/x86_64-linux-gnu/yade/py/yade/export.py in exportSpheres(self, ids, what, comment, numLabel, useRef)
    428 outFile.write("%g\n"%(b.shape.radius))
    429 # write additional data from 'what' param
--> 430 for name,command in what: # for each name...
    431 test = eval(command) # ... eval one example to see what type (float, Vector3, Matrix3) the result is ...
    432 # ... and write appropriate header line and loop over all bodies and write appropriate vtk line(s)

ValueError: too many values to unpack

Yade [2]: ---------------------------------------------------------------------------
KeyboardInterrupt Traceback (most recent call last)
/usr/lib/x86_64-linux-gnu/yade/py/yade/__init__.py in refreshEvent(self)
    198 def yzxSlot(self): self.setViewAxes((-1,0,0),(0,0,1))
    199 def zxySlot(self): self.setViewAxes((0,-1,0),(1,0,0))
--> 200 def refreshEvent(self):
    201 self.refreshValues()
    202 self.activateControls()

KeyboardInterrupt:

In case when I used export to txt file, I get:

#format x_y_z_r_attrs
# x y z r temp
0 0 0 0.55 40
1 0 0 0.55 42.3553
2 0 0 0.55 44.7105
3 0 0 0.55 47.0658
4 0 0 0.55 49.421

And after text2vtk:

# vtk DataFile Version 3.0.
comment
ASCII

DATASET POLYDATA
POINTS 4 double
1 0 0
2 0 0
3 0 0
4 0 0

POINT_DATA 4
SCALARS radius double 1
LOOKUP_TABLE default
0.55
0.55
0.55
0.55

SCALARS temp double 1
LOOKUP_TABLE default
42.3553
44.7105
47.0658
49.421

So, in txt I have 5 particles and in vtk file 4... wierd...

Revision history for this message
Jan Stránský (honzik) said :
#12

if the problem is the 36 particles file, please provide that one
Thanks
Jan

Revision history for this message
Przemek (przemekn) said :
#13

Hi Jan,

this is txt file for 36 particles:

#format x_y_z_r_attrs
# x y z r temp
0 0 0 0.55 21.4949
0 1 0 0.55 21.551
0 2 0 0.55 21.6028
0 3 0 0.55 21.6451
0 4 0 0.55 21.6783
0 5 0 0.55 21.7061
1 0 0 0.55 21.5679
1 1 0 0.55 21.6467
1 2 0 0.55 21.7066
1 3 0 0.55 21.7512
1 4 0 0.55 21.7824
1 5 0 0.55 21.8009
2 0 0 0.55 21.6728
2 1 0 0.55 21.7612
2 2 0 0.55 21.8258
2 3 0 0.55 21.8707
2 4 0 0.55 21.8994
2 5 0 0.55 21.914
3 0 0 0.55 21.8076
3 1 0 0.55 21.8995
3 2 0 0.55 21.9645
3 3 0 0.55 22.0063
3 4 0 0.55 22.0305
3 5 0 0.55 22.0419
4 0 0 0.55 21.9781
4 1 0 0.55 22.0649
4 2 0 0.55 22.1265
4 3 0 0.55 22.1597
4 4 0 0.55 22.1744
4 5 0 0.55 22.181
5 0 0 0.55 22.2016
5 1 0 0.55 22.2554
5 2 0 0.55 22.3168
5 3 0 0.55 22.3314
5 4 0 0.55 22.3264
5 5 0 0.55 22.3268

And generated vtk:

# vtk DataFile Version 3.0.
comment
ASCII

DATASET POLYDATA
POINTS 35 double
0 1 0
0 2 0
0 3 0
0 4 0
0 5 0
1 0 0
1 1 0
1 2 0
1 3 0
1 4 0
1 5 0
2 0 0
2 1 0
2 2 0
2 3 0
2 4 0
2 5 0
3 0 0
3 1 0
3 2 0
3 3 0
3 4 0
3 5 0
4 0 0
4 1 0
4 2 0
4 3 0
4 4 0
4 5 0
5 0 0
5 1 0
5 2 0
5 3 0
5 4 0
5 5 0

POINT_DATA 35
SCALARS radius double 1
LOOKUP_TABLE default
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55
0.55

SCALARS temp double 1
LOOKUP_TABLE default
21.551
21.6028
21.6451
21.6783
21.7061
21.5679
21.6467
21.7066
21.7512
21.7824
21.8009
21.6728
21.7612
21.8258
21.8707
21.8994
21.914
21.8076
21.8995
21.9645
22.0063
22.0305
22.0419
21.9781
22.0649
22.1265
22.1597
22.1744
22.181
22.2016
22.2554
22.3168
22.3314
22.3264
22.3268

Revision history for this message
Jan Stránský (honzik) said :
#14

It seems to be a bug in text2vtk, where the very first particle is not output.. will try to fix it

> For a higher number of particles more of them were missed.

do you have an example of this?

cheers
Jan

Revision history for this message
Przemek (przemekn) said :
#15

Hi Jan,

here is a txt file:

#format x_y_z_r_attrs
# x y z r temp
0 0 0 0.11 21.0635
0 0 0.2 0.11 21.0627
0 0 0.4 0.11 21.0635
0 0.2 0 0.11 21.0687
0 0.2 0.2 0.11 21.0682
0 0.2 0.4 0.11 21.0687
0 0.4 0 0.11 21.0743
0 0.4 0.2 0.11 21.0739
0 0.4 0.4 0.11 21.0743
0 0.6 0 0.11 21.0799
0 0.6 0.2 0.11 21.0795
0 0.6 0.4 0.11 21.0799
0 0.8 0 0.11 21.0854
0 0.8 0.2 0.11 21.085
0 0.8 0.4 0.11 21.0854
0 1 0 0.11 21.0907
0 1 0.2 0.11 21.0902
0 1 0.4 0.11 21.0907
0 1.2 0 0.11 21.0957
0 1.2 0.2 0.11 21.0953
0 1.2 0.4 0.11 21.0957
0 1.4 0 0.11 21.1005
0 1.4 0.2 0.11 21.1
0 1.4 0.4 0.11 21.1005
0 1.6 0 0.11 21.105
0 1.6 0.2 0.11 21.1046
0 1.6 0.4 0.11 21.105
0 1.8 0 0.11 21.1092
0 1.8 0.2 0.11 21.1088
0 1.8 0.4 0.11 21.1092
0 2 0 0.11 21.1132
0 2 0.2 0.11 21.1128
0 2 0.4 0.11 21.1132
0 2.2 0 0.11 21.1169
0 2.2 0.2 0.11 21.1165
0 2.2 0.4 0.11 21.1169
0 2.4 0 0.11 21.1204
0 2.4 0.2 0.11 21.12
0 2.4 0.4 0.11 21.1204
0 2.6 0 0.11 21.1236
0 2.6 0.2 0.11 21.1232
0 2.6 0.4 0.11 21.1236
0 2.8 0 0.11 21.1266
0 2.8 0.2 0.11 21.1261
0 2.8 0.4 0.11 21.1266
0 3 0 0.11 21.1293
0 3 0.2 0.11 21.1288
0 3 0.4 0.11 21.1293
0 3.2 0 0.11 21.1317
0 3.2 0.2 0.11 21.1313
0 3.2 0.4 0.11 21.1317
0 3.4 0 0.11 21.134
0 3.4 0.2 0.11 21.1335
0 3.4 0.4 0.11 21.134
0 3.6 0 0.11 21.1359
0 3.6 0.2 0.11 21.1355
0 3.6 0.4 0.11 21.1359
0 3.8 0 0.11 21.1377
0 3.8 0.2 0.11 21.1373
0 3.8 0.4 0.11 21.1377
0 4 0 0.11 21.1393
0 4 0.2 0.11 21.1388
0 4 0.4 0.11 21.1393
0 4.2 0 0.11 21.1406
0 4.2 0.2 0.11 21.1402
0 4.2 0.4 0.11 21.1406
0 4.4 0 0.11 21.1418
0 4.4 0.2 0.11 21.1414
0 4.4 0.4 0.11 21.1418
0 4.6 0 0.11 21.1429
0 4.6 0.2 0.11 21.1424
0 4.6 0.4 0.11 21.1429
0 4.8 0 0.11 21.1438
0 4.8 0.2 0.11 21.1434
0 4.8 0.4 0.11 21.1438
0 5 0 0.11 21.1449
0 5 0.2 0.11 21.1445
0 5 0.4 0.11 21.1449
0.2 0 0 0.11 21.0691
0.2 0 0.2 0.11 21.0685
0.2 0 0.4 0.11 21.0691
0.2 0.2 0 0.11 21.0753
0.2 0.2 0.2 0.11 21.0751
0.2 0.2 0.4 0.11 21.0753
0.2 0.4 0 0.11 21.0812
0.2 0.4 0.2 0.11 21.0811
0.2 0.4 0.4 0.11 21.0812
0.2 0.6 0 0.11 21.087
0.2 0.6 0.2 0.11 21.0869
0.2 0.6 0.4 0.11 21.087
0.2 0.8 0 0.11 21.0926
0.2 0.8 0.2 0.11 21.0925
0.2 0.8 0.4 0.11 21.0926
0.2 1 0 0.11 21.0979
0.2 1 0.2 0.11 21.0978
0.2 1 0.4 0.11 21.0979
0.2 1.2 0 0.11 21.103
0.2 1.2 0.2 0.11 21.1029
0.2 1.2 0.4 0.11 21.103
0.2 1.4 0 0.11 21.1078
0.2 1.4 0.2 0.11 21.1077
0.2 1.4 0.4 0.11 21.1078
0.2 1.6 0 0.11 21.1124
0.2 1.6 0.2 0.11 21.1123
0.2 1.6 0.4 0.11 21.1124
0.2 1.8 0 0.11 21.1166
0.2 1.8 0.2 0.11 21.1166
0.2 1.8 0.4 0.11 21.1166
0.2 2 0 0.11 21.1207
0.2 2 0.2 0.11 21.1206
0.2 2 0.4 0.11 21.1207
0.2 2.2 0 0.11 21.1244
0.2 2.2 0.2 0.11 21.1243
0.2 2.2 0.4 0.11 21.1244
0.2 2.4 0 0.11 21.1279
0.2 2.4 0.2 0.11 21.1278
0.2 2.4 0.4 0.11 21.1279
0.2 2.6 0 0.11 21.1311
0.2 2.6 0.2 0.11 21.131
0.2 2.6 0.4 0.11 21.1311
0.2 2.8 0 0.11 21.1341
0.2 2.8 0.2 0.11 21.134
0.2 2.8 0.4 0.11 21.1341
0.2 3 0 0.11 21.1368
0.2 3 0.2 0.11 21.1367
0.2 3 0.4 0.11 21.1368
0.2 3.2 0 0.11 21.1392
0.2 3.2 0.2 0.11 21.1392
0.2 3.2 0.4 0.11 21.1392
0.2 3.4 0 0.11 21.1415
0.2 3.4 0.2 0.11 21.1414
0.2 3.4 0.4 0.11 21.1415
0.2 3.6 0 0.11 21.1435
0.2 3.6 0.2 0.11 21.1434
0.2 3.6 0.4 0.11 21.1435
0.2 3.8 0 0.11 21.1453
0.2 3.8 0.2 0.11 21.1452
0.2 3.8 0.4 0.11 21.1453
0.2 4 0 0.11 21.1468
0.2 4 0.2 0.11 21.1467
0.2 4 0.4 0.11 21.1468
0.2 4.2 0 0.11 21.1482
0.2 4.2 0.2 0.11 21.1481
0.2 4.2 0.4 0.11 21.1482
0.2 4.4 0 0.11 21.1493
0.2 4.4 0.2 0.11 21.1492
0.2 4.4 0.4 0.11 21.1493
0.2 4.6 0 0.11 21.1503
0.2 4.6 0.2 0.11 21.1502
0.2 4.6 0.4 0.11 21.1503
0.2 4.8 0 0.11 21.1511
0.2 4.8 0.2 0.11 21.151
0.2 4.8 0.4 0.11 21.1511
0.2 5 0 0.11 21.1517
0.2 5 0.2 0.11 21.1516
0.2 5 0.4 0.11 21.1517
0.4 0 0 0.11 21.0756
0.4 0 0.2 0.11 21.0752
0.4 0 0.4 0.11 21.0756
0.4 0.2 0 0.11 21.0822
0.4 0.2 0.2 0.11 21.0821
0.4 0.2 0.4 0.11 21.0822
0.4 0.4 0 0.11 21.0885
0.4 0.4 0.2 0.11 21.0884
0.4 0.4 0.4 0.11 21.0885
0.4 0.6 0 0.11 21.0944
0.4 0.6 0.2 0.11 21.0944
0.4 0.6 0.4 0.11 21.0944
0.4 0.8 0 0.11 21.1001
0.4 0.8 0.2 0.11 21.1001
0.4 0.8 0.4 0.11 21.1001
0.4 1 0 0.11 21.1055
0.4 1 0.2 0.11 21.1055
0.4 1 0.4 0.11 21.1055
0.4 1.2 0 0.11 21.1107
0.4 1.2 0.2 0.11 21.1106
0.4 1.2 0.4 0.11 21.1107
0.4 1.4 0 0.11 21.1155
0.4 1.4 0.2 0.11 21.1155
0.4 1.4 0.4 0.11 21.1155
0.4 1.6 0 0.11 21.1201
0.4 1.6 0.2 0.11 21.1201
0.4 1.6 0.4 0.11 21.1201
0.4 1.8 0 0.11 21.1244
0.4 1.8 0.2 0.11 21.1244
0.4 1.8 0.4 0.11 21.1244
0.4 2 0 0.11 21.1284
0.4 2 0.2 0.11 21.1284
0.4 2 0.4 0.11 21.1284
0.4 2.2 0 0.11 21.1322
0.4 2.2 0.2 0.11 21.1322
0.4 2.2 0.4 0.11 21.1322
0.4 2.4 0 0.11 21.1357
0.4 2.4 0.2 0.11 21.1357
0.4 2.4 0.4 0.11 21.1357
0.4 2.6 0 0.11 21.1389
0.4 2.6 0.2 0.11 21.1389
0.4 2.6 0.4 0.11 21.1389
0.4 2.8 0 0.11 21.1419
0.4 2.8 0.2 0.11 21.1419
0.4 2.8 0.4 0.11 21.1419
0.4 3 0 0.11 21.1446
0.4 3 0.2 0.11 21.1446
0.4 3 0.4 0.11 21.1446
0.4 3.2 0 0.11 21.1471
0.4 3.2 0.2 0.11 21.1471
0.4 3.2 0.4 0.11 21.1471
0.4 3.4 0 0.11 21.1493
0.4 3.4 0.2 0.11 21.1493
0.4 3.4 0.4 0.11 21.1493
0.4 3.6 0 0.11 21.1513
0.4 3.6 0.2 0.11 21.1513
0.4 3.6 0.4 0.11 21.1513
0.4 3.8 0 0.11 21.1531
0.4 3.8 0.2 0.11 21.1531
0.4 3.8 0.4 0.11 21.1531
0.4 4 0 0.11 21.1546
0.4 4 0.2 0.11 21.1546
0.4 4 0.4 0.11 21.1546
0.4 4.2 0 0.11 21.156
0.4 4.2 0.2 0.11 21.156
0.4 4.2 0.4 0.11 21.156
0.4 4.4 0 0.11 21.1571
0.4 4.4 0.2 0.11 21.1571
0.4 4.4 0.4 0.11 21.1571
0.4 4.6 0 0.11 21.158
0.4 4.6 0.2 0.11 21.158
0.4 4.6 0.4 0.11 21.158
0.4 4.8 0 0.11 21.1587
0.4 4.8 0.2 0.11 21.1586
0.4 4.8 0.4 0.11 21.1587
0.4 5 0 0.11 21.159
0.4 5 0.2 0.11 21.159
0.4 5 0.4 0.11 21.159
0.6 0 0 0.11 21.0828
0.6 0 0.2 0.11 21.0824
0.6 0 0.4 0.11 21.0828
0.6 0.2 0 0.11 21.0896
0.6 0.2 0.2 0.11 21.0895
0.6 0.2 0.4 0.11 21.0896
0.6 0.4 0 0.11 21.096
0.6 0.4 0.2 0.11 21.096
0.6 0.4 0.4 0.11 21.096
0.6 0.6 0 0.11 21.1021
0.6 0.6 0.2 0.11 21.1021
0.6 0.6 0.4 0.11 21.1021
0.6 0.8 0 0.11 21.1079
0.6 0.8 0.2 0.11 21.1079
0.6 0.8 0.4 0.11 21.1079
0.6 1 0 0.11 21.1134
0.6 1 0.2 0.11 21.1134
0.6 1 0.4 0.11 21.1134
0.6 1.2 0 0.11 21.1186
0.6 1.2 0.2 0.11 21.1186
0.6 1.2 0.4 0.11 21.1186
0.6 1.4 0 0.11 21.1235
0.6 1.4 0.2 0.11 21.1235
0.6 1.4 0.4 0.11 21.1235
0.6 1.6 0 0.11 21.1281
0.6 1.6 0.2 0.11 21.1281
0.6 1.6 0.4 0.11 21.1281
0.6 1.8 0 0.11 21.1325
0.6 1.8 0.2 0.11 21.1325
0.6 1.8 0.4 0.11 21.1325
0.6 2 0 0.11 21.1365
0.6 2 0.2 0.11 21.1365
0.6 2 0.4 0.11 21.1365
0.6 2.2 0 0.11 21.1403
0.6 2.2 0.2 0.11 21.1403
0.6 2.2 0.4 0.11 21.1403
0.6 2.4 0 0.11 21.1438
0.6 2.4 0.2 0.11 21.1438
0.6 2.4 0.4 0.11 21.1438
0.6 2.6 0 0.11 21.147
0.6 2.6 0.2 0.11 21.147
0.6 2.6 0.4 0.11 21.147
0.6 2.8 0 0.11 21.15
0.6 2.8 0.2 0.11 21.15
0.6 2.8 0.4 0.11 21.15
0.6 3 0 0.11 21.1527
0.6 3 0.2 0.11 21.1527
0.6 3 0.4 0.11 21.1527
0.6 3.2 0 0.11 21.1552
0.6 3.2 0.2 0.11 21.1552
0.6 3.2 0.4 0.11 21.1552
0.6 3.4 0 0.11 21.1574
0.6 3.4 0.2 0.11 21.1574
0.6 3.4 0.4 0.11 21.1574
0.6 3.6 0 0.11 21.1594
0.6 3.6 0.2 0.11 21.1594
0.6 3.6 0.4 0.11 21.1594
0.6 3.8 0 0.11 21.1612
0.6 3.8 0.2 0.11 21.1612
0.6 3.8 0.4 0.11 21.1612
0.6 4 0 0.11 21.1627
0.6 4 0.2 0.11 21.1627
0.6 4 0.4 0.11 21.1627
0.6 4.2 0 0.11 21.164
0.6 4.2 0.2 0.11 21.164
0.6 4.2 0.4 0.11 21.164
0.6 4.4 0 0.11 21.1651
0.6 4.4 0.2 0.11 21.1651
0.6 4.4 0.4 0.11 21.1651
0.6 4.6 0 0.11 21.1659
0.6 4.6 0.2 0.11 21.1659
0.6 4.6 0.4 0.11 21.1659
0.6 4.8 0 0.11 21.1665
0.6 4.8 0.2 0.11 21.1665
0.6 4.8 0.4 0.11 21.1665
0.6 5 0 0.11 21.1668
0.6 5 0.2 0.11 21.1668
0.6 5 0.4 0.11 21.1668
0.8 0 0 0.11 21.0905
0.8 0 0.2 0.11 21.0901
0.8 0 0.4 0.11 21.0905
0.8 0.2 0 0.11 21.0974
0.8 0.2 0.2 0.11 21.0973
0.8 0.2 0.4 0.11 21.0974
0.8 0.4 0 0.11 21.104
0.8 0.4 0.2 0.11 21.1039
0.8 0.4 0.4 0.11 21.104
0.8 0.6 0 0.11 21.1102
0.8 0.6 0.2 0.11 21.1102
0.8 0.6 0.4 0.11 21.1102
0.8 0.8 0 0.11 21.1161
0.8 0.8 0.2 0.11 21.1161
0.8 0.8 0.4 0.11 21.1161
0.8 1 0 0.11 21.1216
0.8 1 0.2 0.11 21.1216
0.8 1 0.4 0.11 21.1216
0.8 1.2 0 0.11 21.1269
0.8 1.2 0.2 0.11 21.1269
0.8 1.2 0.4 0.11 21.1269
0.8 1.4 0 0.11 21.1318
0.8 1.4 0.2 0.11 21.1318
0.8 1.4 0.4 0.11 21.1318
0.8 1.6 0 0.11 21.1365
0.8 1.6 0.2 0.11 21.1365
0.8 1.6 0.4 0.11 21.1365
0.8 1.8 0 0.11 21.1408
0.8 1.8 0.2 0.11 21.1408
0.8 1.8 0.4 0.11 21.1408
0.8 2 0 0.11 21.1449
0.8 2 0.2 0.11 21.1449
0.8 2 0.4 0.11 21.1449
0.8 2.2 0 0.11 21.1487
0.8 2.2 0.2 0.11 21.1487
0.8 2.2 0.4 0.11 21.1487
0.8 2.4 0 0.11 21.1522
0.8 2.4 0.2 0.11 21.1522
0.8 2.4 0.4 0.11 21.1522
0.8 2.6 0 0.11 21.1554
0.8 2.6 0.2 0.11 21.1554
0.8 2.6 0.4 0.11 21.1554
0.8 2.8 0 0.11 21.1584
0.8 2.8 0.2 0.11 21.1584
0.8 2.8 0.4 0.11 21.1584
0.8 3 0 0.11 21.1611
0.8 3 0.2 0.11 21.1611
0.8 3 0.4 0.11 21.1611
0.8 3.2 0 0.11 21.1636
0.8 3.2 0.2 0.11 21.1636
0.8 3.2 0.4 0.11 21.1636
0.8 3.4 0 0.11 21.1658
0.8 3.4 0.2 0.11 21.1658
0.8 3.4 0.4 0.11 21.1658
0.8 3.6 0 0.11 21.1678
0.8 3.6 0.2 0.11 21.1678
0.8 3.6 0.4 0.11 21.1678
0.8 3.8 0 0.11 21.1695
0.8 3.8 0.2 0.11 21.1695
0.8 3.8 0.4 0.11 21.1695
0.8 4 0 0.11 21.171
0.8 4 0.2 0.11 21.171
0.8 4 0.4 0.11 21.171
0.8 4.2 0 0.11 21.1723
0.8 4.2 0.2 0.11 21.1723
0.8 4.2 0.4 0.11 21.1723
0.8 4.4 0 0.11 21.1733
0.8 4.4 0.2 0.11 21.1733
0.8 4.4 0.4 0.11 21.1733
0.8 4.6 0 0.11 21.1741
0.8 4.6 0.2 0.11 21.1741
0.8 4.6 0.4 0.11 21.1741
0.8 4.8 0 0.11 21.1747
0.8 4.8 0.2 0.11 21.1747
0.8 4.8 0.4 0.11 21.1747
0.8 5 0 0.11 21.175
0.8 5 0.2 0.11 21.175
0.8 5 0.4 0.11 21.175
1 0 0 0.11 21.0986
1 0 0.2 0.11 21.0982
1 0 0.4 0.11 21.0986
1 0.2 0 0.11 21.1056
1 0.2 0.2 0.11 21.1055
1 0.2 0.4 0.11 21.1056
1 0.4 0 0.11 21.1122
1 0.4 0.2 0.11 21.1122
1 0.4 0.4 0.11 21.1122
1 0.6 0 0.11 21.1185
1 0.6 0.2 0.11 21.1185
1 0.6 0.4 0.11 21.1185
1 0.8 0 0.11 21.1245
1 0.8 0.2 0.11 21.1245
1 0.8 0.4 0.11 21.1245
1 1 0 0.11 21.1301
1 1 0.2 0.11 21.1301
1 1 0.4 0.11 21.1301
1 1.2 0 0.11 21.1354
1 1.2 0.2 0.11 21.1354
1 1.2 0.4 0.11 21.1354
1 1.4 0 0.11 21.1404
1 1.4 0.2 0.11 21.1404
1 1.4 0.4 0.11 21.1404
1 1.6 0 0.11 21.1451
1 1.6 0.2 0.11 21.1451
1 1.6 0.4 0.11 21.1451
1 1.8 0 0.11 21.1494
1 1.8 0.2 0.11 21.1494
1 1.8 0.4 0.11 21.1494
1 2 0 0.11 21.1535
1 2 0.2 0.11 21.1535
1 2 0.4 0.11 21.1535
1 2.2 0 0.11 21.1573
1 2.2 0.2 0.11 21.1573
1 2.2 0.4 0.11 21.1573
1 2.4 0 0.11 21.1608
1 2.4 0.2 0.11 21.1608
1 2.4 0.4 0.11 21.1608
1 2.6 0 0.11 21.1641
1 2.6 0.2 0.11 21.1641
1 2.6 0.4 0.11 21.1641
1 2.8 0 0.11 21.167
1 2.8 0.2 0.11 21.167
1 2.8 0.4 0.11 21.167
1 3 0 0.11 21.1697
1 3 0.2 0.11 21.1697
1 3 0.4 0.11 21.1697
1 3.2 0 0.11 21.1722
1 3.2 0.2 0.11 21.1722
1 3.2 0.4 0.11 21.1722
1 3.4 0 0.11 21.1744
1 3.4 0.2 0.11 21.1744
1 3.4 0.4 0.11 21.1744
1 3.6 0 0.11 21.1764
1 3.6 0.2 0.11 21.1764
1 3.6 0.4 0.11 21.1764
1 3.8 0 0.11 21.1781
1 3.8 0.2 0.11 21.1781
1 3.8 0.4 0.11 21.1781
1 4 0 0.11 21.1796
1 4 0.2 0.11 21.1796
1 4 0.4 0.11 21.1796
1 4.2 0 0.11 21.1808
1 4.2 0.2 0.11 21.1808
1 4.2 0.4 0.11 21.1808
1 4.4 0 0.11 21.1818
1 4.4 0.2 0.11 21.1818
1 4.4 0.4 0.11 21.1818
1 4.6 0 0.11 21.1826
1 4.6 0.2 0.11 21.1826
1 4.6 0.4 0.11 21.1826
1 4.8 0 0.11 21.1831
1 4.8 0.2 0.11 21.1831
1 4.8 0.4 0.11 21.1831
1 5 0 0.11 21.1834
1 5 0.2 0.11 21.1834
1 5 0.4 0.11 21.1834
1.2 0 0 0.11 21.1071
1.2 0 0.2 0.11 21.1067
1.2 0 0.4 0.11 21.1071
1.2 0.2 0 0.11 21.1142
1.2 0.2 0.2 0.11 21.1141
1.2 0.2 0.4 0.11 21.1142
1.2 0.4 0 0.11 21.1209
1.2 0.4 0.2 0.11 21.1209
1.2 0.4 0.4 0.11 21.1209
1.2 0.6 0 0.11 21.1273
1.2 0.6 0.2 0.11 21.1273
1.2 0.6 0.4 0.11 21.1273
1.2 0.8 0 0.11 21.1333
1.2 0.8 0.2 0.11 21.1333
1.2 0.8 0.4 0.11 21.1333
1.2 1 0 0.11 21.139
1.2 1 0.2 0.11 21.139
1.2 1 0.4 0.11 21.139
1.2 1.2 0 0.11 21.1443
1.2 1.2 0.2 0.11 21.1443
1.2 1.2 0.4 0.11 21.1443
1.2 1.4 0 0.11 21.1493
1.2 1.4 0.2 0.11 21.1493
1.2 1.4 0.4 0.11 21.1493
1.2 1.6 0 0.11 21.154
1.2 1.6 0.2 0.11 21.154
1.2 1.6 0.4 0.11 21.154
1.2 1.8 0 0.11 21.1584
1.2 1.8 0.2 0.11 21.1584
1.2 1.8 0.4 0.11 21.1584
1.2 2 0 0.11 21.1624
1.2 2 0.2 0.11 21.1624
1.2 2 0.4 0.11 21.1624
1.2 2.2 0 0.11 21.1662
1.2 2.2 0.2 0.11 21.1662
1.2 2.2 0.4 0.11 21.1662
1.2 2.4 0 0.11 21.1697
1.2 2.4 0.2 0.11 21.1697
1.2 2.4 0.4 0.11 21.1697
1.2 2.6 0 0.11 21.173
1.2 2.6 0.2 0.11 21.173
1.2 2.6 0.4 0.11 21.173
1.2 2.8 0 0.11 21.1759
1.2 2.8 0.2 0.11 21.1759
1.2 2.8 0.4 0.11 21.1759
1.2 3 0 0.11 21.1786
1.2 3 0.2 0.11 21.1786
1.2 3 0.4 0.11 21.1786
1.2 3.2 0 0.11 21.181
1.2 3.2 0.2 0.11 21.181
1.2 3.2 0.4 0.11 21.181
1.2 3.4 0 0.11 21.1832
1.2 3.4 0.2 0.11 21.1832
1.2 3.4 0.4 0.11 21.1832
1.2 3.6 0 0.11 21.1852
1.2 3.6 0.2 0.11 21.1852
1.2 3.6 0.4 0.11 21.1852
1.2 3.8 0 0.11 21.1869
1.2 3.8 0.2 0.11 21.1869
1.2 3.8 0.4 0.11 21.1869
1.2 4 0 0.11 21.1883
1.2 4 0.2 0.11 21.1883
1.2 4 0.4 0.11 21.1883
1.2 4.2 0 0.11 21.1896
1.2 4.2 0.2 0.11 21.1896
1.2 4.2 0.4 0.11 21.1896
1.2 4.4 0 0.11 21.1905
1.2 4.4 0.2 0.11 21.1905
1.2 4.4 0.4 0.11 21.1905
1.2 4.6 0 0.11 21.1913
1.2 4.6 0.2 0.11 21.1913
1.2 4.6 0.4 0.11 21.1913
1.2 4.8 0 0.11 21.1918
1.2 4.8 0.2 0.11 21.1918
1.2 4.8 0.4 0.11 21.1918
1.2 5 0 0.11 21.192
1.2 5 0.2 0.11 21.192
1.2 5 0.4 0.11 21.192
1.4 0 0 0.11 21.1161
1.4 0 0.2 0.11 21.1156
1.4 0 0.4 0.11 21.1161
1.4 0.2 0 0.11 21.1231
1.4 0.2 0.2 0.11 21.123
1.4 0.2 0.4 0.11 21.1231
1.4 0.4 0 0.11 21.1299
1.4 0.4 0.2 0.11 21.1299
1.4 0.4 0.4 0.11 21.1299
1.4 0.6 0 0.11 21.1364
1.4 0.6 0.2 0.11 21.1364
1.4 0.6 0.4 0.11 21.1364
1.4 0.8 0 0.11 21.1424
1.4 0.8 0.2 0.11 21.1424
1.4 0.8 0.4 0.11 21.1424
1.4 1 0 0.11 21.1481
1.4 1 0.2 0.11 21.1481
1.4 1 0.4 0.11 21.1481
1.4 1.2 0 0.11 21.1535
1.4 1.2 0.2 0.11 21.1535
1.4 1.2 0.4 0.11 21.1535
1.4 1.4 0 0.11 21.1585
1.4 1.4 0.2 0.11 21.1585
1.4 1.4 0.4 0.11 21.1585
1.4 1.6 0 0.11 21.1632
1.4 1.6 0.2 0.11 21.1632
1.4 1.6 0.4 0.11 21.1632
1.4 1.8 0 0.11 21.1676
1.4 1.8 0.2 0.11 21.1676
1.4 1.8 0.4 0.11 21.1676
1.4 2 0 0.11 21.1717
1.4 2 0.2 0.11 21.1717
1.4 2 0.4 0.11 21.1717
1.4 2.2 0 0.11 21.1754
1.4 2.2 0.2 0.11 21.1754
1.4 2.2 0.4 0.11 21.1754
1.4 2.4 0 0.11 21.1789
1.4 2.4 0.2 0.11 21.1789
1.4 2.4 0.4 0.11 21.1789
1.4 2.6 0 0.11 21.1821
1.4 2.6 0.2 0.11 21.1821
1.4 2.6 0.4 0.11 21.1821
1.4 2.8 0 0.11 21.1851
1.4 2.8 0.2 0.11 21.1851
1.4 2.8 0.4 0.11 21.1851
1.4 3 0 0.11 21.1877
1.4 3 0.2 0.11 21.1877
1.4 3 0.4 0.11 21.1877
1.4 3.2 0 0.11 21.1902
1.4 3.2 0.2 0.11 21.1902
1.4 3.2 0.4 0.11 21.1902
1.4 3.4 0 0.11 21.1923
1.4 3.4 0.2 0.11 21.1923
1.4 3.4 0.4 0.11 21.1923
1.4 3.6 0 0.11 21.1942
1.4 3.6 0.2 0.11 21.1942
1.4 3.6 0.4 0.11 21.1942
1.4 3.8 0 0.11 21.1959
1.4 3.8 0.2 0.11 21.1959
1.4 3.8 0.4 0.11 21.1959
1.4 4 0 0.11 21.1973
1.4 4 0.2 0.11 21.1973
1.4 4 0.4 0.11 21.1973
1.4 4.2 0 0.11 21.1985
1.4 4.2 0.2 0.11 21.1985
1.4 4.2 0.4 0.11 21.1985
1.4 4.4 0 0.11 21.1995
1.4 4.4 0.2 0.11 21.1995
1.4 4.4 0.4 0.11 21.1995
1.4 4.6 0 0.11 21.2002
1.4 4.6 0.2 0.11 21.2002
1.4 4.6 0.4 0.11 21.2002
1.4 4.8 0 0.11 21.2007
1.4 4.8 0.2 0.11 21.2007
1.4 4.8 0.4 0.11 21.2007
1.4 5 0 0.11 21.201
1.4 5 0.2 0.11 21.201
1.4 5 0.4 0.11 21.201
1.6 0 0 0.11 21.1254
1.6 0 0.2 0.11 21.1249
1.6 0 0.4 0.11 21.1254
1.6 0.2 0 0.11 21.1325
1.6 0.2 0.2 0.11 21.1324
1.6 0.2 0.4 0.11 21.1325
1.6 0.4 0 0.11 21.1393
1.6 0.4 0.2 0.11 21.1393
1.6 0.4 0.4 0.11 21.1393
1.6 0.6 0 0.11 21.1458
1.6 0.6 0.2 0.11 21.1458
1.6 0.6 0.4 0.11 21.1458
1.6 0.8 0 0.11 21.1519
1.6 0.8 0.2 0.11 21.1519
1.6 0.8 0.4 0.11 21.1519
1.6 1 0 0.11 21.1576
1.6 1 0.2 0.11 21.1576
1.6 1 0.4 0.11 21.1576
1.6 1.2 0 0.11 21.163
1.6 1.2 0.2 0.11 21.163
1.6 1.2 0.4 0.11 21.163
1.6 1.4 0 0.11 21.1681
1.6 1.4 0.2 0.11 21.1681
1.6 1.4 0.4 0.11 21.1681
1.6 1.6 0 0.11 21.1728
1.6 1.6 0.2 0.11 21.1728
1.6 1.6 0.4 0.11 21.1728
1.6 1.8 0 0.11 21.1771
1.6 1.8 0.2 0.11 21.1771
1.6 1.8 0.4 0.11 21.1771
1.6 2 0 0.11 21.1812
1.6 2 0.2 0.11 21.1812
1.6 2 0.4 0.11 21.1812
1.6 2.2 0 0.11 21.1849
1.6 2.2 0.2 0.11 21.1849
1.6 2.2 0.4 0.11 21.1849
1.6 2.4 0 0.11 21.1884
1.6 2.4 0.2 0.11 21.1884
1.6 2.4 0.4 0.11 21.1884
1.6 2.6 0 0.11 21.1916
1.6 2.6 0.2 0.11 21.1916
1.6 2.6 0.4 0.11 21.1916
1.6 2.8 0 0.11 21.1945
1.6 2.8 0.2 0.11 21.1945
1.6 2.8 0.4 0.11 21.1945
1.6 3 0 0.11 21.1971
1.6 3 0.2 0.11 21.1971
1.6 3 0.4 0.11 21.1971
1.6 3.2 0 0.11 21.1995
1.6 3.2 0.2 0.11 21.1995
1.6 3.2 0.4 0.11 21.1995
1.6 3.4 0 0.11 21.2016
1.6 3.4 0.2 0.11 21.2016
1.6 3.4 0.4 0.11 21.2016
1.6 3.6 0 0.11 21.2035
1.6 3.6 0.2 0.11 21.2035
1.6 3.6 0.4 0.11 21.2035
1.6 3.8 0 0.11 21.2052
1.6 3.8 0.2 0.11 21.2052
1.6 3.8 0.4 0.11 21.2052
1.6 4 0 0.11 21.2066
1.6 4 0.2 0.11 21.2066
1.6 4 0.4 0.11 21.2066
1.6 4.2 0 0.11 21.2078
1.6 4.2 0.2 0.11 21.2078
1.6 4.2 0.4 0.11 21.2078
1.6 4.4 0 0.11 21.2087
1.6 4.4 0.2 0.11 21.2087
1.6 4.4 0.4 0.11 21.2087
1.6 4.6 0 0.11 21.2094
1.6 4.6 0.2 0.11 21.2094
1.6 4.6 0.4 0.11 21.2094
1.6 4.8 0 0.11 21.2099
1.6 4.8 0.2 0.11 21.2099
1.6 4.8 0.4 0.11 21.2099
1.6 5 0 0.11 21.2101
1.6 5 0.2 0.11 21.2101
1.6 5 0.4 0.11 21.2101
1.8 0 0 0.11 21.135
1.8 0 0.2 0.11 21.1346
1.8 0 0.4 0.11 21.135
1.8 0.2 0 0.11 21.1422
1.8 0.2 0.2 0.11 21.1421
1.8 0.2 0.4 0.11 21.1422
1.8 0.4 0 0.11 21.1491
1.8 0.4 0.2 0.11 21.1491
1.8 0.4 0.4 0.11 21.1491
1.8 0.6 0 0.11 21.1556
1.8 0.6 0.2 0.11 21.1556
1.8 0.6 0.4 0.11 21.1556
1.8 0.8 0 0.11 21.1618
1.8 0.8 0.2 0.11 21.1618
1.8 0.8 0.4 0.11 21.1618
1.8 1 0 0.11 21.1675
1.8 1 0.2 0.11 21.1675
1.8 1 0.4 0.11 21.1675
1.8 1.2 0 0.11 21.1729
1.8 1.2 0.2 0.11 21.1729
1.8 1.2 0.4 0.11 21.1729
1.8 1.4 0 0.11 21.1779
1.8 1.4 0.2 0.11 21.1779
1.8 1.4 0.4 0.11 21.1779
1.8 1.6 0 0.11 21.1826
1.8 1.6 0.2 0.11 21.1826
1.8 1.6 0.4 0.11 21.1826
1.8 1.8 0 0.11 21.187
1.8 1.8 0.2 0.11 21.187
1.8 1.8 0.4 0.11 21.187
1.8 2 0 0.11 21.191
1.8 2 0.2 0.11 21.191
1.8 2 0.4 0.11 21.191
1.8 2.2 0 0.11 21.1947
1.8 2.2 0.2 0.11 21.1947
1.8 2.2 0.4 0.11 21.1947
1.8 2.4 0 0.11 21.1982
1.8 2.4 0.2 0.11 21.1982
1.8 2.4 0.4 0.11 21.1982
1.8 2.6 0 0.11 21.2013
1.8 2.6 0.2 0.11 21.2013
1.8 2.6 0.4 0.11 21.2013
1.8 2.8 0 0.11 21.2042
1.8 2.8 0.2 0.11 21.2042
1.8 2.8 0.4 0.11 21.2042
1.8 3 0 0.11 21.2068
1.8 3 0.2 0.11 21.2068
1.8 3 0.4 0.11 21.2068
1.8 3.2 0 0.11 21.2091
1.8 3.2 0.2 0.11 21.2091
1.8 3.2 0.4 0.11 21.2091
1.8 3.4 0 0.11 21.2112
1.8 3.4 0.2 0.11 21.2112
1.8 3.4 0.4 0.11 21.2112
1.8 3.6 0 0.11 21.2131
1.8 3.6 0.2 0.11 21.2131
1.8 3.6 0.4 0.11 21.2131
1.8 3.8 0 0.11 21.2147
1.8 3.8 0.2 0.11 21.2147
1.8 3.8 0.4 0.11 21.2147
1.8 4 0 0.11 21.2161
1.8 4 0.2 0.11 21.2161
1.8 4 0.4 0.11 21.2161
1.8 4.2 0 0.11 21.2172
1.8 4.2 0.2 0.11 21.2172
1.8 4.2 0.4 0.11 21.2172
1.8 4.4 0 0.11 21.2181
1.8 4.4 0.2 0.11 21.2181
1.8 4.4 0.4 0.11 21.2181
1.8 4.6 0 0.11 21.2188
1.8 4.6 0.2 0.11 21.2188
1.8 4.6 0.4 0.11 21.2188
1.8 4.8 0 0.11 21.2193
1.8 4.8 0.2 0.11 21.2193
1.8 4.8 0.4 0.11 21.2193
1.8 5 0 0.11 21.2195
1.8 5 0.2 0.11 21.2195
1.8 5 0.4 0.11 21.2195
2 0 0 0.11 21.1451
2 0 0.2 0.11 21.1447
2 0 0.4 0.11 21.1451
2 0.2 0 0.11 21.1524
2 0.2 0.2 0.11 21.1523
2 0.2 0.4 0.11 21.1524
2 0.4 0 0.11 21.1593
2 0.4 0.2 0.11 21.1593
2 0.4 0.4 0.11 21.1593
2 0.6 0 0.11 21.1659
2 0.6 0.2 0.11 21.1659
2 0.6 0.4 0.11 21.1659
2 0.8 0 0.11 21.172
2 0.8 0.2 0.11 21.172
2 0.8 0.4 0.11 21.172
2 1 0 0.11 21.1778
2 1 0.2 0.11 21.1778
2 1 0.4 0.11 21.1778
2 1.2 0 0.11 21.1831
2 1.2 0.2 0.11 21.1831
2 1.2 0.4 0.11 21.1831
2 1.4 0 0.11 21.1882
2 1.4 0.2 0.11 21.1882
2 1.4 0.4 0.11 21.1882
2 1.6 0 0.11 21.1928
2 1.6 0.2 0.11 21.1928
2 1.6 0.4 0.11 21.1928
2 1.8 0 0.11 21.1971
2 1.8 0.2 0.11 21.1971
2 1.8 0.4 0.11 21.1971
2 2 0 0.11 21.2011
2 2 0.2 0.11 21.2011
2 2 0.4 0.11 21.2011
2 2.2 0 0.11 21.2048
2 2.2 0.2 0.11 21.2048
2 2.2 0.4 0.11 21.2048
2 2.4 0 0.11 21.2082
2 2.4 0.2 0.11 21.2082
2 2.4 0.4 0.11 21.2082
2 2.6 0 0.11 21.2113
2 2.6 0.2 0.11 21.2113
2 2.6 0.4 0.11 21.2113
2 2.8 0 0.11 21.2141
2 2.8 0.2 0.11 21.2141
2 2.8 0.4 0.11 21.2141
2 3 0 0.11 21.2167
2 3 0.2 0.11 21.2167
2 3 0.4 0.11 21.2167
2 3.2 0 0.11 21.219
2 3.2 0.2 0.11 21.219
2 3.2 0.4 0.11 21.219
2 3.4 0 0.11 21.221
2 3.4 0.2 0.11 21.221
2 3.4 0.4 0.11 21.221
2 3.6 0 0.11 21.2229
2 3.6 0.2 0.11 21.2229
2 3.6 0.4 0.11 21.2229
2 3.8 0 0.11 21.2244
2 3.8 0.2 0.11 21.2244
2 3.8 0.4 0.11 21.2244
2 4 0 0.11 21.2258
2 4 0.2 0.11 21.2258
2 4 0.4 0.11 21.2258
2 4.2 0 0.11 21.2269
2 4.2 0.2 0.11 21.2269
2 4.2 0.4 0.11 21.2269
2 4.4 0 0.11 21.2278
2 4.4 0.2 0.11 21.2278
2 4.4 0.4 0.11 21.2278
2 4.6 0 0.11 21.2285
2 4.6 0.2 0.11 21.2285
2 4.6 0.4 0.11 21.2285
2 4.8 0 0.11 21.2289
2 4.8 0.2 0.11 21.2289
2 4.8 0.4 0.11 21.2289
2 5 0 0.11 21.2291
2 5 0.2 0.11 21.2291
2 5 0.4 0.11 21.2291
2.2 0 0 0.11 21.1557
2.2 0 0.2 0.11 21.1552
2.2 0 0.4 0.11 21.1557
2.2 0.2 0 0.11 21.163
2.2 0.2 0.2 0.11 21.1629
2.2 0.2 0.4 0.11 21.163
2.2 0.4 0 0.11 21.1699
2.2 0.4 0.2 0.11 21.1699
2.2 0.4 0.4 0.11 21.1699
2.2 0.6 0 0.11 21.1765
2.2 0.6 0.2 0.11 21.1765
2.2 0.6 0.4 0.11 21.1765
2.2 0.8 0 0.11 21.1826
2.2 0.8 0.2 0.11 21.1826
2.2 0.8 0.4 0.11 21.1826
2.2 1 0 0.11 21.1884
2.2 1 0.2 0.11 21.1884
2.2 1 0.4 0.11 21.1884
2.2 1.2 0 0.11 21.1937
2.2 1.2 0.2 0.11 21.1937
2.2 1.2 0.4 0.11 21.1937
2.2 1.4 0 0.11 21.1987
2.2 1.4 0.2 0.11 21.1987
2.2 1.4 0.4 0.11 21.1987
2.2 1.6 0 0.11 21.2033
2.2 1.6 0.2 0.11 21.2033
2.2 1.6 0.4 0.11 21.2033
2.2 1.8 0 0.11 21.2076
2.2 1.8 0.2 0.11 21.2076
2.2 1.8 0.4 0.11 21.2076
2.2 2 0 0.11 21.2116
2.2 2 0.2 0.11 21.2116
2.2 2 0.4 0.11 21.2116
2.2 2.2 0 0.11 21.2152
2.2 2.2 0.2 0.11 21.2152
2.2 2.2 0.4 0.11 21.2152
2.2 2.4 0 0.11 21.2185
2.2 2.4 0.2 0.11 21.2185
2.2 2.4 0.4 0.11 21.2185
2.2 2.6 0 0.11 21.2216
2.2 2.6 0.2 0.11 21.2216
2.2 2.6 0.4 0.11 21.2216
2.2 2.8 0 0.11 21.2243
2.2 2.8 0.2 0.11 21.2243
2.2 2.8 0.4 0.11 21.2243
2.2 3 0 0.11 21.2268
2.2 3 0.2 0.11 21.2268
2.2 3 0.4 0.11 21.2268
2.2 3.2 0 0.11 21.2291
2.2 3.2 0.2 0.11 21.2291
2.2 3.2 0.4 0.11 21.2291
2.2 3.4 0 0.11 21.2311
2.2 3.4 0.2 0.11 21.2311
2.2 3.4 0.4 0.11 21.2311
2.2 3.6 0 0.11 21.2329
2.2 3.6 0.2 0.11 21.2329
2.2 3.6 0.4 0.11 21.2329
2.2 3.8 0 0.11 21.2344
2.2 3.8 0.2 0.11 21.2344
2.2 3.8 0.4 0.11 21.2344
2.2 4 0 0.11 21.2357
2.2 4 0.2 0.11 21.2357
2.2 4 0.4 0.11 21.2357
2.2 4.2 0 0.11 21.2368
2.2 4.2 0.2 0.11 21.2368
2.2 4.2 0.4 0.11 21.2368
2.2 4.4 0 0.11 21.2377
2.2 4.4 0.2 0.11 21.2377
2.2 4.4 0.4 0.11 21.2377
2.2 4.6 0 0.11 21.2383
2.2 4.6 0.2 0.11 21.2383
2.2 4.6 0.4 0.11 21.2383
2.2 4.8 0 0.11 21.2388
2.2 4.8 0.2 0.11 21.2388
2.2 4.8 0.4 0.11 21.2388
2.2 5 0 0.11 21.239
2.2 5 0.2 0.11 21.239
2.2 5 0.4 0.11 21.239
2.4 0 0 0.11 21.1666
2.4 0 0.2 0.11 21.1661
2.4 0 0.4 0.11 21.1666
2.4 0.2 0 0.11 21.174
2.4 0.2 0.2 0.11 21.1739
2.4 0.2 0.4 0.11 21.174
2.4 0.4 0 0.11 21.181
2.4 0.4 0.2 0.11 21.1809
2.4 0.4 0.4 0.11 21.181
2.4 0.6 0 0.11 21.1875
2.4 0.6 0.2 0.11 21.1875
2.4 0.6 0.4 0.11 21.1875
2.4 0.8 0 0.11 21.1937
2.4 0.8 0.2 0.11 21.1937
2.4 0.8 0.4 0.11 21.1937
2.4 1 0 0.11 21.1994
2.4 1 0.2 0.11 21.1994
2.4 1 0.4 0.11 21.1994
2.4 1.2 0 0.11 21.2047
2.4 1.2 0.2 0.11 21.2047
2.4 1.2 0.4 0.11 21.2047
2.4 1.4 0 0.11 21.2097
2.4 1.4 0.2 0.11 21.2097
2.4 1.4 0.4 0.11 21.2097
2.4 1.6 0 0.11 21.2142
2.4 1.6 0.2 0.11 21.2142
2.4 1.6 0.4 0.11 21.2142
2.4 1.8 0 0.11 21.2184
2.4 1.8 0.2 0.11 21.2184
2.4 1.8 0.4 0.11 21.2184
2.4 2 0 0.11 21.2223
2.4 2 0.2 0.11 21.2223
2.4 2 0.4 0.11 21.2223
2.4 2.2 0 0.11 21.2259
2.4 2.2 0.2 0.11 21.2259
2.4 2.2 0.4 0.11 21.2259
2.4 2.4 0 0.11 21.2291
2.4 2.4 0.2 0.11 21.2291
2.4 2.4 0.4 0.11 21.2291
2.4 2.6 0 0.11 21.2321
2.4 2.6 0.2 0.11 21.2321
2.4 2.6 0.4 0.11 21.2321
2.4 2.8 0 0.11 21.2348
2.4 2.8 0.2 0.11 21.2348
2.4 2.8 0.4 0.11 21.2348
2.4 3 0 0.11 21.2373
2.4 3 0.2 0.11 21.2373
2.4 3 0.4 0.11 21.2373
2.4 3.2 0 0.11 21.2395
2.4 3.2 0.2 0.11 21.2395
2.4 3.2 0.4 0.11 21.2395
2.4 3.4 0 0.11 21.2414
2.4 3.4 0.2 0.11 21.2414
2.4 3.4 0.4 0.11 21.2414
2.4 3.6 0 0.11 21.2431
2.4 3.6 0.2 0.11 21.2431
2.4 3.6 0.4 0.11 21.2431
2.4 3.8 0 0.11 21.2446
2.4 3.8 0.2 0.11 21.2446
2.4 3.8 0.4 0.11 21.2446
2.4 4 0 0.11 21.2459
2.4 4 0.2 0.11 21.2459
2.4 4 0.4 0.11 21.2459
2.4 4.2 0 0.11 21.247
2.4 4.2 0.2 0.11 21.247
2.4 4.2 0.4 0.11 21.247
2.4 4.4 0 0.11 21.2478
2.4 4.4 0.2 0.11 21.2478
2.4 4.4 0.4 0.11 21.2478
2.4 4.6 0 0.11 21.2484
2.4 4.6 0.2 0.11 21.2484
2.4 4.6 0.4 0.11 21.2484
2.4 4.8 0 0.11 21.2488
2.4 4.8 0.2 0.11 21.2488
2.4 4.8 0.4 0.11 21.2488
2.4 5 0 0.11 21.249
2.4 5 0.2 0.11 21.249
2.4 5 0.4 0.11 21.249
2.6 0 0 0.11 21.178
2.6 0 0.2 0.11 21.1775
2.6 0 0.4 0.11 21.178
2.6 0.2 0 0.11 21.1854
2.6 0.2 0.2 0.11 21.1853
2.6 0.2 0.4 0.11 21.1854
2.6 0.4 0 0.11 21.1924
2.6 0.4 0.2 0.11 21.1924
2.6 0.4 0.4 0.11 21.1924
2.6 0.6 0 0.11 21.199
2.6 0.6 0.2 0.11 21.199
2.6 0.6 0.4 0.11 21.199
2.6 0.8 0 0.11 21.2051
2.6 0.8 0.2 0.11 21.2051
2.6 0.8 0.4 0.11 21.2051
2.6 1 0 0.11 21.2108
2.6 1 0.2 0.11 21.2108
2.6 1 0.4 0.11 21.2108
2.6 1.2 0 0.11 21.2161
2.6 1.2 0.2 0.11 21.2161
2.6 1.2 0.4 0.11 21.2161
2.6 1.4 0 0.11 21.221
2.6 1.4 0.2 0.11 21.221
2.6 1.4 0.4 0.11 21.221
2.6 1.6 0 0.11 21.2255
2.6 1.6 0.2 0.11 21.2255
2.6 1.6 0.4 0.11 21.2255
2.6 1.8 0 0.11 21.2296
2.6 1.8 0.2 0.11 21.2296
2.6 1.8 0.4 0.11 21.2296
2.6 2 0 0.11 21.2334
2.6 2 0.2 0.11 21.2334
2.6 2 0.4 0.11 21.2334
2.6 2.2 0 0.11 21.2369
2.6 2.2 0.2 0.11 21.2369
2.6 2.2 0.4 0.11 21.2369
2.6 2.4 0 0.11 21.24
2.6 2.4 0.2 0.11 21.24
2.6 2.4 0.4 0.11 21.24
2.6 2.6 0 0.11 21.2429
2.6 2.6 0.2 0.11 21.2429
2.6 2.6 0.4 0.11 21.2429
2.6 2.8 0 0.11 21.2456
2.6 2.8 0.2 0.11 21.2456
2.6 2.8 0.4 0.11 21.2456
2.6 3 0 0.11 21.2479
2.6 3 0.2 0.11 21.2479
2.6 3 0.4 0.11 21.2479
2.6 3.2 0 0.11 21.2501
2.6 3.2 0.2 0.11 21.2501
2.6 3.2 0.4 0.11 21.2501
2.6 3.4 0 0.11 21.2519
2.6 3.4 0.2 0.11 21.2519
2.6 3.4 0.4 0.11 21.2519
2.6 3.6 0 0.11 21.2536
2.6 3.6 0.2 0.11 21.2536
2.6 3.6 0.4 0.11 21.2536
2.6 3.8 0 0.11 21.2551
2.6 3.8 0.2 0.11 21.2551
2.6 3.8 0.4 0.11 21.2551
2.6 4 0 0.11 21.2563
2.6 4 0.2 0.11 21.2563
2.6 4 0.4 0.11 21.2563
2.6 4.2 0 0.11 21.2573
2.6 4.2 0.2 0.11 21.2573
2.6 4.2 0.4 0.11 21.2573
2.6 4.4 0 0.11 21.2581
2.6 4.4 0.2 0.11 21.2581
2.6 4.4 0.4 0.11 21.2581
2.6 4.6 0 0.11 21.2587
2.6 4.6 0.2 0.11 21.2587
2.6 4.6 0.4 0.11 21.2587
2.6 4.8 0 0.11 21.2591
2.6 4.8 0.2 0.11 21.2591
2.6 4.8 0.4 0.11 21.2591
2.6 5 0 0.11 21.2593
2.6 5 0.2 0.11 21.2593
2.6 5 0.4 0.11 21.2593
2.8 0 0 0.11 21.1899
2.8 0 0.2 0.11 21.1894
2.8 0 0.4 0.11 21.1899
2.8 0.2 0 0.11 21.1973
2.8 0.2 0.2 0.11 21.1972
2.8 0.2 0.4 0.11 21.1973
2.8 0.4 0 0.11 21.2044
2.8 0.4 0.2 0.11 21.2044
2.8 0.4 0.4 0.11 21.2044
2.8 0.6 0 0.11 21.2109
2.8 0.6 0.2 0.11 21.2109
2.8 0.6 0.4 0.11 21.211
2.8 0.8 0 0.11 21.217
2.8 0.8 0.2 0.11 21.217
2.8 0.8 0.4 0.11 21.217
2.8 1 0 0.11 21.2227
2.8 1 0.2 0.11 21.2227
2.8 1 0.4 0.11 21.2227
2.8 1.2 0 0.11 21.2279
2.8 1.2 0.2 0.11 21.2279
2.8 1.2 0.4 0.11 21.2279
2.8 1.4 0 0.11 21.2326
2.8 1.4 0.2 0.11 21.2326
2.8 1.4 0.4 0.11 21.2326
2.8 1.6 0 0.11 21.237
2.8 1.6 0.2 0.11 21.237
2.8 1.6 0.4 0.11 21.237
2.8 1.8 0 0.11 21.2411
2.8 1.8 0.2 0.11 21.2411
2.8 1.8 0.4 0.11 21.2411
2.8 2 0 0.11 21.2448
2.8 2 0.2 0.11 21.2448
2.8 2 0.4 0.11 21.2448
2.8 2.2 0 0.11 21.2481
2.8 2.2 0.2 0.11 21.2481
2.8 2.2 0.4 0.11 21.2481
2.8 2.4 0 0.11 21.2512
2.8 2.4 0.2 0.11 21.2512
2.8 2.4 0.4 0.11 21.2512
2.8 2.6 0 0.11 21.254
2.8 2.6 0.2 0.11 21.254
2.8 2.6 0.4 0.11 21.254
2.8 2.8 0 0.11 21.2566
2.8 2.8 0.2 0.11 21.2566
2.8 2.8 0.4 0.11 21.2566
2.8 3 0 0.11 21.2588
2.8 3 0.2 0.11 21.2588
2.8 3 0.4 0.11 21.2588
2.8 3.2 0 0.11 21.2609
2.8 3.2 0.2 0.11 21.2609
2.8 3.2 0.4 0.11 21.2609
2.8 3.4 0 0.11 21.2627
2.8 3.4 0.2 0.11 21.2627
2.8 3.4 0.4 0.11 21.2627
2.8 3.6 0 0.11 21.2643
2.8 3.6 0.2 0.11 21.2643
2.8 3.6 0.4 0.11 21.2643
2.8 3.8 0 0.11 21.2657
2.8 3.8 0.2 0.11 21.2657
2.8 3.8 0.4 0.11 21.2657
2.8 4 0 0.11 21.2669
2.8 4 0.2 0.11 21.2669
2.8 4 0.4 0.11 21.2669
2.8 4.2 0 0.11 21.2679
2.8 4.2 0.2 0.11 21.2679
2.8 4.2 0.4 0.11 21.2679
2.8 4.4 0 0.11 21.2686
2.8 4.4 0.2 0.11 21.2686
2.8 4.4 0.4 0.11 21.2686
2.8 4.6 0 0.11 21.2692
2.8 4.6 0.2 0.11 21.2692
2.8 4.6 0.4 0.11 21.2692
2.8 4.8 0 0.11 21.2696
2.8 4.8 0.2 0.11 21.2696
2.8 4.8 0.4 0.11 21.2696
2.8 5 0 0.11 21.2698
2.8 5 0.2 0.11 21.2698
2.8 5 0.4 0.11 21.2698
3 0 0 0.11 21.2023
3 0 0.2 0.11 21.2018
3 0 0.4 0.11 21.2023
3 0.2 0 0.11 21.2098
3 0.2 0.2 0.11 21.2097
3 0.2 0.4 0.11 21.2098
3 0.4 0 0.11 21.2168
3 0.4 0.2 0.11 21.2168
3 0.4 0.4 0.11 21.2168
3 0.6 0 0.11 21.2234
3 0.6 0.2 0.11 21.2234
3 0.6 0.4 0.11 21.2234
3 0.8 0 0.11 21.2294
3 0.8 0.2 0.11 21.2294
3 0.8 0.4 0.11 21.2294
3 1 0 0.11 21.2349
3 1 0.2 0.11 21.2349
3 1 0.4 0.11 21.2349
3 1.2 0 0.11 21.24
3 1.2 0.2 0.11 21.24
3 1.2 0.4 0.11 21.24
3 1.4 0 0.11 21.2447
3 1.4 0.2 0.11 21.2447
3 1.4 0.4 0.11 21.2447
3 1.6 0 0.11 21.249
3 1.6 0.2 0.11 21.249
3 1.6 0.4 0.11 21.249
3 1.8 0 0.11 21.2529
3 1.8 0.2 0.11 21.2529
3 1.8 0.4 0.11 21.2529
3 2 0 0.11 21.2565
3 2 0.2 0.11 21.2565
3 2 0.4 0.11 21.2565
3 2.2 0 0.11 21.2597
3 2.2 0.2 0.11 21.2597
3 2.2 0.4 0.11 21.2597
3 2.4 0 0.11 21.2627
3 2.4 0.2 0.11 21.2627
3 2.4 0.4 0.11 21.2627
3 2.6 0 0.11 21.2654
3 2.6 0.2 0.11 21.2654
3 2.6 0.4 0.11 21.2654
3 2.8 0 0.11 21.2678
3 2.8 0.2 0.11 21.2678
3 2.8 0.4 0.11 21.2678
3 3 0 0.11 21.27
3 3 0.2 0.11 21.27
3 3 0.4 0.11 21.27
3 3.2 0 0.11 21.2719
3 3.2 0.2 0.11 21.2719
3 3.2 0.4 0.11 21.2719
3 3.4 0 0.11 21.2737
3 3.4 0.2 0.11 21.2737
3 3.4 0.4 0.11 21.2737
3 3.6 0 0.11 21.2752
3 3.6 0.2 0.11 21.2752
3 3.6 0.4 0.11 21.2752
3 3.8 0 0.11 21.2765
3 3.8 0.2 0.11 21.2765
3 3.8 0.4 0.11 21.2765
3 4 0 0.11 21.2777
3 4 0.2 0.11 21.2777
3 4 0.4 0.11 21.2777
3 4.2 0 0.11 21.2786
3 4.2 0.2 0.11 21.2786
3 4.2 0.4 0.11 21.2786
3 4.4 0 0.11 21.2794
3 4.4 0.2 0.11 21.2794
3 4.4 0.4 0.11 21.2794
3 4.6 0 0.11 21.2799
3 4.6 0.2 0.11 21.2799
3 4.6 0.4 0.11 21.2799
3 4.8 0 0.11 21.2803
3 4.8 0.2 0.11 21.2803
3 4.8 0.4 0.11 21.2803
3 5 0 0.11 21.2805
3 5 0.2 0.11 21.2805
3 5 0.4 0.11 21.2805
3.2 0 0 0.11 21.2152
3.2 0 0.2 0.11 21.2147
3.2 0 0.4 0.11 21.2152
3.2 0.2 0 0.11 21.2228
3.2 0.2 0.2 0.11 21.2227
3.2 0.2 0.4 0.11 21.2228
3.2 0.4 0 0.11 21.2298
3.2 0.4 0.2 0.11 21.2298
3.2 0.4 0.4 0.11 21.2298
3.2 0.6 0 0.11 21.2363
3.2 0.6 0.2 0.11 21.2363
3.2 0.6 0.4 0.11 21.2363
3.2 0.8 0 0.11 21.2422
3.2 0.8 0.2 0.11 21.2422
3.2 0.8 0.4 0.11 21.2422
3.2 1 0 0.11 21.2477
3.2 1 0.2 0.11 21.2477
3.2 1 0.4 0.11 21.2477
3.2 1.2 0 0.11 21.2526
3.2 1.2 0.2 0.11 21.2526
3.2 1.2 0.4 0.11 21.2526
3.2 1.4 0 0.11 21.2572
3.2 1.4 0.2 0.11 21.2572
3.2 1.4 0.4 0.11 21.2572
3.2 1.6 0 0.11 21.2613
3.2 1.6 0.2 0.11 21.2613
3.2 1.6 0.4 0.11 21.2613
3.2 1.8 0 0.11 21.2651
3.2 1.8 0.2 0.11 21.2651
3.2 1.8 0.4 0.11 21.2651
3.2 2 0 0.11 21.2685
3.2 2 0.2 0.11 21.2685
3.2 2 0.4 0.11 21.2685
3.2 2.2 0 0.11 21.2716
3.2 2.2 0.2 0.11 21.2716
3.2 2.2 0.4 0.11 21.2716
3.2 2.4 0 0.11 21.2744
3.2 2.4 0.2 0.11 21.2744
3.2 2.4 0.4 0.11 21.2744
3.2 2.6 0 0.11 21.277
3.2 2.6 0.2 0.11 21.277
3.2 2.6 0.4 0.11 21.277
3.2 2.8 0 0.11 21.2793
3.2 2.8 0.2 0.11 21.2793
3.2 2.8 0.4 0.11 21.2793
3.2 3 0 0.11 21.2814
3.2 3 0.2 0.11 21.2814
3.2 3 0.4 0.11 21.2814
3.2 3.2 0 0.11 21.2832
3.2 3.2 0.2 0.11 21.2832
3.2 3.2 0.4 0.11 21.2832
3.2 3.4 0 0.11 21.2849
3.2 3.4 0.2 0.11 21.2849
3.2 3.4 0.4 0.11 21.2849
3.2 3.6 0 0.11 21.2863
3.2 3.6 0.2 0.11 21.2863
3.2 3.6 0.4 0.11 21.2863
3.2 3.8 0 0.11 21.2876
3.2 3.8 0.2 0.11 21.2876
3.2 3.8 0.4 0.11 21.2876
3.2 4 0 0.11 21.2887
3.2 4 0.2 0.11 21.2887
3.2 4 0.4 0.11 21.2887
3.2 4.2 0 0.11 21.2895
3.2 4.2 0.2 0.11 21.2895
3.2 4.2 0.4 0.11 21.2895
3.2 4.4 0 0.11 21.2903
3.2 4.4 0.2 0.11 21.2903
3.2 4.4 0.4 0.11 21.2903
3.2 4.6 0 0.11 21.2908
3.2 4.6 0.2 0.11 21.2908
3.2 4.6 0.4 0.11 21.2908
3.2 4.8 0 0.11 21.2911
3.2 4.8 0.2 0.11 21.2911
3.2 4.8 0.4 0.11 21.2911
3.2 5 0 0.11 21.2913
3.2 5 0.2 0.11 21.2913
3.2 5 0.4 0.11 21.2913
3.4 0 0 0.11 21.2288
3.4 0 0.2 0.11 21.2283
3.4 0 0.4 0.11 21.2288
3.4 0.2 0 0.11 21.2363
3.4 0.2 0.2 0.11 21.2362
3.4 0.2 0.4 0.11 21.2363
3.4 0.4 0 0.11 21.2434
3.4 0.4 0.2 0.11 21.2433
3.4 0.4 0.4 0.11 21.2434
3.4 0.6 0 0.11 21.2498
3.4 0.6 0.2 0.11 21.2498
3.4 0.6 0.4 0.11 21.2498
3.4 0.8 0 0.11 21.2556
3.4 0.8 0.2 0.11 21.2556
3.4 0.8 0.4 0.11 21.2556
3.4 1 0 0.11 21.2609
3.4 1 0.2 0.11 21.2609
3.4 1 0.4 0.11 21.2609
3.4 1.2 0 0.11 21.2657
3.4 1.2 0.2 0.11 21.2657
3.4 1.2 0.4 0.11 21.2657
3.4 1.4 0 0.11 21.27
3.4 1.4 0.2 0.11 21.27
3.4 1.4 0.4 0.11 21.27
3.4 1.6 0 0.11 21.274
3.4 1.6 0.2 0.11 21.274
3.4 1.6 0.4 0.11 21.274
3.4 1.8 0 0.11 21.2776
3.4 1.8 0.2 0.11 21.2776
3.4 1.8 0.4 0.11 21.2776
3.4 2 0 0.11 21.2808
3.4 2 0.2 0.11 21.2808
3.4 2 0.4 0.11 21.2808
3.4 2.2 0 0.11 21.2838
3.4 2.2 0.2 0.11 21.2838
3.4 2.2 0.4 0.11 21.2838
3.4 2.4 0 0.11 21.2864
3.4 2.4 0.2 0.11 21.2864
3.4 2.4 0.4 0.11 21.2864
3.4 2.6 0 0.11 21.2888
3.4 2.6 0.2 0.11 21.2888
3.4 2.6 0.4 0.11 21.2888
3.4 2.8 0 0.11 21.291
3.4 2.8 0.2 0.11 21.291
3.4 2.8 0.4 0.11 21.291
3.4 3 0 0.11 21.293
3.4 3 0.2 0.11 21.293
3.4 3 0.4 0.11 21.293
3.4 3.2 0 0.11 21.2947
3.4 3.2 0.2 0.11 21.2947
3.4 3.2 0.4 0.11 21.2947
3.4 3.4 0 0.11 21.2963
3.4 3.4 0.2 0.11 21.2963
3.4 3.4 0.4 0.11 21.2963
3.4 3.6 0 0.11 21.2976
3.4 3.6 0.2 0.11 21.2976
3.4 3.6 0.4 0.11 21.2976
3.4 3.8 0 0.11 21.2988
3.4 3.8 0.2 0.11 21.2988
3.4 3.8 0.4 0.11 21.2988
3.4 4 0 0.11 21.2998
3.4 4 0.2 0.11 21.2998
3.4 4 0.4 0.11 21.2998
3.4 4.2 0 0.11 21.3007
3.4 4.2 0.2 0.11 21.3007
3.4 4.2 0.4 0.11 21.3007
3.4 4.4 0 0.11 21.3013
3.4 4.4 0.2 0.11 21.3013
3.4 4.4 0.4 0.11 21.3013
3.4 4.6 0 0.11 21.3018
3.4 4.6 0.2 0.11 21.3018
3.4 4.6 0.4 0.11 21.3018
3.4 4.8 0 0.11 21.3022
3.4 4.8 0.2 0.11 21.3022
3.4 4.8 0.4 0.11 21.3022
3.4 5 0 0.11 21.3024
3.4 5 0.2 0.11 21.3024
3.4 5 0.4 0.11 21.3024
3.6 0 0 0.11 21.243
3.6 0 0.2 0.11 21.2425
3.6 0 0.4 0.11 21.243
3.6 0.2 0 0.11 21.2506
3.6 0.2 0.2 0.11 21.2505
3.6 0.2 0.4 0.11 21.2506
3.6 0.4 0 0.11 21.2575
3.6 0.4 0.2 0.11 21.2575
3.6 0.4 0.4 0.11 21.2575
3.6 0.6 0 0.11 21.2638
3.6 0.6 0.2 0.11 21.2638
3.6 0.6 0.4 0.11 21.2638
3.6 0.8 0 0.11 21.2695
3.6 0.8 0.2 0.11 21.2695
3.6 0.8 0.4 0.11 21.2695
3.6 1 0 0.11 21.2746
3.6 1 0.2 0.11 21.2746
3.6 1 0.4 0.11 21.2746
3.6 1.2 0 0.11 21.2792
3.6 1.2 0.2 0.11 21.2792
3.6 1.2 0.4 0.11 21.2792
3.6 1.4 0 0.11 21.2833
3.6 1.4 0.2 0.11 21.2833
3.6 1.4 0.4 0.11 21.2833
3.6 1.6 0 0.11 21.287
3.6 1.6 0.2 0.11 21.287
3.6 1.6 0.4 0.11 21.287
3.6 1.8 0 0.11 21.2904
3.6 1.8 0.2 0.11 21.2904
3.6 1.8 0.4 0.11 21.2904
3.6 2 0 0.11 21.2934
3.6 2 0.2 0.11 21.2934
3.6 2 0.4 0.11 21.2934
3.6 2.2 0 0.11 21.2962
3.6 2.2 0.2 0.11 21.2962
3.6 2.2 0.4 0.11 21.2962
3.6 2.4 0 0.11 21.2987
3.6 2.4 0.2 0.11 21.2987
3.6 2.4 0.4 0.11 21.2987
3.6 2.6 0 0.11 21.3009
3.6 2.6 0.2 0.11 21.3009
3.6 2.6 0.4 0.11 21.3009
3.6 2.8 0 0.11 21.3029
3.6 2.8 0.2 0.11 21.303
3.6 2.8 0.4 0.11 21.303
3.6 3 0 0.11 21.3048
3.6 3 0.2 0.11 21.3048
3.6 3 0.4 0.11 21.3048
3.6 3.2 0 0.11 21.3064
3.6 3.2 0.2 0.11 21.3064
3.6 3.2 0.4 0.11 21.3064
3.6 3.4 0 0.11 21.3078
3.6 3.4 0.2 0.11 21.3078
3.6 3.4 0.4 0.11 21.3078
3.6 3.6 0 0.11 21.3091
3.6 3.6 0.2 0.11 21.3091
3.6 3.6 0.4 0.11 21.3091
3.6 3.8 0 0.11 21.3102
3.6 3.8 0.2 0.11 21.3102
3.6 3.8 0.4 0.11 21.3102
3.6 4 0 0.11 21.3112
3.6 4 0.2 0.11 21.3112
3.6 4 0.4 0.11 21.3112
3.6 4.2 0 0.11 21.312
3.6 4.2 0.2 0.11 21.312
3.6 4.2 0.4 0.11 21.312
3.6 4.4 0 0.11 21.3126
3.6 4.4 0.2 0.11 21.3126
3.6 4.4 0.4 0.11 21.3126
3.6 4.6 0 0.11 21.3131
3.6 4.6 0.2 0.11 21.3131
3.6 4.6 0.4 0.11 21.3131
3.6 4.8 0 0.11 21.3134
3.6 4.8 0.2 0.11 21.3134
3.6 4.8 0.4 0.11 21.3134
3.6 5 0 0.11 21.3136
3.6 5 0.2 0.11 21.3136
3.6 5 0.4 0.11 21.3136
3.8 0 0 0.11 21.258
3.8 0 0.2 0.11 21.2575
3.8 0 0.4 0.11 21.258
3.8 0.2 0 0.11 21.2655
3.8 0.2 0.2 0.11 21.2654
3.8 0.2 0.4 0.11 21.2655
3.8 0.4 0 0.11 21.2724
3.8 0.4 0.2 0.11 21.2724
3.8 0.4 0.4 0.11 21.2724
3.8 0.6 0 0.11 21.2785
3.8 0.6 0.2 0.11 21.2785
3.8 0.6 0.4 0.11 21.2785
3.8 0.8 0 0.11 21.2839
3.8 0.8 0.2 0.11 21.2839
3.8 0.8 0.4 0.11 21.284
3.8 1 0 0.11 21.2888
3.8 1 0.2 0.11 21.2888
3.8 1 0.4 0.11 21.2888
3.8 1.2 0 0.11 21.2931
3.8 1.2 0.2 0.11 21.2931
3.8 1.2 0.4 0.11 21.2931
3.8 1.4 0 0.11 21.297
3.8 1.4 0.2 0.11 21.297
3.8 1.4 0.4 0.11 21.297
3.8 1.6 0 0.11 21.3004
3.8 1.6 0.2 0.11 21.3004
3.8 1.6 0.4 0.11 21.3005
3.8 1.8 0 0.11 21.3036
3.8 1.8 0.2 0.11 21.3036
3.8 1.8 0.4 0.11 21.3036
3.8 2 0 0.11 21.3064
3.8 2 0.2 0.11 21.3064
3.8 2 0.4 0.11 21.3064
3.8 2.2 0 0.11 21.3089
3.8 2.2 0.2 0.11 21.3089
3.8 2.2 0.4 0.11 21.3089
3.8 2.4 0 0.11 21.3112
3.8 2.4 0.2 0.11 21.3112
3.8 2.4 0.4 0.11 21.3112
3.8 2.6 0 0.11 21.3132
3.8 2.6 0.2 0.11 21.3132
3.8 2.6 0.4 0.11 21.3132
3.8 2.8 0 0.11 21.3151
3.8 2.8 0.2 0.11 21.3151
3.8 2.8 0.4 0.11 21.3151
3.8 3 0 0.11 21.3168
3.8 3 0.2 0.11 21.3168
3.8 3 0.4 0.11 21.3168
3.8 3.2 0 0.11 21.3183
3.8 3.2 0.2 0.11 21.3183
3.8 3.2 0.4 0.11 21.3183
3.8 3.4 0 0.11 21.3196
3.8 3.4 0.2 0.11 21.3196
3.8 3.4 0.4 0.11 21.3196
3.8 3.6 0 0.11 21.3208
3.8 3.6 0.2 0.11 21.3208
3.8 3.6 0.4 0.11 21.3208
3.8 3.8 0 0.11 21.3218
3.8 3.8 0.2 0.11 21.3218
3.8 3.8 0.4 0.11 21.3218
3.8 4 0 0.11 21.3227
3.8 4 0.2 0.11 21.3227
3.8 4 0.4 0.11 21.3227
3.8 4.2 0 0.11 21.3234
3.8 4.2 0.2 0.11 21.3234
3.8 4.2 0.4 0.11 21.3234
3.8 4.4 0 0.11 21.324
3.8 4.4 0.2 0.11 21.324
3.8 4.4 0.4 0.11 21.324
3.8 4.6 0 0.11 21.3245
3.8 4.6 0.2 0.11 21.3245
3.8 4.6 0.4 0.11 21.3245
3.8 4.8 0 0.11 21.3248
3.8 4.8 0.2 0.11 21.3248
3.8 4.8 0.4 0.11 21.3248
3.8 5 0 0.11 21.3249
3.8 5 0.2 0.11 21.3249
3.8 5 0.4 0.11 21.3249
4 0 0 0.11 21.2738
4 0 0.2 0.11 21.2733
4 0 0.4 0.11 21.2738
4 0.2 0 0.11 21.2813
4 0.2 0.2 0.11 21.2812
4 0.2 0.4 0.11 21.2813
4 0.4 0 0.11 21.288
4 0.4 0.2 0.11 21.288
4 0.4 0.4 0.11 21.288
4 0.6 0 0.11 21.2939
4 0.6 0.2 0.11 21.2939
4 0.6 0.4 0.11 21.2939
4 0.8 0 0.11 21.299
4 0.8 0.2 0.11 21.299
4 0.8 0.4 0.11 21.299
4 1 0 0.11 21.3035
4 1 0.2 0.11 21.3035
4 1 0.4 0.11 21.3035
4 1.2 0 0.11 21.3075
4 1.2 0.2 0.11 21.3075
4 1.2 0.4 0.11 21.3075
4 1.4 0 0.11 21.311
4 1.4 0.2 0.11 21.3111
4 1.4 0.4 0.11 21.3111
4 1.6 0 0.11 21.3142
4 1.6 0.2 0.11 21.3142
4 1.6 0.4 0.11 21.3142
4 1.8 0 0.11 21.317
4 1.8 0.2 0.11 21.317
4 1.8 0.4 0.11 21.317
4 2 0 0.11 21.3195
4 2 0.2 0.11 21.3195
4 2 0.4 0.11 21.3196
4 2.2 0 0.11 21.3218
4 2.2 0.2 0.11 21.3218
4 2.2 0.4 0.11 21.3218
4 2.4 0 0.11 21.3239
4 2.4 0.2 0.11 21.3239
4 2.4 0.4 0.11 21.3239
4 2.6 0 0.11 21.3257
4 2.6 0.2 0.11 21.3258
4 2.6 0.4 0.11 21.3258
4 2.8 0 0.11 21.3274
4 2.8 0.2 0.11 21.3274
4 2.8 0.4 0.11 21.3275
4 3 0 0.11 21.3289
4 3 0.2 0.11 21.3289
4 3 0.4 0.11 21.329
4 3.2 0 0.11 21.3303
4 3.2 0.2 0.11 21.3303
4 3.2 0.4 0.11 21.3303
4 3.4 0 0.11 21.3315
4 3.4 0.2 0.11 21.3315
4 3.4 0.4 0.11 21.3315
4 3.6 0 0.11 21.3325
4 3.6 0.2 0.11 21.3326
4 3.6 0.4 0.11 21.3326
4 3.8 0 0.11 21.3335
4 3.8 0.2 0.11 21.3335
4 3.8 0.4 0.11 21.3335
4 4 0 0.11 21.3343
4 4 0.2 0.11 21.3343
4 4 0.4 0.11 21.3343
4 4.2 0 0.11 21.335
4 4.2 0.2 0.11 21.335
4 4.2 0.4 0.11 21.335
4 4.4 0 0.11 21.3356
4 4.4 0.2 0.11 21.3356
4 4.4 0.4 0.11 21.3356
4 4.6 0 0.11 21.336
4 4.6 0.2 0.11 21.336
4 4.6 0.4 0.11 21.336
4 4.8 0 0.11 21.3363
4 4.8 0.2 0.11 21.3363
4 4.8 0.4 0.11 21.3363
4 5 0 0.11 21.3364
4 5 0.2 0.11 21.3364
4 5 0.4 0.11 21.3364
4.2 0 0 0.11 21.2907
4.2 0 0.2 0.11 21.2901
4.2 0 0.4 0.11 21.2907
4.2 0.2 0 0.11 21.2981
4.2 0.2 0.2 0.11 21.298
4.2 0.2 0.4 0.11 21.2981
4.2 0.4 0 0.11 21.3045
4.2 0.4 0.2 0.11 21.3044
4.2 0.4 0.4 0.11 21.3045
4.2 0.6 0 0.11 21.3099
4.2 0.6 0.2 0.11 21.3099
4.2 0.6 0.4 0.11 21.31
4.2 0.8 0 0.11 21.3147
4.2 0.8 0.2 0.11 21.3147
4.2 0.8 0.4 0.11 21.3147
4.2 1 0 0.11 21.3188
4.2 1 0.2 0.11 21.3188
4.2 1 0.4 0.11 21.3188
4.2 1.2 0 0.11 21.3223
4.2 1.2 0.2 0.11 21.3224
4.2 1.2 0.4 0.11 21.3224
4.2 1.4 0 0.11 21.3255
4.2 1.4 0.2 0.11 21.3255
4.2 1.4 0.4 0.11 21.3256
4.2 1.6 0 0.11 21.3283
4.2 1.6 0.2 0.11 21.3283
4.2 1.6 0.4 0.11 21.3284
4.2 1.8 0 0.11 21.3307
4.2 1.8 0.2 0.11 21.3308
4.2 1.8 0.4 0.11 21.3308
4.2 2 0 0.11 21.3329
4.2 2 0.2 0.11 21.333
4.2 2 0.4 0.11 21.333
4.2 2.2 0 0.11 21.3349
4.2 2.2 0.2 0.11 21.335
4.2 2.2 0.4 0.11 21.335
4.2 2.4 0 0.11 21.3367
4.2 2.4 0.2 0.11 21.3368
4.2 2.4 0.4 0.11 21.3369
4.2 2.6 0 0.11 21.3384
4.2 2.6 0.2 0.11 21.3385
4.2 2.6 0.4 0.11 21.3385
4.2 2.8 0 0.11 21.3399
4.2 2.8 0.2 0.11 21.34
4.2 2.8 0.4 0.11 21.34
4.2 3 0 0.11 21.3412
4.2 3 0.2 0.11 21.3413
4.2 3 0.4 0.11 21.3413
4.2 3.2 0 0.11 21.3424
4.2 3.2 0.2 0.11 21.3425
4.2 3.2 0.4 0.11 21.3425
4.2 3.4 0 0.11 21.3435
4.2 3.4 0.2 0.11 21.3435
4.2 3.4 0.4 0.11 21.3436
4.2 3.6 0 0.11 21.3444
4.2 3.6 0.2 0.11 21.3445
4.2 3.6 0.4 0.11 21.3445
4.2 3.8 0 0.11 21.3453
4.2 3.8 0.2 0.11 21.3453
4.2 3.8 0.4 0.11 21.3454
4.2 4 0 0.11 21.346
4.2 4 0.2 0.11 21.3461
4.2 4 0.4 0.11 21.3461
4.2 4.2 0 0.11 21.3467
4.2 4.2 0.2 0.11 21.3467
4.2 4.2 0.4 0.11 21.3467
4.2 4.4 0 0.11 21.3472
4.2 4.4 0.2 0.11 21.3473
4.2 4.4 0.4 0.11 21.3473
4.2 4.6 0 0.11 21.3477
4.2 4.6 0.2 0.11 21.3477
4.2 4.6 0.4 0.11 21.3477
4.2 4.8 0 0.11 21.3479
4.2 4.8 0.2 0.11 21.3479
4.2 4.8 0.4 0.11 21.348
4.2 5 0 0.11 21.3481
4.2 5 0.2 0.11 21.3481
4.2 5 0.4 0.11 21.3481
4.4 0 0 0.11 21.3088
4.4 0 0.2 0.11 21.3082
4.4 0 0.4 0.11 21.3088
4.4 0.2 0 0.11 21.3159
4.4 0.2 0.2 0.11 21.3158
4.4 0.2 0.4 0.11 21.3159
4.4 0.4 0 0.11 21.3219
4.4 0.4 0.2 0.11 21.3218
4.4 0.4 0.4 0.11 21.3219
4.4 0.6 0 0.11 21.3268
4.4 0.6 0.2 0.11 21.3268
4.4 0.6 0.4 0.11 21.3268
4.4 0.8 0 0.11 21.3309
4.4 0.8 0.2 0.11 21.331
4.4 0.8 0.4 0.11 21.331
4.4 1 0 0.11 21.3345
4.4 1 0.2 0.11 21.3345
4.4 1 0.4 0.11 21.3346
4.4 1.2 0 0.11 21.3376
4.4 1.2 0.2 0.11 21.3377
4.4 1.2 0.4 0.11 21.3378
4.4 1.4 0 0.11 21.3403
4.4 1.4 0.2 0.11 21.3404
4.4 1.4 0.4 0.11 21.3405
4.4 1.6 0 0.11 21.3426
4.4 1.6 0.2 0.11 21.3427
4.4 1.6 0.4 0.11 21.3429
4.4 1.8 0 0.11 21.3446
4.4 1.8 0.2 0.11 21.3448
4.4 1.8 0.4 0.11 21.345
4.4 2 0 0.11 21.3465
4.4 2 0.2 0.11 21.3466
4.4 2 0.4 0.11 21.3468
4.4 2.2 0 0.11 21.3482
4.4 2.2 0.2 0.11 21.3483
4.4 2.2 0.4 0.11 21.3485
4.4 2.4 0 0.11 21.3497
4.4 2.4 0.2 0.11 21.3499
4.4 2.4 0.4 0.11 21.35
4.4 2.6 0 0.11 21.3512
4.4 2.6 0.2 0.11 21.3513
4.4 2.6 0.4 0.11 21.3515
4.4 2.8 0 0.11 21.3525
4.4 2.8 0.2 0.11 21.3526
4.4 2.8 0.4 0.11 21.3528
4.4 3 0 0.11 21.3536
4.4 3 0.2 0.11 21.3538
4.4 3 0.4 0.11 21.3539
4.4 3.2 0 0.11 21.3546
4.4 3.2 0.2 0.11 21.3548
4.4 3.2 0.4 0.11 21.3549
4.4 3.4 0 0.11 21.3555
4.4 3.4 0.2 0.11 21.3557
4.4 3.4 0.4 0.11 21.3558
4.4 3.6 0 0.11 21.3563
4.4 3.6 0.2 0.11 21.3565
4.4 3.6 0.4 0.11 21.3566
4.4 3.8 0 0.11 21.3571
4.4 3.8 0.2 0.11 21.3572
4.4 3.8 0.4 0.11 21.3574
4.4 4 0 0.11 21.3578
4.4 4 0.2 0.11 21.3579
4.4 4 0.4 0.11 21.358
4.4 4.2 0 0.11 21.3585
4.4 4.2 0.2 0.11 21.3586
4.4 4.2 0.4 0.11 21.3586
4.4 4.4 0 0.11 21.359
4.4 4.4 0.2 0.11 21.3591
4.4 4.4 0.4 0.11 21.3591
4.4 4.6 0 0.11 21.3594
4.4 4.6 0.2 0.11 21.3595
4.4 4.6 0.4 0.11 21.3595
4.4 4.8 0 0.11 21.3597
4.4 4.8 0.2 0.11 21.3597
4.4 4.8 0.4 0.11 21.3598
4.4 5 0 0.11 21.3599
4.4 5 0.2 0.11 21.3599
4.4 5 0.4 0.11 21.3599
4.6 0 0 0.11 21.3284
4.6 0 0.2 0.11 21.3279
4.6 0 0.4 0.11 21.3284
4.6 0.2 0 0.11 21.3351
4.6 0.2 0.2 0.11 21.335
4.6 0.2 0.4 0.11 21.3351
4.6 0.4 0 0.11 21.3403
4.6 0.4 0.2 0.11 21.3403
4.6 0.4 0.4 0.11 21.3403
4.6 0.6 0 0.11 21.3444
4.6 0.6 0.2 0.11 21.3444
4.6 0.6 0.4 0.11 21.3444
4.6 0.8 0 0.11 21.3477
4.6 0.8 0.2 0.11 21.3478
4.6 0.8 0.4 0.11 21.3479
4.6 1 0 0.11 21.3506
4.6 1 0.2 0.11 21.3508
4.6 1 0.4 0.11 21.3509
4.6 1.2 0 0.11 21.3531
4.6 1.2 0.2 0.11 21.3534
4.6 1.2 0.4 0.11 21.3537
4.6 1.4 0 0.11 21.3553
4.6 1.4 0.2 0.11 21.3556
4.6 1.4 0.4 0.11 21.356
4.6 1.6 0 0.11 21.3571
4.6 1.6 0.2 0.11 21.3574
4.6 1.6 0.4 0.11 21.3579
4.6 1.8 0 0.11 21.3586
4.6 1.8 0.2 0.11 21.359
4.6 1.8 0.4 0.11 21.3594
4.6 2 0 0.11 21.3601
4.6 2 0.2 0.11 21.3604
4.6 2 0.4 0.11 21.3609
4.6 2.2 0 0.11 21.3614
4.6 2.2 0.2 0.11 21.3617
4.6 2.2 0.4 0.11 21.3622
4.6 2.4 0 0.11 21.3627
4.6 2.4 0.2 0.11 21.363
4.6 2.4 0.4 0.11 21.3635
4.6 2.6 0 0.11 21.3639
4.6 2.6 0.2 0.11 21.3644
4.6 2.6 0.4 0.11 21.3647
4.6 2.8 0 0.11 21.3651
4.6 2.8 0.2 0.11 21.3655
4.6 2.8 0.4 0.11 21.3658
4.6 3 0 0.11 21.366
4.6 3 0.2 0.11 21.3664
4.6 3 0.4 0.11 21.3668
4.6 3.2 0 0.11 21.3668
4.6 3.2 0.2 0.11 21.3673
4.6 3.2 0.4 0.11 21.3676
4.6 3.4 0 0.11 21.3675
4.6 3.4 0.2 0.11 21.368
4.6 3.4 0.4 0.11 21.3683
4.6 3.6 0 0.11 21.3682
4.6 3.6 0.2 0.11 21.3686
4.6 3.6 0.4 0.11 21.3689
4.6 3.8 0 0.11 21.3688
4.6 3.8 0.2 0.11 21.3692
4.6 3.8 0.4 0.11 21.3695
4.6 4 0 0.11 21.3696
4.6 4 0.2 0.11 21.3699
4.6 4 0.4 0.11 21.3701
4.6 4.2 0 0.11 21.3703
4.6 4.2 0.2 0.11 21.3705
4.6 4.2 0.4 0.11 21.3707
4.6 4.4 0 0.11 21.3709
4.6 4.4 0.2 0.11 21.371
4.6 4.4 0.4 0.11 21.3711
4.6 4.6 0 0.11 21.3713
4.6 4.6 0.2 0.11 21.3714
4.6 4.6 0.4 0.11 21.3715
4.6 4.8 0 0.11 21.3716
4.6 4.8 0.2 0.11 21.3717
4.6 4.8 0.4 0.11 21.3717
4.6 5 0 0.11 21.3718
4.6 5 0.2 0.11 21.3718
4.6 5 0.4 0.11 21.3718
4.8 0 0 0.11 21.3503
4.8 0 0.2 0.11 21.3498
4.8 0 0.4 0.11 21.3503
4.8 0.2 0 0.11 21.3559
4.8 0.2 0.2 0.11 21.3558
4.8 0.2 0.4 0.11 21.3559
4.8 0.4 0 0.11 21.3598
4.8 0.4 0.2 0.11 21.3598
4.8 0.4 0.4 0.11 21.3598
4.8 0.6 0 0.11 21.3627
4.8 0.6 0.2 0.11 21.3627
4.8 0.6 0.4 0.11 21.3628
4.8 0.8 0 0.11 21.365
4.8 0.8 0.2 0.11 21.3651
4.8 0.8 0.4 0.11 21.3652
4.8 1 0 0.11 21.367
4.8 1 0.2 0.11 21.3673
4.8 1 0.4 0.11 21.3677
4.8 1.2 0 0.11 21.3688
4.8 1.2 0.2 0.11 21.3693
4.8 1.2 0.4 0.11 21.3705
4.8 1.4 0 0.11 21.3703
4.8 1.4 0.2 0.11 21.371
4.8 1.4 0.4 0.11 21.3724
4.8 1.6 0 0.11 21.3715
4.8 1.6 0.2 0.11 21.3722
4.8 1.6 0.4 0.11 21.3737
4.8 1.8 0 0.11 21.3725
4.8 1.8 0.2 0.11 21.3732
4.8 1.8 0.4 0.11 21.3746
4.8 2 0 0.11 21.3734
4.8 2 0.2 0.11 21.3741
4.8 2 0.4 0.11 21.3755
4.8 2.2 0 0.11 21.3743
4.8 2.2 0.2 0.11 21.375
4.8 2.2 0.4 0.11 21.3764
4.8 2.4 0 0.11 21.3753
4.8 2.4 0.2 0.11 21.3761
4.8 2.4 0.4 0.11 21.3774
4.8 2.6 0 0.11 21.3764
4.8 2.6 0.2 0.11 21.3776
4.8 2.6 0.4 0.11 21.3785
4.8 2.8 0 0.11 21.3774
4.8 2.8 0.2 0.11 21.3787
4.8 2.8 0.4 0.11 21.3794
4.8 3 0 0.11 21.378
4.8 3 0.2 0.11 21.3794
4.8 3 0.4 0.11 21.3801
4.8 3.2 0 0.11 21.3786
4.8 3.2 0.2 0.11 21.3799
4.8 3.2 0.4 0.11 21.3806
4.8 3.4 0 0.11 21.3791
4.8 3.4 0.2 0.11 21.3804
4.8 3.4 0.4 0.11 21.3811
4.8 3.6 0 0.11 21.3796
4.8 3.6 0.2 0.11 21.3809
4.8 3.6 0.4 0.11 21.3816
4.8 3.8 0 0.11 21.3801
4.8 3.8 0.2 0.11 21.3814
4.8 3.8 0.4 0.11 21.382
4.8 4 0 0.11 21.3809
4.8 4 0.2 0.11 21.382
4.8 4 0.4 0.11 21.3825
4.8 4.2 0 0.11 21.3821
4.8 4.2 0.2 0.11 21.3826
4.8 4.2 0.4 0.11 21.3829
4.8 4.4 0 0.11 21.3828
4.8 4.4 0.2 0.11 21.3832
4.8 4.4 0.4 0.11 21.3833
4.8 4.6 0 0.11 21.3833
4.8 4.6 0.2 0.11 21.3835
4.8 4.6 0.4 0.11 21.3836
4.8 4.8 0 0.11 21.3837
4.8 4.8 0.2 0.11 21.3838
4.8 4.8 0.4 0.11 21.3838
4.8 5 0 0.11 21.3839
4.8 5 0.2 0.11 21.3839
4.8 5 0.4 0.11 21.3839
5 0 0 0.11 21.3756
5 0 0.2 0.11 21.3752
5 0 0.4 0.11 21.3756
5 0.2 0 0.11 21.3786
5 0.2 0.2 0.11 21.3785
5 0.2 0.4 0.11 21.3786
5 0.4 0 0.11 21.3803
5 0.4 0.2 0.11 21.3803
5 0.4 0.4 0.11 21.3804
5 0.6 0 0.11 21.3815
5 0.6 0.2 0.11 21.3816
5 0.6 0.4 0.11 21.3816
5 0.8 0 0.11 21.3825
5 0.8 0.2 0.11 21.3826
5 0.8 0.4 0.11 21.3827
5 1 0 0.11 21.3833
5 1 0.2 0.11 21.3837
5 1 0.4 0.11 21.3844
5 1.2 0 0.11 21.3842
5 1.2 0.2 0.11 21.3851
5 1.2 0.4 0.11 21.3895
5 1.4 0 0.11 21.3848
5 1.4 0.2 0.11 21.386
5 1.4 0.4 0.11 21.3909
5 1.6 0 0.11 21.3853
5 1.6 0.2 0.11 21.3865
5 1.6 0.4 0.11 21.3913
5 1.8 0 0.11 21.3857
5 1.8 0.2 0.11 21.3868
5 1.8 0.4 0.11 21.3912
5 2 0 0.11 21.386
5 2 0.2 0.11 21.3871
5 2 0.4 0.11 21.3914
5 2.2 0 0.11 21.3864
5 2.2 0.2 0.11 21.3876
5 2.2 0.4 0.11 21.3918
5 2.4 0 0.11 21.387
5 2.4 0.2 0.11 21.3884
5 2.4 0.4 0.11 21.3924
5 2.6 0 0.11 21.388
5 2.6 0.2 0.11 21.3917
5 2.6 0.4 0.11 21.3933
5 2.8 0 0.11 21.3886
5 2.8 0.2 0.11 21.3928
5 2.8 0.4 0.11 21.3939
5 3 0 0.11 21.3889
5 3 0.2 0.11 21.3931
5 3 0.4 0.11 21.3942
5 3.2 0 0.11 21.3891
5 3.2 0.2 0.11 21.3933
5 3.2 0.4 0.11 21.3945
5 3.4 0 0.11 21.3893
5 3.4 0.2 0.11 21.3936
5 3.4 0.4 0.11 21.3947
5 3.6 0 0.11 21.3895
5 3.6 0.2 0.11 21.3938
5 3.6 0.4 0.11 21.3949
5 3.8 0 0.11 21.3899
5 3.8 0.2 0.11 21.3941
5 3.8 0.4 0.11 21.3951
5 4 0 0.11 21.3907
5 4 0.2 0.11 21.3944
5 4 0.4 0.11 21.3953
5 4.2 0 0.11 21.394
5 4.2 0.2 0.11 21.3952
5 4.2 0.4 0.11 21.3956
5 4.4 0 0.11 21.3947
5 4.4 0.2 0.11 21.3956
5 4.4 0.4 0.11 21.3958
5 4.6 0 0.11 21.3951
5 4.6 0.2 0.11 21.3958
5 4.6 0.4 0.11 21.3959
5 4.8 0 0.11 21.3959
5 4.8 0.2 0.11 21.396
5 4.8 0.4 0.11 21.396
5 5 0 0.11 21.396
5 5 0.2 0.11 21.3961
5 5 0.4 0.11 21.3961

BR
Przemek

Revision history for this message
Jan Stránský (honzik) said :
#16

This is the same, 2028 particles in txt file 2027 in vtk file
Jan

Revision history for this message
Przemek (przemekn) said :
#17

Yes, you have right. But why in paraview more than one parcicle are missed? And this issue is also in case with less particles, e.g. when the vtk file contain 675 particles three of them are not visible...

Revision history for this message
Jan Stránský (honzik) said :
#18

There might be several reasons, e.g. one particle could be "inside" another particle and therefore not visible..
Or (as mentioned before) Paraview is hiding some particles "by default".
E.g. in Paraview 5.6.1 even for 36 particles, only roughly 2/3 are shown. I have to go to "Masking" section of "Properties" tab and select "Glyph Mode" to "All points" (instead of default "Uniform Spatial Distribution"). I use Sphere glyph to show the data.
Jan

Revision history for this message
Jan Stránský (honzik) said :
#19

fixed in MR [2]. You can copy-paste the new code of export.text2vtk in the export module or you can save it as a user defined function.
cheers
Jan

[2] https://gitlab.com/yade-dev/trunk/-/merge_requests/477

Revision history for this message
Przemek (przemekn) said :
#20

Hi,

now it works! Thanks a lot! :)

BR
Przemek