{ "cells": [ { "cell_type": "code", "execution_count": 2, "metadata": {}, "outputs": [], "source": [ "using LinearAlgebra\n", "using Plots\n", "import JSON\n", "# using Quaternions\n", "using StaticArrays, Rotations\n", "using Distributed\n", "using StaticArrays, BenchmarkTools\n", "using Base.Threads\n", "using CUDAnative\n", "using CuArrays,CUDAdrv \n", "using Test\n", "import Base: +, * , -, ^" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "## Todo\n", "- create struct for material and get for each edge its properties\n", "- implement getTimestep (done)\n", "- implement on single voxel (done)\n", "- get reat E and L (done)\n", "- compare to Frame3dd" ] }, { "cell_type": "code", "execution_count": 2, "metadata": {}, "outputs": [], "source": [ "struct Vector3\n", " x::Float64\n", " y::Float64\n", " z::Float64\n", " function Vector3()\n", " x=0.0\n", " y=0.0\n", " z=0.0\n", " new(x,y,z)\n", " end\n", " function Vector3(x,y,z)\n", " new(x,y,z)\n", " end\n", "end\n", "struct Quaternion\n", " x::Float64\n", " y::Float64\n", " z::Float64\n", " w::Float64\n", " function Quaternion()\n", " x=0.0\n", " y=0.0\n", " z=0.0\n", " w=1.0\n", " new(x,y,z,w)\n", " end\n", " function Quaternion(x,y,z,w)\n", " new(x,y,z,w)\n", " end\n", "end\n", "struct RotationMatrix\n", " te1::Float64\n", " te2::Float64\n", " te3::Float64\n", " te4::Float64\n", " te5::Float64\n", " te6::Float64\n", " te7::Float64\n", " te8::Float64\n", " te9::Float64\n", " te10::Float64\n", " te11::Float64\n", " te12::Float64\n", " te13::Float64\n", " te14::Float64\n", " te15::Float64\n", " te16::Float64\n", " function RotationMatrix()\n", " te1 =0.0\n", " te2 =0.0\n", " te3 =0.0\n", " te4 =0.0\n", " te5 =0.0\n", " te6 =0.0\n", " te7 =0.0\n", " te8 =0.0\n", " te9 =0.0\n", " te10=0.0\n", " te11=0.0\n", " te12=0.0\n", " te13=0.0\n", " te14=0.0\n", " te15=0.0\n", " te16=0.0\n", " new(te1,te2,te3,te4,te5,te6,te7,te8,te9,te10,te11,te12,te13,te14,te15,te16)\n", " end\n", " function RotationMatrix(te1,te2,te3,te4,te5,te6,te7,te8,te9,te10,te11,te12,te13,te14,te15,te16)\n", " new(te1,te2,te3,te4,te5,te6,te7,te8,te9,te10,te11,te12,te13,te14,te15,te16)\n", " end\n", "end\n", "\n", "+(f::Vector3, g::Vector3)=Vector3(f.x+g.x , f.y+g.y,f.z+g.z )\n", "-(f::Vector3, g::Vector3)=Vector3(f.x-g.x , f.y-g.y,f.z-g.z )\n", "*(f::Vector3, g::Vector3)=Vector3(f.x*g.x , f.y*g.y,f.z*g.z )\n", "\n", "+(f::Vector3, g::Number)=Vector3(f.x+g , f.y+g,f.z+g )\n", "-(f::Vector3, g::Number)=Vector3(f.x-g , f.y-g,f.z-g )\n", "*(f::Vector3, g::Number)=Vector3(f.x*g , f.y*g,f.z*g )\n", "\n", "+(g::Vector3, f::Number)=Vector3(f.x+g , f.y+g,f.z+g )\n", "-(g::Vector3, f::Number)=Vector3(g-f.x , g-f.y,g-f.z )\n", "*(g::Vector3, f::Number)=Vector3(f.x*g , f.y*g,f.z*g )\n", "\n", "addX(f::Vector3, g::Number)=Vector3(f.x+g , f.y,f.z)\n", "addY(f::Vector3, g::Number)=Vector3(f.x , f.y+g,f.z )\n", "addZ(f::Vector3, g::Number)=Vector3(f.x , f.y,f.z+g )\n", "\n", "function normalizeVector3(f::Vector3)\n", " leng=sqrt((f.x * f.x) + (f.y * f.y) + (f.z * f.z))\n", " return Vector3(f.x/leng,f.y/leng,f.z/leng)\n", " \n", "end\n", "function normalizeQuaternion(f::Quaternion)\n", " l = sqrt((f.x * f.x) + (f.y * f.y) + (f.z * f.z)+ (f.w * f.w))\n", " if l === 0 \n", " qx = 0\n", " qy = 0\n", " qz = 0\n", " qw = 1\n", " else \n", " l = 1 / l\n", " qx = f.x * l\n", " qy = f.y * l\n", " qz = f.z * l\n", " qw = f.w * l\n", " end\n", " return Quaternion(qx,qy,qz,qw)\n", "end\n", "\n", "function normalizeQuaternion1!(fx::Float64,fy::Float64,fz::Float64,fw::Float64)\n", " l = sqrt((fx * fx) + (fy * fy) + (fz * fz)+ (fw * fw))\n", " if l === 0 \n", " qx = 0.0\n", " qy = 0.0\n", " qz = 0.0\n", " qw = 1.0\n", " else \n", " l = 1.0 / l\n", " qx = fx * l\n", " qy = fy * l\n", " qz = fz * l\n", " qw = fw * l\n", " end\n", " return qx,qy,qz,qw\n", "end\n", "\n", "\n", "function dotVector3(f::Vector3, g::Vector3)\n", " return (f.x * g.x) + (f.y * g.y) + (f.z * g.z)\n", "end\n", "\n", "function Base.show(io::IO, v::Vector3)\n", " print(io, \"x:$(v.x), y:$(v.y), z:$(v.z)\")\n", "end\n", "\n", "function Base.show(io::IO, v::Quaternion)\n", " print(io, \"x:$(v.x), y:$(v.y), z:$(v.z), w:$(v.z)\")\n", "end\n", "\n", "Base.Broadcast.broadcastable(q::Vector3) = Ref(q)" ] }, { "cell_type": "code", "execution_count": 3, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "simulateParallel (generic function with 2 methods)" ] }, "execution_count": 3, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function simulateParallel(numTimeSteps,dt)\n", " # initialize(setup)\n", " \n", " for i in 1:numTimeSteps\n", " #println(\"Timestep:\",i)\n", " doTimeStep(dt,i)\n", " end\n", "end\n", "\n", "function simulateParallel(metavoxel,numTimeSteps,dt)\n", " # initialize(setup)\n", " \n", " for i in 1:numTimeSteps\n", " #println(\"Timestep:\",i)\n", " doTimeStep(metavoxel,dt,i)\n", " end\n", "end" ] }, { "cell_type": "code", "execution_count": 4, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "initialize (generic function with 1 method)" ] }, "execution_count": 4, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function initialize(setup)\n", " nodes = setup[\"nodes\"]\n", " edges = setup[\"edges\"]\n", "\n", " i=1\n", " # pre-calculate current position\n", " for node in nodes\n", " # element=parse(Int,node[\"id\"][2:end])\n", " N_position[i]=Vector3(node[\"position\"][\"x\"]*15.0,node[\"position\"][\"y\"]*15.0,node[\"position\"][\"z\"]*15.0)\n", " N_restrained[i]=node[\"restrained_degrees_of_freedom\"][1] ## todo later consider other degrees of freedom\n", " N_displacement[i]=Vector3(node[\"displacement\"][\"x\"]*15,node[\"displacement\"][\"y\"]*15,node[\"displacement\"][\"z\"]*15)\n", " N_angle[i]=Vector3(node[\"angle\"][\"x\"],node[\"angle\"][\"y\"],node[\"angle\"][\"z\"])\n", " N_force[i]=Vector3(node[\"force\"][\"x\"],node[\"force\"][\"y\"],node[\"force\"][\"z\"])\n", " N_currPosition[i]=Vector3(node[\"position\"][\"x\"]*15.0,node[\"position\"][\"y\"]*15.0,node[\"position\"][\"z\"]*15.0)\n", "\n", " # for dynamic simulations\n", " # append!(N_posTimeSteps,[[]])\n", " # append!(N_angTimeSteps,[[]])\n", "\n", " i=i+1\n", " end \n", "\n", " i=1\n", " # pre-calculate the axis\n", " for edge in edges\n", " # element=parse(Int,edge[\"id\"][2:end])\n", "\n", " # find the nodes that the lements connects\n", " fromNode = nodes[edge[\"source\"]+1]\n", " toNode = nodes[edge[\"target\"]+1]\n", "\n", "\n", " node1 = [fromNode[\"position\"][\"x\"]*15.0 fromNode[\"position\"][\"y\"]*15.0 fromNode[\"position\"][\"z\"]*15.0]\n", " node2 = [toNode[\"position\"][\"x\"]*15.0 toNode[\"position\"][\"y\"]*15.0 toNode[\"position\"][\"z\"]*15.0]\n", "\n", " length=norm(node2-node1)\n", " axis=normalize(collect(Iterators.flatten(node2-node1)))\n", "\n", " E_source[i]=edge[\"source\"]+1\n", " E_target[i]=edge[\"target\"]+1\n", " E_area[i]=edge[\"area\"]\n", " E_density[i]=edge[\"density\"]\n", " E_stiffness[i]=edge[\"stiffness\"]\n", " E_axis[i]=Vector3(axis[1],axis[2],axis[3])\n", " E_currentRestLength[i]=length #?????????? todo change\n", "# E_currentRestLength[i]=75/sqrt(2)\n", "\n", " N_edgeID[E_source[i],N_currEdge[E_source[i]]]=i\n", " N_edgeFirst[E_source[i],N_currEdge[E_source[i]]]=true\n", " N_currEdge[E_source[i]]+=1\n", "\n", " N_edgeID[E_target[i],N_currEdge[E_target[i]]]=i\n", " N_edgeFirst[E_target[i],N_currEdge[E_target[i]]]=false\n", " N_currEdge[E_target[i]]+=1\n", "\n", "\n", " # for dynamic simulations\n", " # append!(E_stressTimeSteps,[[]])\n", "\n", " i=i+1\n", " end \n", "end" ] }, { "cell_type": "code", "execution_count": 5, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "doTimeStep! (generic function with 1 method)" ] }, "execution_count": 5, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function doTimeStep(dt,currentTimeStep)\n", " # update forces: go through edges, get currentposition from nodes, calc pos2 and update stresses and interior forces of nodes\n", " run_updateEdges!(\n", " E_sourceGPU, \n", " E_targetGPU,\n", " E_areaGPU,\n", " E_densityGPU,\n", " E_stiffnessGPU,\n", " E_stressGPU,\n", " E_axisGPU,\n", " E_currentRestLengthGPU,\n", " E_pos2GPU,\n", " E_angle1vGPU,\n", " E_angle2vGPU,\n", " E_angle1GPU,\n", " E_angle2GPU,\n", " E_intForce1GPU,\n", " E_intMoment1GPU,\n", " E_intForce2GPU,\n", " E_intMoment2GPU,\n", " E_dampGPU,\n", " N_currPositionGPU,\n", " N_orientGPU)\n", " \n", " # update forces: go through nodes and update interior force (according to int forces from edges), integrate and update currpos\n", " run_updateNodes!(dt,currentTimeStep,\n", " N_positionGPU, \n", " N_restrainedGPU,\n", " N_displacementGPU,\n", " N_angleGPU,\n", " N_currPositionGPU,\n", " N_linMomGPU,\n", " N_angMomGPU,\n", " N_intForceGPU,\n", " N_intMomentGPU,\n", " N_forceGPU,\n", " N_momentGPU,\n", " N_orientGPU,\n", " N_edgeIDGPU, \n", " N_edgeFirstGPU, \n", " E_intForce1GPU,\n", " E_intMoment1GPU,\n", " E_intForce2GPU,\n", " E_intMoment2GPU)\n", " \n", "end\n", "\n", "function doTimeStep!(metavoxel,dt,currentTimeStep)\n", " # update forces: go through edges, get currentposition from nodes, calc pos2 and update stresses and interior forces of nodes\n", " run_updateEdges!(\n", " metavoxel[\"E_sourceGPU\"], \n", " metavoxel[\"E_targetGPU\"],\n", " metavoxel[\"E_areaGPU\"],\n", " metavoxel[\"E_densityGPU\"],\n", " metavoxel[\"E_stiffnessGPU\"],\n", " metavoxel[\"E_stressGPU\"],\n", " metavoxel[\"E_axisGPU\"],\n", " metavoxel[\"E_currentRestLengthGPU\"],\n", " metavoxel[\"E_pos2GPU\"],\n", " metavoxel[\"E_angle1vGPU\"],\n", " metavoxel[\"E_angle2vGPU\"],\n", " metavoxel[\"E_angle1GPU\"],\n", " metavoxel[\"E_angle2GPU\"],\n", " metavoxel[\"E_intForce1GPU\"],\n", " metavoxel[\"E_intMoment1GPU\"],\n", " metavoxel[\"E_intForce2GPU\"],\n", " metavoxel[\"E_intMoment2GPU\"],\n", " metavoxel[\"E_dampGPU\"],\n", " metavoxel[\"N_currPositionGPU\"],\n", " metavoxel[\"N_orientGPU\"])\n", " \n", " # update forces: go through nodes and update interior force (according to int forces from edges), integrate and update currpos\n", " run_updateNodes!(dt,currentTimeStep,\n", " metavoxel[\"N_positionGPU\"], \n", " metavoxel[\"N_restrainedGPU\"],\n", " metavoxel[\"N_displacementGPU\"],\n", " metavoxel[\"N_angleGPU\"],\n", " metavoxel[\"N_currPositionGPU\"],\n", " metavoxel[\"N_linMomGPU\"],\n", " metavoxel[\"N_angMomGPU\"],\n", " metavoxel[\"N_intForceGPU\"],\n", " metavoxel[\"N_intMomentGPU\"],\n", " metavoxel[\"N_forceGPU\"],\n", " metavoxel[\"N_momentGPU\"],\n", " metavoxel[\"N_orientGPU\"],\n", " metavoxel[\"N_edgeIDGPU\"], \n", " metavoxel[\"N_edgeFirstGPU\"], \n", " metavoxel[\"E_intForce1GPU\"],\n", " metavoxel[\"E_intMoment1GPU\"],\n", " metavoxel[\"E_intForce2GPU\"],\n", " metavoxel[\"E_intMoment2GPU\"])\n", " \n", "end" ] }, { "cell_type": "code", "execution_count": 6, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "run_updateEdges! (generic function with 1 method)" ] }, "execution_count": 6, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function updateEdges!(E_source,E_target,E_area,E_density,E_stiffness,E_stress,E_axis,\n", " E_currentRestLength,E_pos2,E_angle1v,E_angle2v,\n", " E_angle1,E_angle2,E_intForce1,E_intMoment1,E_intForce2,E_intMoment2,E_damp,\n", " N_currPosition,N_orient)\n", "\n", " index = (blockIdx().x - 1) * blockDim().x + threadIdx().x\n", " stride = blockDim().x * gridDim().x\n", " ## @cuprintln(\"thread $index, block $stride\")\n", " N=length(E_source)\n", " for i = index:stride:N\n", " \n", " @inbounds pVNeg=N_currPosition[E_source[i]]\n", " @inbounds pVPos=N_currPosition[E_target[i]]\n", " \n", " @inbounds oVNeg=N_orient[E_source[i]]\n", " @inbounds oVPos=N_orient[E_target[i]]\n", " \n", " @inbounds oldPos2=Vector3(E_pos2[i].x,E_pos2[i].y,E_pos2[i].z) #?copy?\n", " @inbounds oldAngle1v = Vector3(E_angle1v[i].x,E_angle1v[i].y,E_angle1v[i].z)\n", " @inbounds oldAngle2v = Vector3(E_angle2v[i].x,E_angle2v[i].y,E_angle2v[i].z)# remember the positions/angles from last timestep to calculate velocity\n", " \n", " \n", " @inbounds E_pos2[i],E_angle1v[i],E_angle2v[i],E_angle1[i],E_angle2[i],totalRot= orientLink!(E_currentRestLength[i],pVNeg,pVPos,oVNeg,oVPos,E_axis[i])\n", " \n", " @inbounds dPos2 = Vector3(0.5,0.5,0.5) * (E_pos2[i]-oldPos2) #deltas for local damping. velocity at center is half the total velocity\n", " @inbounds dAngle1 = Vector3(0.5,0.5,0.5) *(E_angle1v[i]-oldAngle1v)\n", " @inbounds dAngle2 = Vector3(0.5,0.5,0.5) *(E_angle2v[i]-oldAngle2v)\n", " \n", " \n", " @inbounds strain=(E_pos2[i].x/E_currentRestLength[i])\n", " \n", " positiveEnd=true\n", " if axialStrain( positiveEnd,strain)>100.0\n", " diverged=true\n", " @cuprintln(\"DIVERGED!!!!!!!!!!\")\n", " return \n", " end\n", " \n", " @inbounds E = E_stiffness[i]\n", " \n", " \n", " \n", " @inbounds l = E_currentRestLength[i]\n", " \n", " \n", " nu=0\n", "# L = 5.0 #?? change!!!!!!\n", " L=l\n", " a1 = E*L # EA/L : Units of N/m\n", " a2 = E * L*L*L / (12.0*(1+nu)) # GJ/L : Units of N-m\n", " b1 = E*L # 12EI/L^3 : Units of N/m\n", " b2 = E*L*L/2.0 # 6EI/L^2 : Units of N (or N-m/m: torque related to linear distance)\n", " b3 = E*L*L*L/6.0 # 2EI/L : Units of N-m\n", " \n", " nu=0.35\n", " W = 75\n", "# L = W/sqrt(2)\n", " l=L\n", " n_min = 1\n", " n_max = 7\n", " # Cross Section inputs, must be floats\n", " mass=125000 #before for voxel\n", " mass=10\n", " E = 2000 # MPa\n", " G = E * 1 / 3 # MPa\n", " h = 2.38 # mm\n", " b = 2.38 # mm\n", " rho = 7.85e-9 / 3 # kg/mm^3\n", " S = h * b\n", " Sy = (S * (6 + 12 * nu + 6 * nu^2)/ (7 + 12 * nu + 4 * nu^2))\n", " # For solid rectangular cross section (width=b, depth=d & ( b < d )):\n", " Q = 1 / 3 - 0.2244 / (min(h / b, b / h) + 0.1607)\n", " Jxx = Q * min(h * b^3, b * h^3)\n", " s=b\n", " \n", " MaxFreq2=E*s/mass\n", " dt= 1/(6.283185*sqrt(MaxFreq2))\n", "\n", "\n", " ##if voxels\n", " #nu=0\n", " #L=l\n", " #a1 = E*L # EA/L : Units of N/m\n", " #a2 = E * L*L*L / (12.0*(1+nu)) # GJ/L : Units of N-m\n", " #b1 = E*L # 12EI/L^3 : Units of N/m\n", " #b2 = E*L*L/2.0 # 6EI/L^2 : Units of N (or N-m/m: torque related to linear distance)\n", " #b3 = E*L*L*L/6.0 # 2EI/L : Units of N-m\n", "\n", " I= b*h^3/12\n", " J=b*h*(b*b+h*h)/12\n", " a1=E*b*h/L\n", " a2=G*J/L\n", " b1=12*E*I/(L^3)\n", " b2=6*E*I/(L^2)\n", " b3=2*E*I/(L)\n", " \n", " \n", "\n", " \n", " #inbounds currentTransverseArea=25.0 #?? change!!!!!! E_area[i]\n", " @inbounds currentTransverseArea= b*h\n", " @inbounds _stress=updateStrain(strain,E)\n", " \n", " #@inbounds currentTransverseArea= E_area[i]\n", " #@inbounds _stress=updateStrain(strain,E_stiffness[i])\n", " \n", " @inbounds E_stress[i]=_stress\n", " \n", " #@cuprintln(\"_stress $_stress\")\n", " x=(_stress*currentTransverseArea)\n", " @inbounds y=(b1*E_pos2[i].y-b2*(E_angle1v[i].z + E_angle2v[i].z))\n", " @inbounds z=(b1*E_pos2[i].z + b2*(E_angle1v[i].y + E_angle2v[i].y))\n", " \n", " x=convert(Float64,x)\n", " y=convert(Float64,y)\n", " z=convert(Float64,z)\n", " \n", " # Use Curstress instead of -a1*Pos2.x to account for non-linear deformation \n", " forceNeg = Vector3(x,y,z)\n", " \n", " forcePos = Vector3(-x,-y,-z)\n", " \n", " @inbounds x= (a2*(E_angle2v[i].x-E_angle1v[i].x))\n", " @inbounds y= (-b2*E_pos2[i].z-b3*(2.0*E_angle1v[i].y+E_angle2v[i].y))\n", " @inbounds z=(b2*E_pos2[i].y - b3*(2.0*E_angle1v[i].z + E_angle2v[i].z)) \n", " x=convert(Float64,x)\n", " y=convert(Float64,y)\n", " z=convert(Float64,z)\n", " momentNeg = Vector3(x,y,z)\n", " \n", "\n", " @inbounds x= (a2*(E_angle1v[i].x-E_angle2v[i].x))\n", " @inbounds y= (-b2*E_pos2[i].z- b3*(E_angle1v[i].y+2.0*E_angle2v[i].y))\n", " @inbounds z=(b2*E_pos2[i].y - b3*(E_angle1v[i].z + 2.0*E_angle2v[i].z))\n", " x=convert(Float64,x)\n", " y=convert(Float64,y)\n", " z=convert(Float64,z)\n", " momentPos = Vector3(x,y,z)\n", " \n", " \n", " ### damping\n", " @inbounds if E_damp[i] #first pass no damping\n", " sqA1=CUDAnative.sqrt(a1) \n", " sqA2xIp=CUDAnative.sqrt(a2*L*L/6.0) \n", " sqB1=CUDAnative.sqrt(b1) \n", " sqB2xFMp=CUDAnative.sqrt(b2*L/2) \n", " sqB3xIp=CUDAnative.sqrt(b3*L*L/6.0)\n", " \n", " dampingMultiplier=Vector3(28099.3,28099.3,28099.3) # 2*mat->_sqrtMass*mat->zetaInternal/previousDt;?? todo link to material\n", " \n", " zeta=1\n", " dampingM= 2*sqrt(mass)*zeta/dt\n", " dampingMultiplier=Vector3(dampingM,dampingM,dampingM)\n", " \n", " posCalc=Vector3(sqA1*dPos2.x, sqB1*dPos2.y - sqB2xFMp*(dAngle1.z+dAngle2.z),sqB1*dPos2.z + sqB2xFMp*(dAngle1.y+dAngle2.y))\n", " \n", " \n", " forceNeg =forceNeg + (dampingMultiplier*posCalc);\n", " forcePos =forcePos - (dampingMultiplier*posCalc);\n", "\n", " momentNeg -= Vector3(0.5,0.5,0.5)*dampingMultiplier*Vector3(-sqA2xIp*(dAngle2.x - dAngle1.x),\n", " sqB2xFMp*dPos2.z + sqB3xIp*(2*dAngle1.y + dAngle2.y),\n", " -sqB2xFMp*dPos2.y + sqB3xIp*(2*dAngle1.z + dAngle2.z));\n", " momentPos -= Vector3(0.5,0.5,0.5)*dampingMultiplier*Vector3(sqA2xIp*(dAngle2.x - dAngle1.x),\n", " sqB2xFMp*dPos2.z + sqB3xIp*(dAngle1.y + 2*dAngle2.y),\n", " -sqB2xFMp*dPos2.y + sqB3xIp*(dAngle1.z + 2*dAngle2.z));\n", "\n", " else\n", " @inbounds E_damp[i]=true \n", " end\n", "\n", " smallAngle=true\n", " if !smallAngle # ?? check\n", " @inbounds forceNeg = RotateVec3DInv(E_angle1[i],forceNeg)\n", " @inbounds momentNeg = RotateVec3DInv(E_angle1[i],momentNeg)\n", " end\n", " \n", " @inbounds forcePos = RotateVec3DInv(E_angle2[i],forcePos)\n", " @inbounds momentPos = RotateVec3DInv(E_angle2[i],momentPos)\n", "\n", " @inbounds forceNeg =toAxisOriginalVector3(forceNeg,E_axis[i])\n", " @inbounds forcePos =toAxisOriginalVector3(forcePos,E_axis[i])\n", "\n", " @inbounds momentNeg=toAxisOriginalQuat(momentNeg,E_axis[i])# TODOO CHECKKKKKK\n", " @inbounds momentPos=toAxisOriginalQuat(momentPos,E_axis[i])\n", "\n", "\n", " @inbounds E_intForce1[i] =forceNeg\n", " @inbounds E_intForce2[i] =forcePos\n", " \n", "\n", "\n", " @inbounds x= momentNeg.x\n", " @inbounds y= momentNeg.y\n", " @inbounds z= momentNeg.z \n", " x=convert(Float64,x)\n", " y=convert(Float64,y)\n", " z=convert(Float64,z)\n", " \n", " @inbounds E_intMoment1[i]=Vector3(x,y,z)\n", "\n", " @inbounds x= momentNeg.x\n", " @inbounds y= momentNeg.y\n", " @inbounds z= momentNeg.z\n", " x=convert(Float64,x)\n", " y=convert(Float64,y)\n", " z=convert(Float64,z)\n", " \n", " @inbounds E_intMoment2[i]=Vector3(x,y,z)\n", " \n", " #x=E_pos2[i].x*10000000000\n", " #y=E_pos2[i].y*10000000000\n", " #z=E_pos2[i].z*10000000000\n", " #@cuprintln(\"pos2 x $x, y $y, z $z \")\n", " ##x=E_intMoment2[i].x*10000000000\n", " #y=E_intMoment2[i].y*10000000000\n", " #z=E_intMoment2[i].z*10000000000\n", " #@cuprintln(\"E_intMoment2 x $x, y $y, z $z \")\n", "\n", " \n", " \n", " end\n", " return\n", "end\n", "\n", "function run_updateEdges!(E_source,E_target,E_area,E_density,E_stiffness,\n", " E_stress,E_axis,E_currentRestLength,E_pos2,E_angle1v,E_angle2v,\n", " E_angle1,E_angle2,E_intForce1,E_intMoment1,E_intForce2,E_intMoment2,\n", " E_damp,N_currPosition,N_orient)\n", " N=length(E_source)\n", " numblocks = ceil(Int, N/256)\n", " CuArrays.@sync begin\n", " @cuda threads=256 blocks=numblocks updateEdges!(E_source,E_target,E_area,E_density,\n", " E_stiffness,E_stress,E_axis,E_currentRestLength,E_pos2,E_angle1v,\n", " E_angle2v,E_angle1,E_angle2,E_intForce1,E_intMoment1,E_intForce2,\n", " E_intMoment2,E_damp,N_currPosition,N_orient)\n", " end\n", "end" ] }, { "cell_type": "code", "execution_count": 7, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "run_updateNodes! (generic function with 1 method)" ] }, "execution_count": 7, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function updateNodes!(dt,currentTimeStep,N_position, N_restrained,N_displacement,N_angle,N_currPosition,N_linMom,N_angMom,N_intForce,N_intMoment,N_force,N_moment,N_orient,N_edgeID,N_edgeFirst,E_intForce1,E_intMoment1,E_intForce2,E_intMoment2)\n", "\n", " index = (blockIdx().x - 1) * blockDim().x + threadIdx().x\n", " stride = blockDim().x * gridDim().x\n", " ## @cuprintln(\"thread $index, block $stride\")\n", " N,M=size(N_edgeID)\n", " for i = index:stride:N\n", " @inbounds if N_restrained[i]\n", " return\n", " else\n", " for j in 1:M\n", " temp=N_edgeID[i,j]\n", " @inbounds if (N_edgeID[i,j]!=-1)\n", " #@cuprintln(\"i $i, j $j, N_edgeID[i,j] $temp\")\n", " @inbounds N_intForce[i]=ifelse(N_edgeFirst[i,j], N_intForce[i]+E_intForce1[N_edgeID[i,j]], N_intForce[i]+E_intForce2[N_edgeID[i,j]] )\n", " @inbounds N_intMoment[i]=ifelse(N_edgeFirst[i,j], N_intMoment[i]+E_intMoment1[N_edgeID[i,j]], N_intMoment[i]+E_intMoment2[N_edgeID[i,j]] )\n", " end\n", " end\n", " @inbounds curForce = force(N_intForce[i],N_orient[i],N_force[i],true,currentTimeStep)\n", " \n", " #@inbounds N_force[i]=Vector3(0,0,0) ##????\n", " \n", " @inbounds N_intForce[i]=Vector3(0,0,0)\n", " \n", " #x=curForce.x\n", " #y=curForce.y\n", " #z=curForce.z\n", " #@cuprintln(\"curForce x $x, y $y, z $z \")\n", " \n", " #x=N_linMom[i].x*10000000000\n", " #y=N_linMom[i].y*10000000000\n", " #z=N_linMom[i].z*10000000000\n", " #@cuprintln(\"N_linMom[i] x $x, y $y, z $z \")\n", " \n", " \n", " @inbounds N_linMom[i]=N_linMom[i]+curForce*Vector3(dt,dt,dt) #todo make sure right\n", " massInverse=8e-6 # todo ?? later change //8e-6\n", " mass=10\n", " massInverse=1.0/mass #\n", " @inbounds translate=N_linMom[i]*Vector3((dt*massInverse),(dt*massInverse),(dt*massInverse)) # ??massInverse\n", " \n", " #x=translate.x*10000000000\n", " #y=translate.y*10000000000\n", " #z=translate.z*10000000000\n", " #@cuprintln(\"translate x $x, y $y, z $z \")\n", " \n", " @inbounds N_currPosition[i]=N_currPosition[i]+translate\n", " @inbounds N_displacement[i]=N_displacement[i]+translate\n", " \n", " \n", " \n", " # Rotation\n", " @inbounds curMoment = moment(N_intMoment[i],N_orient[i],N_moment[i]) \n", " \n", " \n", " \n", " @inbounds N_intMoment[i]=Vector3(0,0,0) # do i really need it?\n", " \n", " @inbounds N_angMom[i]=N_angMom[i]+curMoment*Vector3(dt,dt,dt)\n", " \n", " \n", " \n", " \n", " momentInertiaInverse=1.92e-6 # todo ?? later change 1/Inertia (1/(kg*m^2))\n", " \n", " \n", " @inbounds temp=FromRotationVector(N_angMom[i]*Vector3((dt*momentInertiaInverse),(dt*momentInertiaInverse),(dt*momentInertiaInverse)))\n", " \n", " \n", " #x=temp.x*10000000000\n", " #y=temp.y*10000000000\n", " #z=temp.z*10000000000\n", " #@cuprintln(\"temp x $x, y $y, z $z \")\n", " \n", " @inbounds N_orient[i]=multiplyQuaternions(temp,N_orient[i])\n", " \n", " #@inbounds x= N_orient[i].x*temp.x\n", " #@inbounds y= N_orient[i].y*temp.y\n", " #@inbounds z= N_orient[i].z*temp.z\n", " #@inbounds w= N_orient[i].w*temp.w\n", " #x=convert(Float64,x)\n", " #y=convert(Float64,y)\n", " #z=convert(Float64,z)\n", " #w=convert(Float64,w)\n", " \n", " #@inbounds N_orient[i]=Quaternion(x,y,z,w)\n", " \n", " #x=N_orient[i].x*10000000000\n", " #y=N_orient[i].y*10000000000\n", " #z=N_orient[i].z*10000000000\n", " #w=N_orient[i].w\n", " #@cuprintln(\"N_orient x $x, y $y, z $z, w $w \")\n", " \n", " \n", " end\n", " end\n", " return\n", "end\n", "\n", "\n", "function run_updateNodes!(dt,currentTimeStep,N_position, N_restrained,N_displacement, N_angle,N_currPosition,N_linMom,N_angMom,N_intForce,N_intMoment,N_force,N_moment,N_orient,N_edgeID,N_edgeFirst,E_intForce1,E_intMoment1,E_intForce2,E_intMoment2)\n", " N=length(N_intForce)\n", " numblocks = ceil(Int, N/256)\n", " CuArrays.@sync begin\n", " @cuda threads=256 blocks=numblocks updateNodes!(dt,currentTimeStep,N_position, N_restrained,N_displacement, N_angle,N_currPosition,N_linMom,N_angMom,N_intForce,N_intMoment,N_force,N_moment,N_orient,N_edgeID,N_edgeFirst,E_intForce1,E_intMoment1,E_intForce2,E_intMoment2)\n", " end\n", "end" ] }, { "cell_type": "code", "execution_count": 8, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "orientLink! (generic function with 1 method)" ] }, "execution_count": 8, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function orientLink!(currentRestLength,pVNeg,pVPos,oVNeg,oVPos,axis) # updates pos2, angle1, angle2, and smallAngle //Quat3D<double> /*double restLength*/\n", " \n", " pos2 = toAxisXVector3(pVPos-pVNeg,axis) # digit truncation happens here...\n", " angle1 = toAxisXQuat(oVNeg,axis)\n", " angle2 = toAxisXQuat(oVPos,axis)\n", " \n", " #x=pos2.x*10000000000\n", " #y=pos2.y*10000000000\n", " #z=pos2.z*10000000000\n", " #@cuprintln(\"pos2 x $x, y $y, z $z \")\n", " \n", " #x=angle1.x*10000000000\n", " #y=angle1.y*10000000000\n", " #z=angle1.z*10000000000\n", " #@cuprintln(\"angle1 x $x, y $y, z $z \")\n", " #x=oVNeg.x*10000000000\n", " #y=oVNeg.y*10000000000\n", " #z=oVNeg.z*10000000000\n", " #@cuprintln(\"oVNeg x $x, y $y, z $z \")\n", " \n", " \n", " \n", " totalRot = conjugate(angle1) #keep track of the total rotation of this bond (after toAxisX()) # Quat3D<double>\n", " pos2 = RotateVec3D(totalRot,pos2)\n", " \n", " #x=pos2.x*10000000000\n", " #y=pos2.y*10000000000\n", " #z=pos2.z*10000000000\n", " #@cuprintln(\"pos2 2 x $x, y $y, z $z \")\n", " \n", " \n", " #x=totalRot.x*10000000000\n", " #y=totalRot.y*10000000000\n", " #z=totalRot.z*10000000000\n", " #@cuprintln(\"totalRot x $x, y $y, z $z \")\n", " \n", " \n", "# x=pos2.x*10000000000\n", "# y=pos2.y*10000000000\n", "# z=pos2.z*10000000000\n", "# @cuprintln(\"pos2 x $x, y $y, z $z \")\n", " \n", " angle2 = Quaternion(angle2.x*totalRot.x,angle2.y*totalRot.y,angle2.z*totalRot.z,angle2.w*totalRot.w)\n", " angle1 = Quaternion(0.0,0.0,0.0,1.0)#new THREE.Quaternion() #zero for now...\n", "\n", " smallAngle=true #todo later remove\n", " \n", " \n", " if (smallAngle)\t #Align so Angle1 is all zeros\n", " #pos2[1] =pos2[1]- currentRestLength #only valid for small angles\n", " pos2=Vector3(pos2.x-currentRestLength,pos2.y,pos2.z)\n", " else #Large angle. Align so that Pos2.y, Pos2.z are zero.\n", " # FromAngleToPosX(angle1,pos2) #get the angle to align Pos2 with the X axis\n", " # totalRot = angle1.clone().multiply(totalRot) #update our total rotation to reflect this\n", " # angle2 = angle1.clone().multiply( angle2) #rotate angle2\n", " # pos2 = new THREE.Vector3(pos2.length() - currentRestLength, 0, 0);\n", " end\n", " \n", " angle1v = ToRotationVector(angle1)\n", " angle2v = ToRotationVector(angle2)\n", " \n", " \n", " \n", " \n", "# pos2,angle1v,angle2v,angle1,angle2,\n", " return pos2,angle1v,angle2v,angle1,angle2,totalRot\n", "end" ] }, { "cell_type": "code", "execution_count": 9, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "toAxisOriginalQuat (generic function with 1 method)" ] }, "execution_count": 9, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function toAxisXVector3(pV::Vector3,axis::Vector3) #TODO CHANGE\n", "\n", " xaxis=Vector3(1.0,0.0,0.0)\n", "\n", " vector=normalizeVector3(axis)\n", " q=setFromUnitVectors(vector,xaxis)\n", " \n", " \n", " \n", "# rot=setFromRotationMatrix(quatToMatrix( q ))\n", " \n", " \n", "# v= applyQuaternion1( pV ,setQuaternionFromEuler(rot) )\n", " v=applyQuaternion1( pV ,q )\n", " \n", " #d=15\n", " #vx=round(v.x, digits=d)\n", " #vy=round(v.y, digits=d)\n", " #vz=round(v.z, digits=d)\n", " \n", " \n", " return Vector3(v.x,v.y,v.z)\n", "end\n", "\n", "function toAxisOriginalVector3(pV::Vector3,axis::Vector3)\n", " \n", " xaxis=Vector3(1.0,0.0,0.0)\n", "\n", " vector=normalizeVector3(axis)\n", "\n", " q=setFromUnitVectors(xaxis,vector)\n", " \n", "\n", "# rot=setFromRotationMatrix(quatToMatrix( q ))\n", "\n", "# v= applyQuaternion1( pV ,setQuaternionFromEuler(rot) )\n", " v=applyQuaternion1( pV ,q )\n", " \n", " #d=15\n", " #vx=round(v.x, digits=d)\n", " #vy=round(v.y, digits=d)\n", " #vz=round(v.z, digits=d)\n", " \n", " \n", " return Vector3(v.x,v.y,v.z)\n", "end\n", "\n", "function toAxisXQuat(pQ::Quaternion,axis::Vector3)\n", " \n", " xaxis=Vector3(1.0,0.0,0.0)\n", "\n", " vector=normalizeVector3(axis)\n", "\n", "\n", " q=setFromUnitVectors(vector,xaxis)\n", " \n", " #d=17\n", " #qw=round(q[1], digits=d)\n", " #qx=round(q[2], digits=d)\n", " #qy=round(q[3], digits=d)\n", " #qz=round(q[4], digits=d)\n", " #\n", "\n", "# rot=setFromRotationMatrix(quatToMatrix( q ))\n", " \n", " pV=Vector3(pQ.x,pQ.y,pQ.z)\n", " \n", "# v=applyQuaternion1( pV ,setQuaternionFromEuler(rot) )\n", " v=applyQuaternion1( pV ,q )\n", " \n", " #d=15\n", " #vx=round(v.x, digits=d)\n", " #vy=round(v.y, digits=d)\n", " #vz=round(v.z, digits=d)\n", " \n", " return Quaternion(v.x,v.y,v.z,1.0)\n", " \n", " # return [1.0 v[1] v[2] v[3]]\n", "end\n", "\n", "function toAxisOriginalQuat(pQ::Vector3,axis::Vector3)\n", " xaxis=Vector3(1.0,0.0,0.0)\n", "\n", " vector=normalizeVector3(axis)\n", " \n", " q=setFromUnitVectors(xaxis,vector)\n", " \n", "\n", "# rot=setFromRotationMatrix(quatToMatrix( q ))\n", " \n", " pV=Vector3(pQ.x,pQ.y,pQ.z)\n", "# v=applyQuaternion1( pV ,setQuaternionFromEuler(rot) )\n", " v=applyQuaternion1( pV ,q )\n", " \n", " #d=15\n", " #vx=round(v.x, digits=d)\n", " #vy=round(v.y, digits=d)\n", " #vz=round(v.z, digits=d)\n", " \n", " return Quaternion(v.x,v.y,v.z,1.0)\n", " \n", "end" ] }, { "cell_type": "code", "execution_count": 10, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "applyQuaternion1 (generic function with 1 method)" ] }, "execution_count": 10, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function setFromUnitVectors(vFrom::Vector3, vTo::Vector3)\n", " # assumes direction vectors vFrom and vTo are normalized\n", " EPS = 0.000000001;\n", " r= dotVector3(vFrom,vTo)+1.0\n", " # r = dot(vFrom,vTo)+1\n", "\n", " if r < EPS\n", " r = 0;\n", " if abs( vFrom.x ) > abs( vFrom.z ) \n", " qx = - vFrom.y\n", " qy = vFrom.x\n", " qz = 0.0\n", " qw = r\n", " else \n", " qx = 0.0\n", " qy = -(vFrom.z)\n", " qz = vFrom.y\n", " qw = r\n", " end\n", " else \n", " # crossVectors( vFrom, vTo ); // inlined to avoid cyclic dependency on Vector3\n", " qx = vFrom.y * vTo.z - vFrom.z * vTo.y\n", " qy = vFrom.z * vTo.x - vFrom.x * vTo.z\n", " qz = vFrom.x * vTo.y - vFrom.y * vTo.x\n", " qw = r\n", "\n", " end\n", " qx= (qx==-0.0) ? 0.0 : qx\n", " qy= (qy==-0.0) ? 0.0 : qy\n", " qz= (qz==-0.0) ? 0.0 : qz\n", " qw= (qw==-0.0) ? 0.0 : qw\n", " \n", " \n", " mx=qx*qx\n", " my=qy*qy\n", " mz=qz*qz\n", " mw=qw*qw\n", " mm=mx+my\n", " mm=mm+mz\n", " mm=mm+mw\n", " mm=convert(Float64,mm)#??????????????????? todo check later\n", " \n", " l=CUDAnative.sqrt(mm)\n", " \n", " #l = sqrt((qx * qx) + (qy * qy) + (qz * qz)+ (qw * qw))\n", " if l === 0 \n", " qx = 0.0\n", " qy = 0.0\n", " qz = 0.0\n", " qw = 1.0\n", " else \n", " l = 1.0 / l\n", " qx = qx * l\n", " qy = qy * l\n", " qz = qz * l\n", " qw = qw * l\n", " end\n", " \n", " \n", "\n", " # return qx,qy,qz,qw\n", " return Quaternion(qx,qy,qz,qw)\n", " \n", " # return normalizeQ(Quat(qw,qx,qy,qz))\n", " # return Quat(nn[1], nn[2], nn[3], nn[4])\n", "\n", "end\n", "\n", "function quatToMatrix( quaternion::Quaternion)\n", "\n", " #te = RotationMatrix()\n", " \n", " x = quaternion.x\n", " y = quaternion.y\n", " z = quaternion.z\n", " w = quaternion.w\n", " \n", " x2 = x + x\n", " y2 = y + y\n", " z2 = z + z\n", " xx = x * x2\n", " xy = x * y2\n", " xz = x * z2\n", " yy = y * y2\n", " yz = y * z2\n", " zz = z * z2\n", " wx = w * x2\n", " wy = w * y2\n", " wz = w * z2\n", "\n", " sx = 1.0\n", " sy = 1.0\n", " sz = 1.0\n", "\n", " te1 = ( 1.0 - ( yy + zz ) ) * sx\n", " te2 = ( xy + wz ) * sx\n", " te3 = ( xz - wy ) * sx\n", " te4 = 0.0\n", "\n", " te5 = ( xy - wz ) * sy\n", " te6 = ( 1.0 - ( xx + zz ) ) * sy\n", " te7 = ( yz + wx ) * sy\n", " te8 = 0.0\n", "\n", " te9 = ( xz + wy ) * sz\n", " te10 = ( yz - wx ) * sz\n", " te11 = ( 1.0 - ( xx + yy ) ) * sz\n", " te12 = 0.0\n", "\n", " te13 = 0.0 #position.x;\n", " te14 = 0.0 #position.y;\n", " te15 = 0.0 #position.z;\n", " te16 = 1.0\n", " \n", " \n", " te= RotationMatrix(te1,te2,te3,te4,te5,te6,te7,te8,te9,te10,te11,te12,te13,te14,te15,te16)\n", "\n", " return te\n", "\n", "end\n", "\n", "function setFromRotationMatrix(m::RotationMatrix)\n", " #te = m\n", " #m11 = (te[ 1 ]== -0.0) ? 0.0 : te[ 1 ]\n", " #m12 = (te[ 5 ]== -0.0) ? 0.0 : te[ 5 ]\n", " #m13 = (te[ 9 ]== -0.0) ? 0.0 : te[ 9 ]\n", " #m21 = (te[ 2 ]== -0.0) ? 0.0 : te[ 2 ]\n", " #m22 = (te[ 6 ]== -0.0) ? 0.0 : te[ 6 ]\n", " #m23 = (te[ 10]== -0.0) ? 0.0 : te[ 10]\n", " #m31 = (te[ 3 ]== -0.0) ? 0.0 : te[ 3 ]\n", " #m32 = (te[ 7 ]== -0.0) ? 0.0 : te[ 7 ]\n", " #m33 = (te[ 11]== -0.0) ? 0.0 : te[ 11]\n", "\n", " m11 = convert(Float64,m.te1 )\n", " m12 = convert(Float64,m.te5 )\n", " m13 = convert(Float64,m.te9 )\n", " m21 = convert(Float64,m.te2 )\n", " m22 = convert(Float64,m.te6 )\n", " m23 = convert(Float64,m.te10)\n", " m31 = convert(Float64,m.te3 )\n", " m32 = convert(Float64,m.te7 )\n", " m33 = convert(Float64,m.te11)\n", " \n", "\n", " y = CUDAnative.asin( clamp( m13, -1.0, 1.0 ) ) ##check if has to be changed to cuda\n", "\n", " if ( abs( m13 ) < 0.9999999999 ) \n", " \n", " x = CUDAnative.atan2( - m23, m33 )\n", " z = CUDAnative.atan2( - m12, m11 )#-m12, m11\n", " # if(m23==0.0)\n", " # x = atan( m23, m33 )\n", " # end\n", " # if(m12==0.0)\n", " # z = atan( m12, m11 )\n", " # end\n", "\n", " else\n", "\n", " x = CUDAnative.atan2( m32, m22 )\n", " z = 0.0;\n", "\n", " end\n", " \n", " \n", " return Vector3(x,y,z)\n", " \n", "end\n", "\n", "function setQuaternionFromEuler(euler::Vector3)\n", " x=euler.x\n", " y=euler.y\n", " z=euler.z\n", " \n", " \n", " c1 = CUDAnative.cos( x / 2.0 )\n", " c2 = CUDAnative.cos( y / 2.0 )\n", " c3 = CUDAnative.cos( z / 2.0 )\n", "\n", " s1 = CUDAnative.sin( x / 2.0 )\n", " s2 = CUDAnative.sin( y / 2.0 )\n", " s3 = CUDAnative.sin( z / 2.0 )\n", " \n", " \n", " x = s1 * c2 * c3 + c1 * s2 * s3\n", " y = c1 * s2 * c3 - s1 * c2 * s3\n", " z = c1 * c2 * s3 + s1 * s2 * c3\n", " w = c1 * c2 * c3 - s1 * s2 * s3\n", " \n", " return Quaternion(x,y,z,w)\n", "end\n", "\n", "function applyQuaternion1(e::Vector3,q2::Quaternion)\n", " x = e.x\n", " y = e.y\n", " z = e.z\n", "\n", " qx = q2.x\n", " qy = q2.y\n", " qz = q2.z\n", " qw = q2.w\n", "\n", " # calculate quat * vector\n", "\n", " ix = qw * x + qy * z - qz * y\n", " iy = qw * y + qz * x - qx * z\n", " iz = qw * z + qx * y - qy * x\n", " iw = - qx * x - qy * y - qz * z\n", "\n", " # calculate result * inverse quat\n", "\n", " xx = ix * qw + iw * - qx + iy * - qz - iz * - qy\n", " yy = iy * qw + iw * - qy + iz * - qx - ix * - qz\n", " zz = iz * qw + iw * - qz + ix * - qy - iy * - qx\n", " \n", " d=15\n", "\n", " return Vector3(xx,yy,zz)\n", "end\n" ] }, { "cell_type": "code", "execution_count": 11, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "multiplyQuaternions (generic function with 1 method)" ] }, "execution_count": 11, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function conjugate(q::Quaternion)\n", " x= (-q.x==-0) ? 0.0 : -q.x\n", " y= (-q.y==-0) ? 0.0 : -q.y\n", " z= (-q.z==-0) ? 0.0 : -q.z\n", " w=q.w\n", " x=convert(Float64,x)\n", " y=convert(Float64,y)\n", " z=convert(Float64,z)\n", " w=convert(Float64,w)\n", " return Quaternion(x,y,z,w)\n", "end\n", "\n", "function RotateVec3D(a::Quaternion, f::Vector3) \n", " fx= (f.x==-0) ? 0 : f.x\n", " fy= (f.y==-0) ? 0 : f.y\n", " fz= (f.z==-0) ? 0 : f.z\n", " # fx= f.x\n", " # fy= f.y\n", " # fz= f.z\n", " tw = fx*a.x + fy*a.y + fz*a.z\n", " tx = fx*a.w - fy*a.z + fz*a.y\n", " ty = fx*a.z + fy*a.w - fz*a.x\n", " tz = -fx*a.y + fy*a.x + fz*a.w\n", "\n", " return Vector3((a.w*tx+a.x*tw+a.y*tz-a.z*ty),(a.w*ty-a.x*tz+a.y*tw+a.z*tx),(a.w*tz+a.x*ty-a.y*tx+a.z*tw))\n", "end\n", "#!< Returns a vector representing the specified vector \"f\" rotated by this quaternion. @param[in] f The vector to transform.\n", "\n", "function RotateVec3DInv(a::Quaternion, f::Vector3) \n", " fx=f.x\n", " fy=f.y\n", " fz=f.z\n", " tw = a.x*fx + a.y*fy + a.z*fz\n", " tx = a.w*fx - a.y*fz + a.z*fy\n", " ty = a.w*fy + a.x*fz - a.z*fx\n", " tz = a.w*fz - a.x*fy + a.y*fx\n", " return Vector3((tw*a.x + tx*a.w + ty*a.z - tz*a.y),(tw*a.y - tx*a.z + ty*a.w + tz*a.x),(tw*a.z + tx*a.y - ty*a.x + tz*a.w))\n", "end\n", "#!< Returns a vector representing the specified vector \"f\" rotated by the inverse of this quaternion. This is the opposite of RotateVec3D. @param[in] f The vector to transform.\n", "\n", "function ToRotationVector(a::Quaternion) \n", " if (a.w >= 1.0 || a.w <= -1.0) \n", " return Vector3(0.0,0.0,0.0)\n", " end\n", " squareLength = 1.0-a.w*a.w; # because x*x + y*y + z*z + w*w = 1.0, but more susceptible to w noise (when \n", " SLTHRESH_ACOS2SQRT= 2.4e-3; # SquareLength threshhold for when we can use square root optimization for acos. From SquareLength = 1-w*w. (calculate according to 1.0-W_THRESH_ACOS2SQRT*W_THRESH_ACOS2SQRT\n", "\n", " if (squareLength < SLTHRESH_ACOS2SQRT) # ???????\n", " x=a.x*(2.0*CUDAnative.sqrt((2-2*a.w)/squareLength))\n", " y=a.y*(2.0*CUDAnative.sqrt((2-2*a.w)/squareLength))\n", " z=a.z*(2.0*CUDAnative.sqrt((2-2*a.w)/squareLength))\n", " x=convert(Float64,x)\n", " y=convert(Float64,y)\n", " z=convert(Float64,z)\n", " \n", " return Vector3(x,y,z) ; # acos(w) = sqrt(2*(1-x)) for w close to 1. for w=0.001, error is 1.317e-6\n", " else \n", " x=a.x*(2.0*CUDAnative.acos(a.w)/CUDAnative.sqrt(squareLength))\n", " y=a.y*(2.0*CUDAnative.acos(a.w)/CUDAnative.sqrt(squareLength))\n", " z=a.z*(2.0*CUDAnative.acos(a.w)/CUDAnative.sqrt(squareLength))\n", " x=convert(Float64,x)\n", " y=convert(Float64,y)\n", " z=convert(Float64,z)\n", "\n", " return Vector3(x,y,z)\n", " end \n", "end \n", "# !< Returns a rotation vector representing this quaternion rotation. Adapted from http://www.euclideanspace.com/maths/geometry/rotations/conversions/quaternionToAngle/\n", "\n", "function FromRotationVector(VecIn::Vector3)\n", " theta=VecIn*Vector3(0.5,0.5,0.5)\n", " ntheta=CUDAnative.sqrt((theta.x * theta.x) + (theta.y * theta.y) + (theta.z * theta.z))\n", " thetaMag2=ntheta*ntheta\n", " \n", " DBL_EPSILONx24 =5.328e-15\n", " if thetaMag2*thetaMag2 < DBL_EPSILONx24\n", " qw=1.0 - 0.5*thetaMag2\n", "\t\ts=1.0 - thetaMag2 / 6.0\n", " else\n", " thetaMag = CUDAnative.sqrt(thetaMag2)\n", "\t\tqw=CUDAnative.cos(thetaMag)\n", "\t\ts=CUDAnative.sin(thetaMag) / thetaMag\n", " end\n", " qx=theta.x*s\n", " qy=theta.y*s\n", " qz=theta.z*s\n", " \n", " qx=convert(Float64,qx)\n", " qy=convert(Float64,qy)\n", " qz=convert(Float64,qz)\n", " qw=convert(Float64,qw)\n", " \n", " return Quaternion(qx,qy,qz,qw)\n", "end\n", "\n", "function multiplyQuaternions(q::Quaternion,f::Quaternion)\n", " x=q.x\n", " y=q.y\n", " z=q.z\n", " w=q.w\n", " x1=w*f.x + x*f.w + y*f.z - z*f.y \n", " y1=w*f.y - x*f.z + y*f.w + z*f.x\n", " z1=w*f.z + x*f.y - y*f.x + z*f.w\n", " w1=w*f.w - x*f.x - y*f.y - z*f.z\n", "# x1=convert(Float64,x1)\n", "# y1=convert(Float64,y1)\n", "# z1=convert(Float64,z1)\n", "# w1=convert(Float64,w1)\n", "\treturn Quaternion(x1,y1,z1,w1 ); #!< overload quaternion multiplication.\n", "end\n" ] }, { "cell_type": "code", "execution_count": 12, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "axialStrain (generic function with 1 method)" ] }, "execution_count": 12, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function updateStrain( axialStrain,E) # ?from where strain\n", " strain = axialStrain # redundant?\n", " currentTransverseStrainSum=0.0 # ??? todo\n", " linear=true\n", " maxStrain=1000000000000000;# ?? todo later change\n", " if linear\n", " if axialStrain > maxStrain\n", " maxStrain = axialStrain # remember this maximum for easy reference\n", " end\n", " return stress(axialStrain,E)\n", " else \n", " if (axialStrain > maxStrain) # if new territory on the stress/strain curve\n", " maxStrain = axialStrain # remember this maximum for easy reference\n", " returnStress = stress(axialStrain,E) # ??currentTransverseStrainSum\n", " if (nu != 0.0) \n", " strainOffset = maxStrain-stress(axialStrain,E)/(_eHat*(1.0-nu)) # precalculate strain offset for when we back off\n", " else \n", " strainOffset = maxStrain-returnStress/E # precalculate strain offset for when we back off\n", " end\n", " else # backed off a non-linear material, therefore in linear region.\n", " relativeStrain = axialStrain-strainOffset # treat the material as linear with a strain offset according to the maximum plastic deformation\n", " if (nu != 0.0) \n", " returnStress = stress(relativeStrain,E)\n", " else \n", " returnStress = E*relativeStrain\n", " end\n", " end\n", " return returnStress\n", " end\n", "end\n", "\n", "function stress( strain , E ) #end,transverseStrainSum, forceLinear){\n", " # reference: http://www.colorado.edu/engineering/CAS/courses.d/Structures.d/IAST.Lect05.d/IAST.Lect05.pdf page 10\n", " # if (isFailed(strain)) return 0.0f; //if a failure point is set and exceeded, we've broken!\n", " # var E =setup.edges[0].stiffness; //todo change later to material ??\n", " # var E=1000000;//todo change later to material ??\n", " # var scaleFactor=1;\n", " return E*strain;\n", "\n", " # # if (strain <= strainData[1] || linear || forceLinear){ //for compression/first segment and linear materials (forced or otherwise), simple calculation\n", "\n", " # if (nu==0.0) return E*strain;\n", " # else return _eHat*((1-nu)*strain + nu*transverseStrainSum); \n", " # else return eHat()*((1-nu)*strain + nu*transverseStrainSum); \n", " # # }\n", "\n", " #//the non-linear feature with non-zero poissons ratio is currently experimental\n", " #int DataCount = modelDataPoints();\n", " #for (int i=2; i<DataCount; i++){ //go through each segment in the material model (skipping the first segment because it has already been handled.\n", " # if (strain <= strainData[i] || i==DataCount-1){ //if in the segment ending with this point (or if this is the last point extrapolate out) \n", " # float Perc = (strain-strainData[i-1])/(strainData[i]-strainData[i-1]);\n", " # float basicStress = stressData[i-1] + Perc*(stressData[i]-stressData[i-1]);\n", " # if (nu==0.0f) return basicStress;\n", " # else { //accounting for volumetric effects\n", " # float modulus = (stressData[i]-stressData[i-1])/(strainData[i]-strainData[i-1]);\n", " # float modulusHat = modulus/((1-2*nu)*(1+nu));\n", " # float effectiveStrain = basicStress/modulus; //this is the strain at which a simple linear stress strain line would hit this point at the definied modulus\n", " # float effectiveTransverseStrainSum = transverseStrainSum*(effectiveStrain/strain);\n", " # return modulusHat*((1-nu)*effectiveStrain + nu*effectiveTransverseStrainSum);\n", " # }\n", " # }\n", " #}\n", "\n", " # assert(false); //should never reach this point\n", " # return 0.0f;\n", "end \n", "\n", "function axialStrain( positiveEnd,strain)\n", "\t#strainRatio = pVPos->material()->E/pVNeg->material()->E;\n", "\tstrainRatio=1.0;\n", "\treturn positiveEnd ? 2.0 *strain*strainRatio/(1.0+strainRatio) : 2.0*strain/(1.0+strainRatio)\n", "end" ] }, { "cell_type": "code", "execution_count": 13, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "moment (generic function with 1 method)" ] }, "execution_count": 13, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function force(N_intForce,N_orient,N_force,static,currentTimeStep) \n", " # forces from internal bonds\n", " totalForce=Vector3(0,0,0)\n", " # new THREE.Vector3(node.force.x,node.force.y,node.force.z);\n", " # todo \n", "\n", "\n", " totalForce=totalForce+N_intForce\n", "\n", " # for (int i=0; i<6; i++){ \n", " # \tif (links[i]) totalForce += links[i]->force(isNegative((linkDirection)i)); # total force in LCS\n", " # }\n", " totalForce = RotateVec3D(N_orient,totalForce); # from local to global coordinates\n", "\n", "\n", " # assert(!(totalForce.x != totalForce.x) || !(totalForce.y != totalForce.y) || !(totalForce.z != totalForce.z)); //assert non QNAN\n", "\n", " # other forces\n", " if(static)\n", " totalForce=totalForce+N_force\n", " # }else if(currentTimeStep<50){\n", " # \ttotalForce.add(new THREE.Vector3(node.force.x,node.force.y,node.force.z));\n", " else\n", " # var ex=0.1;\n", " # if(node.force.y!=0){\n", " # \tvar f=400*Math.sin(currentTimeStep*ex);\n", " # \ttotalForce.add(new THREE.Vector3(0,f,0));\n", "\n", " # }\n", " #x=N_position[node][3]\n", " #t=currentTimeStep\n", " #wave=getForce(x,t)\n", " #totalForce=totalForce+[0 wave 0]\n", " end\n", "\n", "\n", " # if (externalExists()) totalForce += external()->force(); //external forces\n", " # totalForce -= velocity()*mat->globalDampingTranslateC(); //global damping f-cv\n", " # totalForce.z += mat->gravityForce(); //gravity, according to f=mg\n", "\n", " # if (isCollisionsEnabled()){\n", " # \tfor (std::vector<CVX_Collision*>::iterator it=colWatch->begin(); it!=colWatch->end(); it++){\n", " # \t\ttotalForce -= (*it)->contactForce(this);\n", " # \t}\n", " # }\n", " # todo make internal forces 0 again\n", " # N_intForce[node]=[0 0 0] # do i really need it?\n", "\n", " # node.force.x=0;\n", " # node.force.y=0;\n", " # node.force.z=0;\n", "\n", "\n", " return totalForce\n", "end\n", "\n", "\n", "function moment(intMoment,orient,moment) \n", " #moments from internal bonds\n", " totalMoment=Vector3(0,0,0)\n", " # for (int i=0; i<6; i++){ \n", " # \tif (links[i]) totalMoment += links[i]->moment(isNegative((linkDirection)i)); //total force in LCS\n", " # }\n", "\n", " totalMoment=totalMoment+intMoment\n", " \n", " \n", "\n", " totalMoment = RotateVec3D(orient,totalMoment);\n", " \n", " \n", "\n", " totalMoment=totalMoment+moment\n", "\n", "\n", " #other moments\n", " # if (externalExists()) totalMoment += external()->moment(); //external moments\n", " # totalMoment -= angularVelocity()*mat->globalDampingRotateC(); //global damping\n", "\n", " return totalMoment\n", "end" ] }, { "cell_type": "code", "execution_count": 14, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "updateDataAndSaveFEA! (generic function with 1 method)" ] }, "execution_count": 14, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function updateDataAndSaveFEA!(setup,fileName)\n", "# nodes = setup[\"nodes\"]\n", "# edges = setup[\"edges\"]\n", " \n", "# setup[\"animation\"][\"showDisplacement\"]=false\n", "# voxCount=size(nodes)[1]\n", "# linkCount=size(edges)[1]\n", " \n", "# N_displacement=Array(metavoxel[\"N_displacementGPU\"])\n", "# N_angle=Array(metavoxel[\"N_angleGPU\"])\n", "# E_stress=Array(metavoxel[\"E_stressGPU\"])\n", " \n", "# setup[\"viz\"][\"maxStress\"]=maximum(E_stress)\n", "# setup[\"viz\"][\"minStress\"]=minimum(E_stress) \n", "\n", "\n", "# i=1\n", "# \tfor edge in edges\n", "# edge[\"stress\"]=E_stress[i]\n", "# i=i+1\n", "\n", "# end\n", " \n", " \n", "# i=1 \n", "# \tfor node in nodes\n", "# node[\"displacement\"][\"x\"]=N_displacement[i].x*100\n", "# node[\"displacement\"][\"y\"]=N_displacement[i].y*100\n", "# node[\"displacement\"][\"z\"]=N_displacement[i].z*100\n", " \n", "# node[\"angle\"][\"x\"]=N_angle[i].x\n", "# node[\"angle\"][\"y\"]=N_angle[i].y\n", "# node[\"angle\"][\"z\"]=N_angle[i].z\n", "# i=i+1\n", "\n", "# end\n", " \n", " # pass data as a json string (how it shall be displayed in a file)\n", " stringdata = JSON.json(setup)\n", "\n", " # write the file with the stringdata variable information\n", " open(fileName, \"w\") do f\n", " write(f, stringdata)\n", " end\n", " \n", "end" ] }, { "cell_type": "code", "execution_count": 30, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "updateDataAndSave! (generic function with 1 method)" ] }, "execution_count": 30, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function updateDataAndSave!(metavoxel,setup,fileName)\n", " nodes = setup[\"nodes\"]\n", " edges = setup[\"edges\"]\n", " \n", " setup[\"animation\"][\"showDisplacement\"]=true\n", " voxCount=size(nodes)[1]\n", " linkCount=size(edges)[1]\n", " \n", " N_displacement=Array(metavoxel[\"N_displacementGPU\"])\n", " N_angle=Array(metavoxel[\"N_angleGPU\"])\n", " E_stress=Array(metavoxel[\"E_stressGPU\"])\n", " \n", " setup[\"viz\"][\"maxStress\"]=maximum(E_stress)\n", " setup[\"viz\"][\"minStress\"]=minimum(E_stress) \n", "\n", "\n", " i=1\n", "\tfor edge in edges\n", " edge[\"stress\"]=E_stress[i]\n", " i=i+1\n", "\n", " end\n", " \n", " \n", " i=1 \n", "\tfor node in nodes\n", " node[\"displacement\"][\"x\"]=N_displacement[i].x/15\n", " node[\"displacement\"][\"y\"]=N_displacement[i].y/15\n", " node[\"displacement\"][\"z\"]=N_displacement[i].z/15\n", " \n", " node[\"angle\"][\"x\"]=N_angle[i].x\n", " node[\"angle\"][\"y\"]=N_angle[i].y\n", " node[\"angle\"][\"z\"]=N_angle[i].z\n", " i=i+1\n", "\n", " end\n", " \n", " # pass data as a json string (how it shall be displayed in a file)\n", " stringdata = JSON.json(setup)\n", "\n", " # write the file with the stringdata variable information\n", " open(fileName, \"w\") do f\n", " write(f, stringdata)\n", " end\n", " \n", "end" ] }, { "cell_type": "code", "execution_count": 31, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "runMetavoxelGPU! (generic function with 1 method)" ] }, "execution_count": 31, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function runMetavoxelGPU!(setup,numTimeSteps,latticeSize,displacements,returnEvery,save)\n", " function initialize!(setup)\n", " nodes = setup[\"nodes\"]\n", " edges = setup[\"edges\"]\n", "\n", " i=1\n", " # pre-calculate current position\n", " for node in nodes\n", " # element=parse(Int,node[\"id\"][2:end])\n", " N_position[i]=Vector3(node[\"position\"][\"x\"]*15.0,node[\"position\"][\"y\"]*15.0,node[\"position\"][\"z\"]*15.0)\n", " N_restrained[i]=node[\"restrained_degrees_of_freedom\"][1] ## todo later consider other degrees of freedom\n", " N_displacement[i]=Vector3(node[\"displacement\"][\"x\"]*15,node[\"displacement\"][\"y\"]*15,node[\"displacement\"][\"z\"]*15)\n", " N_angle[i]=Vector3(node[\"angle\"][\"x\"],node[\"angle\"][\"y\"],node[\"angle\"][\"z\"])\n", " N_force[i]=Vector3(node[\"force\"][\"x\"],node[\"force\"][\"y\"],node[\"force\"][\"z\"])\n", " N_currPosition[i]=Vector3(node[\"position\"][\"x\"]*15.0,node[\"position\"][\"y\"]*15.0,node[\"position\"][\"z\"]*15.0)\n", "\n", " # for dynamic simulations\n", " # append!(N_posTimeSteps,[[]])\n", " # append!(N_angTimeSteps,[[]])\n", "\n", " i=i+1\n", " end \n", "\n", " i=1\n", " # pre-calculate the axis\n", " for edge in edges\n", " # element=parse(Int,edge[\"id\"][2:end])\n", "\n", " # find the nodes that the lements connects\n", " fromNode = nodes[edge[\"source\"]+1]\n", " toNode = nodes[edge[\"target\"]+1]\n", "\n", "\n", " node1 = [fromNode[\"position\"][\"x\"]*15.0 fromNode[\"position\"][\"y\"]*15.0 fromNode[\"position\"][\"z\"]*15.0]\n", " node2 = [toNode[\"position\"][\"x\"]*15.0 toNode[\"position\"][\"y\"]*15.0 toNode[\"position\"][\"z\"]*15.0]\n", "\n", " length=norm(node2-node1)\n", " axis=normalize(collect(Iterators.flatten(node2-node1)))\n", "\n", " E_source[i]=edge[\"source\"]+1\n", " E_target[i]=edge[\"target\"]+1\n", " E_area[i]=edge[\"area\"]\n", " E_density[i]=edge[\"density\"]\n", " E_stiffness[i]=edge[\"stiffness\"]\n", " E_axis[i]=Vector3(axis[1],axis[2],axis[3])\n", " E_currentRestLength[i]=length #?????? todo change\n", "# E_currentRestLength[i]=75/sqrt(2)\n", " \n", "\n", " N_edgeID[E_source[i],N_currEdge[E_source[i]]]=i\n", " N_edgeFirst[E_source[i],N_currEdge[E_source[i]]]=true\n", " N_currEdge[E_source[i]]+=1\n", "\n", " N_edgeID[E_target[i],N_currEdge[E_target[i]]]=i\n", " N_edgeFirst[E_target[i],N_currEdge[E_target[i]]]=false\n", " N_currEdge[E_target[i]]+=1\n", "\n", "\n", " # for dynamic simulations\n", " # append!(E_stressTimeSteps,[[]])\n", "\n", " i=i+1\n", " end \n", " end\n", " function simulateParallel!(metavoxel,numTimeSteps,dt,returnEvery)\n", " # initialize(setup)\n", "\n", " for i in 1:numTimeSteps\n", " #println(\"Timestep:\",i)\n", " doTimeStep!(metavoxel,dt,i)\n", " if(mod(i,returnEvery)==0)\n", " append!(displacements,[Array(metavoxel[\"N_displacementGPU\"])])\n", " end\n", " end\n", " end\n", " \n", " ########\n", " voxCount=0\n", " linkCount=0\n", " nodes = setup[\"nodes\"]\n", " edges = setup[\"edges\"]\n", " voxCount=size(nodes)[1]\n", " linkCount=size(edges)[1]\n", " strain =0 #todooo moveeee\n", " maxNumEdges=10\n", "\n", " ########\n", " voxCount=0\n", " linkCount=0\n", " nodes = setup[\"nodes\"]\n", " edges = setup[\"edges\"]\n", " voxCount=size(nodes)[1]\n", " linkCount=size(edges)[1]\n", " strain =0 #todooo moveeee\n", "\n", " ############# nodes\n", " N_position=fill(Vector3(),voxCount)\n", " N_restrained=zeros(Bool, voxCount)\n", " N_displacement=fill(Vector3(),voxCount)\n", " N_angle=fill(Vector3(),voxCount)\n", " N_currPosition=fill(Vector3(),voxCount)\n", " N_linMom=fill(Vector3(),voxCount)\n", " N_angMom=fill(Vector3(),voxCount)\n", " N_intForce=fill(Vector3(),voxCount)\n", " N_intMoment=fill(Vector3(),voxCount)\n", " N_moment=fill(Vector3(),voxCount)\n", " # N_posTimeSteps=[]\n", " # N_angTimeSteps=[]\n", " N_force=fill(Vector3(),voxCount)\n", " N_orient=fill(Quaternion(),voxCount)\n", " N_edgeID=fill(-1,(voxCount,maxNumEdges))\n", " N_edgeFirst=fill(true,(voxCount,maxNumEdges))\n", " N_currEdge=fill(1,voxCount)\n", "\n", " ############# edges\n", " E_source=fill(0,linkCount)\n", " E_target=fill(0,linkCount)\n", " E_area=fill(0.0f0,linkCount)\n", " E_density=fill(0.0f0,linkCount)\n", " E_stiffness=fill(0.0f0,linkCount)\n", " E_stress=fill(0.0f0,linkCount)\n", " E_axis=fill(Vector3(1.0,0.0,0.0),linkCount)\n", " E_currentRestLength=fill(0.0f0,linkCount)\n", " E_pos2=fill(Vector3(),linkCount)\n", " E_angle1v=fill(Vector3(),linkCount)\n", " E_angle2v=fill(Vector3(),linkCount)\n", " E_angle1=fill(Quaternion(),linkCount)\n", " E_angle2=fill(Quaternion(),linkCount)\n", "\n", " E_intForce1=fill(Vector3(),linkCount)\n", " E_intMoment1=fill(Vector3(),linkCount) \n", "\n", " E_intForce2=fill(Vector3(),linkCount)\n", " E_intMoment2=fill(Vector3(),linkCount)\n", " E_damp=fill(false,linkCount)\n", "\n", " E_currentTransverseStrainSum=fill(0.0f0,linkCount)# TODO remove ot incorporate\n", " # E_stressTimeSteps=[]\n", "\n", "\n", " #################################################################\n", " initialize!(setup)\n", " #################################################################\n", "\n", " ########################## turn to cuda arrays\n", " ############# nodes\n", " N_positionGPU= CuArray(N_position) \n", " N_restrainedGPU= CuArray(N_restrained) \n", " N_displacementGPU=CuArray(N_displacement) \n", " N_angleGPU= CuArray(N_angle) \n", " N_currPositionGPU=CuArray(N_currPosition) \n", " N_linMomGPU= CuArray(N_linMom) \n", " N_angMomGPU= CuArray(N_angMom) \n", " N_intForceGPU= CuArray(N_intForce) \n", " N_intMomentGPU= CuArray(N_intMoment) \n", " N_momentGPU= CuArray(N_moment) \n", " N_forceGPU= CuArray(N_force) \n", " N_orientGPU= CuArray(N_orient) \n", " N_edgeIDGPU= CuArray(N_edgeID) \n", " N_edgeFirstGPU= CuArray(N_edgeFirst) \n", "\n", "\n", " ############# edges\n", " E_sourceGPU= CuArray(E_source) \n", " E_targetGPU= CuArray(E_target)\n", " E_areaGPU= CuArray(E_area) \n", " E_densityGPU= CuArray(E_density)\n", " E_stiffnessGPU= CuArray(E_stiffness)\n", " E_stressGPU= CuArray(E_stress)\n", " E_axisGPU= CuArray(E_axis) \n", " E_currentRestLengthGPU= CuArray(E_currentRestLength)\n", " E_pos2GPU= CuArray(E_pos2)\n", " E_angle1vGPU= CuArray(E_angle1v)\n", " E_angle2vGPU= CuArray(E_angle2v)\n", " E_angle1GPU= CuArray(E_angle1)\n", " E_angle2GPU= CuArray(E_angle2)\n", " E_currentTransverseStrainSumGPU=CuArray(E_currentTransverseStrainSum)\n", " E_intForce1GPU= CuArray(E_intForce1) \n", " E_intMoment1GPU= CuArray(E_intMoment1) \n", " E_intForce2GPU= CuArray(E_intForce2) \n", " E_intMoment2GPU= CuArray(E_intMoment2)\n", " E_dampGPU= CuArray(E_damp) \n", " # E_stressTimeSteps=[]\n", "\n", "\n", " #########################################\n", " metavoxel = Dict(\n", " \"N_positionGPU\" => N_positionGPU, \n", " \"N_restrainedGPU\" => N_restrainedGPU, \n", " \"N_displacementGPU\" => N_displacementGPU,\n", " \"N_angleGPU\" => N_angleGPU, \n", " \"N_currPositionGPU\" => N_currPositionGPU,\n", " \"N_linMomGPU\" => N_linMomGPU, \n", " \"N_angMomGPU\" => N_angMomGPU, \n", " \"N_intForceGPU\" => N_intForceGPU, \n", " \"N_intMomentGPU\" => N_intMomentGPU, \n", " \"N_momentGPU\" => N_momentGPU, \n", " \"N_forceGPU\" => N_forceGPU, \n", " \"N_orientGPU\" => N_orientGPU, \n", " \"N_edgeIDGPU\" => N_edgeIDGPU, \n", " \"N_edgeFirstGPU\" => N_edgeFirstGPU,\n", " \"E_sourceGPU\" =>E_sourceGPU, \n", " \"E_targetGPU\" =>E_targetGPU, \n", " \"E_areaGPU\" =>E_areaGPU, \n", " \"E_densityGPU\" =>E_densityGPU, \n", " \"E_stiffnessGPU\" =>E_stiffnessGPU, \n", " \"E_stressGPU\" =>E_stressGPU, \n", " \"E_axisGPU\" =>E_axisGPU, \n", " \"E_currentRestLengthGPU\" =>E_currentRestLengthGPU, \n", " \"E_pos2GPU\" =>E_pos2GPU, \n", " \"E_angle1vGPU\" =>E_angle1vGPU, \n", " \"E_angle2vGPU\" =>E_angle2vGPU, \n", " \"E_angle1GPU\" =>E_angle1GPU, \n", " \"E_angle2GPU\" =>E_angle2GPU, \n", " \"E_currentTransverseStrainSumGPU\" =>E_currentTransverseStrainSumGPU,\n", " \"E_intForce1GPU\" =>E_intForce1GPU, \n", " \"E_intMoment1GPU\" =>E_intMoment1GPU, \n", " \"E_intForce2GPU\" =>E_intForce2GPU, \n", " \"E_intMoment2GPU\" =>E_intMoment2GPU, \n", " \"E_dampGPU\" =>E_dampGPU \n", " )\n", "\n", " #########################################\n", " \n", "\n", " dt=0.0251646\n", " E = 2000 # MPa\n", " s=2.38\n", " mass=10 \n", " \n", " \n", " \n", " MaxFreq2=E*s/mass\n", " dt= 1/(6.283185*sqrt(MaxFreq2))\n", "# dt=0.0001646\n", " println(\"dt: $dt\")\n", " \n", " append!(displacements,[Array(metavoxel[\"N_displacementGPU\"])])\n", " \n", " t=@timed doTimeStep!(metavoxel,dt,0)\n", " append!(displacements,[Array(metavoxel[\"N_displacementGPU\"])])\n", " time=t[2]\n", " println(\"first timestep took $time seconds\")\n", " t=@timed simulateParallel!(metavoxel,numTimeSteps-1,dt,returnEvery)\n", " time=t[2]\n", " \n", " if save\n", " updateDataAndSave!(metavoxel,setup,\"../json/trialJuliaParallelGPU.json\")\n", " end\n", " println(\"ran latticeSize $latticeSize with $voxCount voxels and $linkCount edges for $numTimeSteps time steps took $time seconds\")\n", " return\n", "end" ] }, { "cell_type": "code", "execution_count": 32, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "fea (generic function with 1 method)" ] }, "execution_count": 32, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function fea(setup)\n", " #######################################################\n", " function points(element, properties)\n", " elements = properties[\"elements\"]\n", " nodes = properties[\"nodes\"]\n", " degrees_of_freedom = properties[\"degrees_of_freedom\"]\n", "\n", " # find the nodes that the lements connects\n", " fromNode = elements[element][1]\n", " toNode = elements[element][2]\n", "\n", " # the coordinates for each node\n", " fromPoint = nodes[fromNode]\n", " toPoint = nodes[toNode]\n", "\n", " # find the degrees of freedom for each node\n", " dofs = degrees_of_freedom[fromNode]\n", " dofs=vcat(dofs,degrees_of_freedom[toNode])\n", "\n", " return fromPoint, toPoint, dofs\n", " end\n", "\n", " function direction_cosine(vec1, vec2)\n", " return dot(vec1,vec2) / (norm(vec1) * norm(vec2))\n", " end\n", "\n", " function rotation_matrix(element_vector, x_axis, y_axis,z_axis)\n", " # find the direction cosines\n", " x_proj = direction_cosine(element_vector, x_axis)\n", " y_proj = direction_cosine(element_vector, y_axis)\n", " z_proj = direction_cosine(element_vector, z_axis);\n", " return [[x_proj y_proj z_proj 0 0 0];[0 0 0 x_proj y_proj z_proj]]\n", " end\n", "\n", " function rotation_matrix(element_vector, x_axis, y_axis,z_axis)\n", " # find the direction cosines\n", " L=norm(element_vector)\n", " l = (element_vector[1])/L\n", " m = (element_vector[2])/L\n", " n = (element_vector[3])/L\n", " D = ( l^2+ m^2+n^2)^0.5\n", "\n", " transMatrix=[[l m n 0 0 0 0 0 0 0 0 0];[-m/D l/D 0 0 0 0 0 0 0 0 0 0];[ -l*n/D -m*n/D D 0 0 0 0 0 0 0 0 0];[ 0 0 0 l m n 0 0 0 0 0 0];[ 0 0 0 -m/D l/D 0 0 0 0 0 0 0];[ 0 0 0 -l*n/D -m*n/D D 0 0 0 0 0 0];[ 0 0 0 0 0 0 l m n 0 0 0];[ 0 0 0 0 0 0 -m/D l/D 0 0 0 0];[ 0 0 0 0 0 0 -l*n/D -m*n/D D 0 0 0];[ 0 0 0 0 0 0 0 0 0 l m n];[ 0 0 0 0 0 0 0 0 0 -m/D l/D 0];[ 0 0 0 0 0 0 0 0 0 -l*n/D -m*n/D D]]\n", "\n", " return transMatrix\n", " end\n", " \n", " #######################################################\n", " function get_matrices(setup)\n", "\n", " nodes = setup[\"nodes\"]\n", " edges = setup[\"edges\"]\n", " ndofs = length(nodes)*6\n", "\n", " x_axis = [1 0 0]\n", " y_axis = [0 1 0]\n", " z_axis = [0 0 1]\n", "\n", " M = zeros((ndofs,ndofs))\n", " K = zeros((ndofs,ndofs))\n", " \n", " \n", " for edge in edges\n", " #degrees_of_freedom = properties[\"degrees_of_freedom\"]\n", "\n", " element=parse(Int,edge[\"id\"][2:end])\n", "\n", " # find the nodes that the lements connects\n", " fromNode = nodes[edge[\"source\"]+1]\n", " toNode = nodes[edge[\"target\"]+1]\n", " \n", "\n", " # the coordinates for each node\n", " fromPoint = [fromNode[\"position\"][\"x\"]*15.0 fromNode[\"position\"][\"y\"]*15.0 fromNode[\"position\"][\"z\"]*15.0]\n", " toPoint = [toNode[\"position\"][\"x\"]*15.0 toNode[\"position\"][\"y\"]*15.0 toNode[\"position\"][\"z\"]*15.0]\n", "\n", " # find the degrees of freedom for each node\n", " dofs = convert(Array{Int}, fromNode[\"degrees_of_freedom\"])\n", " dofs=vcat(dofs,convert(Array{Int}, toNode[\"degrees_of_freedom\"]))\n", "\n", " element_vector=toPoint-fromPoint\n", "\n", " # find element mass and stifness matrices\n", " length = norm(element_vector)\n", " rho = edge[\"density\"]\n", " area = edge[\"area\"]\n", " E = edge[\"stiffness\"]# youngs modulus\n", "\n", " A = edge[\"area\"]\n", " G=1.0#todo shear_modulus\n", " ixx = 1.0#todo section ixx\n", " iyy = 1.0#todo section.iyy#\n", " l0=length\n", " j=1.0;#todo check\n", " l02 = l0 * l0\n", " l03 = l0 * l0 * l0\n", " \n", " # find element mass and stifness matrices\n", " length = norm(element_vector)\n", " rho = edge[\"density\"]\n", " area = edge[\"area\"]\n", " E = edge[\"stiffness\"]# youngs modulus\n", " \n", " \n", " \n", " A = edge[\"area\"]\n", " G=1.0#todo shear_modulus\n", " ixx = 1.0#todo section ixx\n", " iyy = 1.0#todo section.iyy#\n", " j=1.0;#todo check\n", " \n", " \n", " h = 2.38 # mm\n", " b = 2.38 # mm\n", " E = 2000 # MPa\n", " rho = 7.85e-9 / 3 # kg/mm^3\n", " G = E * 1 / 3 # MPa\n", " A=h*b\n", " Q = 1 / 3 - 0.2244 / (min(h / b, b / h) + 0.1607)\n", " J = Q * min(h * b^3, b * h^3)\n", " I= b*h^3/12\n", " ixx=I\n", " iyy=I\n", " j=J\n", " \n", " l0=length\n", " l02 = l0 * l0\n", " l03 = l0 * l0 * l0\n", "\n", " # Cm = rho * area * length /6.0\n", " # Ck= E * area / length \n", "\n", " # m = [[2 1];[1 2]]\n", " # k = [[1 -1];[-1 1]]\n", "\n", " k = [[E*A/l0 0 0 0 0 0 -E*A/l0 0 0 0 0 0];[0 12*E*ixx/l03 0 0 0 6*E*ixx/l02 0 -12*E*ixx/l03 0 0 0 6*E*ixx/l02];[0 0 12*E*iyy/l03 0 -6*E*iyy/l02 0 0 0 -12*E*iyy/l03 0 -6*E*iyy/l02 0];[0 0 0 G*j/l0 0 0 0 0 0 -G*j/l0 0 0];[0 0 -6*E*iyy/l02 0 4*E*iyy/l0 0 0 0 6*E*iyy/l02 0 2*E*iyy/l0 0];[0 6*E*ixx/l02 0 0 0 4*E*ixx/l0 0 -6*E*ixx/l02 0 0 0 2*E*ixx/l0];[-E*A/l0 0 0 0 0 0 E*A/l0 0 0 0 0 0];[0 -12*E*ixx/l03 0 0 0 -6*E*ixx/l02 0 12*E*ixx/l03 0 0 0 -6*E*ixx/l02];[0 0 -12*E*iyy/l03 0 6*E*iyy/l02 0 0 0 12*E*iyy/l03 0 6*E*iyy/l02 0];[0 0 0 -G*j/l0 0 0 0 0 0 G*j/l0 0 0];[0 0 -6*E*iyy/l02 0 2*E*iyy/l0 0 0 0 6*E*iyy/l02 0 4*E*iyy/l0 0];[0 6*E*ixx/l02 0 0 0 2*E*ixx/l0 0 -6*E*ixx/l02 0 0 0 4*E*ixx/l0]]\n", "\n", " \n", " ################################\n", "# mass=10\n", "# nu=0.35\n", "# W = 75\n", "# L = W/sqrt(2)\n", "# L=length\n", "# n_min = 1\n", "# n_max = 7\n", "# # Cross Section inputs, must be floats\n", "# E = 2000 # MPa\n", "# G = E * 1 / 3 # MPa\n", "# h = 2.38 # mm\n", "# b = 2.38 # mm\n", "# rho = 7.85e-9 / 3 # kg/mm^3\n", "# S = h * b\n", "# Sy = (S * (6 + 12 * nu + 6 * nu^2)/ (7 + 12 * nu + 4 * nu^2))\n", "# # For solid rectangular cross section (width=b, depth=d & ( b < d )):\n", "# Q = 1 / 3 - 0.2244 / (min(h / b, b / h) + 0.1607)\n", "# J = Q * min(h * b^3, b * h^3)\n", " \n", " \n", "# ##if voxels\n", "# #nu=0\n", "# #L=l\n", "# #a1 = E*L # EA/L : Units of N/m\n", "# #a2 = E * L*L*L / (12.0*(1+nu)) # GJ/L : Units of N-m\n", "# #b1 = E*L # 12EI/L^3 : Units of N/m\n", "# #b2 = E*L*L/2.0 # 6EI/L^2 : Units of N (or N-m/m: torque related to linear distance)\n", "# #b3 = E*L*L*L/6.0 # 2EI/L : Units of N-m\n", " \n", "# I= b*h^3/12\n", "# # J=b*h*(b*b+h*h)/12\n", "# a1=E*b*h/L\n", "# a2=G*J/L\n", "# b1=12*E*I/(L^3)\n", "# b2=6*E*I/(L^2)\n", "# b3=2*E*I/(L)\n", "\n", " \n", "\n", "# k = [[E*A/l0 0 0 0 0 0 -E*A/l0 0 0 0 0 0];[0 12*E*ixx/l03 0 0 0 6*E*ixx/l02 0 -12*E*ixx/l03 0 0 0 6*E*ixx/l02];[0 0 12*E*iyy/l03 0 -6*E*iyy/l02 0 0 0 -12*E*iyy/l03 0 -6*E*iyy/l02 0];[0 0 0 G*j/l0 0 0 0 0 0 -G*j/l0 0 0];[0 0 -6*E*iyy/l02 0 4*E*iyy/l0 0 0 0 6*E*iyy/l02 0 2*E*iyy/l0 0];[0 6*E*ixx/l02 0 0 0 4*E*ixx/l0 0 -6*E*ixx/l02 0 0 0 2*E*ixx/l0];[-E*A/l0 0 0 0 0 0 E*A/l0 0 0 0 0 0];[0 -12*E*ixx/l03 0 0 0 -6*E*ixx/l02 0 12*E*ixx/l03 0 0 0 -6*E*ixx/l02];[0 0 -12*E*iyy/l03 0 6*E*iyy/l02 0 0 0 12*E*iyy/l03 0 6*E*iyy/l02 0];[0 0 0 -G*j/l0 0 0 0 0 0 G*j/l0 0 0];[0 0 -6*E*iyy/l02 0 2*E*iyy/l0 0 0 0 6*E*iyy/l02 0 4*E*iyy/l0 0];[0 6*E*ixx/l02 0 0 0 2*E*ixx/l0 0 -6*E*ixx/l02 0 0 0 4*E*ixx/l0]]\n", "# k= [[ a1 0 0 0 0 0 -a1 0 0 0 0 0 ];\n", "# [ 0 b1 0 0 0 b2 0 -b1 0 0 0 b2 ];\n", "# [ 0 0 b1 0 -b2 0 0 0 -b1 0 -b2 0 ];\n", "# [ 0 0 0 a2 0 0 0 0 0 -a2 0 0 ];\n", "# [ 0 0 0 0 2b3 0 0 0 b2 0 b3 0 ];\n", "# [ 0 0 0 0 0 2b3 0 -b2 0 0 0 b3 ];\n", "# [ 0 0 0 0 0 0 a1 0 0 0 0 0 ];\n", "# [ 0 0 0 0 0 0 0 b1 0 0 0 -b2 ];\n", "# [ 0 0 0 0 0 0 0 0 b1 0 b2 0 ];\n", "# [ 0 0 0 0 0 0 0 0 0 a2 0 0 ];\n", "# [ 0 0 0 0 0 0 0 0 0 0 2b3 0 ];\n", "# [ 0 0 0 0 0 0 0 0 0 0 0 2b3 ]]\n", " # find rotated mass and stifness matrices\n", " tau = rotation_matrix(element_vector, x_axis,y_axis,z_axis)\n", "\n", " # m_r=transpose(tau)*m*tau\n", " k_r=transpose(tau)*k*tau\n", "\n", " # change from element to global coordinate\n", " index= dofs.+1\n", "\n", " B=zeros((12,ndofs))\n", " for i in 1:12\n", " B[i,index[i]]=1.0\n", " end\n", "\n", "\n", " # M_rG= transpose(B)*m_r*B\n", " K_rG= transpose(B)*k_r*B\n", "\n", " # M += Cm .* M_rG\n", " # K += Ck .* K_rG\n", " K += K_rG\n", "\n", " end\n", " \n", " \n", " # construct the force vector\n", " F=zeros(ndofs)\n", " remove_indices=[];\n", " for node in nodes\n", " #insert!(F,i, value);\n", " #F=vcat(F,value)\n", " \n", " \n", " i=parse(Int,node[\"id\"][2:end])\n", " f=node[\"force\"]\n", " \n", " # println(f)\n", " F[(i)*6+1]+=f[\"x\"]\n", " F[(i)*6+2]+=f[\"y\"]\n", " F[(i)*6+3]+=f[\"z\"]\n", " F[(i)*6+4]+=0\n", " F[(i)*6+5]+=0\n", " F[(i)*6+6]+=0\n", " Load+=f[\"y\"]\n", " if (F[(i)*6+2]!=0)\n", " append!(topNodesIndices,i+1)\n", " end\n", " \n", " dofs = convert(Array{Int}, node[\"degrees_of_freedom\"]).+1\n", " restrained_dofs=node[\"restrained_degrees_of_freedom\"]\n", " for (index, value) in enumerate(dofs)\n", " if restrained_dofs[index]\n", " append!( remove_indices, value)\n", " end\n", " end\n", " \n", " end\n", "\n", " #println(remove_indices)\n", " #print(K)\n", " #print(F)\n", " \n", "\n", " #M = M[setdiff(1:end, remove_indices), :]\n", " K = K[setdiff(1:end, remove_indices), :]\n", "\n", " #M = M[:,setdiff(1:end, remove_indices)]\n", " K = K[:,setdiff(1:end, remove_indices)]\n", "\n", " F = F[setdiff(1:end, remove_indices)]\n", " \n", " U=zeros(ndofs)\n", " \n", " return M,K,F,U,remove_indices\n", " end\n", "\n", " \n", " function updateDisplacement(setup, X)\n", " nodes= setup[\"nodes\"]\n", " i=0\n", " for node in nodes\n", " \n", "# if !node[\"restrained_degrees_of_freedom\"][2]\n", " #i=parse(Int,node[\"id\"][2:end])\n", " node[\"displacement\"][\"x\"]=X[(i)*6+1]/15\n", " node[\"displacement\"][\"y\"]=X[(i)*6+2]/15\n", " node[\"displacement\"][\"z\"]=X[(i)*6+3]/15\n", " node[\"angle\"][\"x\"]=X[(i)*6+4]\n", " node[\"angle\"][\"y\"]=X[(i)*6+5]\n", " node[\"angle\"][\"z\"]=X[(i)*6+6]\n", " append!(displacementFEA,[Vector3(X[(i)*6+1],X[(i)*6+2],X[(i)*6+3])])\n", " i=i+1\n", "# else\n", "# append!(displacementFEA,[Vector3(0,0,0)])\n", "# end\n", " end\n", " end\n", " \n", " #######################################################\n", "\n", " function get_stresses(setup)\n", " nodes = setup[\"nodes\"]\n", " edges = setup[\"edges\"]\n", " ndofs = length(nodes)*6\n", "\n", " x_axis = [1 0 0]\n", " y_axis = [0 1 0]\n", " z_axis = [0 0 1]\n", "\n", " # find the stresses in each member\n", " stresses=zeros(length(edges))\n", " max11=-10e6\n", " min11=10e6\n", " for edge in edges\n", " #degrees_of_freedom = properties[\"degrees_of_freedom\"]\n", "\n", " element=parse(Int,edge[\"id\"][2:end])\n", "\n", " # find the nodes that the lements connects\n", " fromNode = nodes[edge[\"source\"]+1]\n", " toNode = nodes[edge[\"target\"]+1]\n", "\n", " # the coordinates for each node\n", " fromPoint = [fromNode[\"position\"][\"x\"]*15.0 fromNode[\"position\"][\"y\"]*15.0 fromNode[\"position\"][\"z\"]*15.0]\n", " toPoint = [toNode[\"position\"][\"x\"]*15.0 toNode[\"position\"][\"y\"]*15.0 toNode[\"position\"][\"z\"]*15.0]\n", "\n", " # find the degrees of freedom for each node\n", " dofs = convert(Array{Int}, fromNode[\"degrees_of_freedom\"])\n", " dofs=vcat(dofs,convert(Array{Int}, toNode[\"degrees_of_freedom\"]))\n", "\n", " element_vector=toPoint-fromPoint\n", "\n", "\n", " # find rotated mass and stifness matrices\n", " tau = rotation_matrix(element_vector, x_axis,y_axis,z_axis)\n", "\n", " # i1=parse(Int,fromNode[\"id\"][2:end])\n", " # i2=parse(Int,toNode[\"id\"][2:end])\n", "\n", " # global_displacements=[X[(i1)*6+1] X[(i1)*6+2] X[(i1)*6+3] X[(i1)*6+4] X[(i1)*6+5] X[(i1)*6+6] X[(i2)*6+1] X[(i2)*6+2] X[(i2)*6+3] X[(i2)*6+4] X[(i2)*6+5] X[(i2)*6+6]] # todo change\n", " global_displacements=[fromNode[\"displacement\"][\"x\"]*15 fromNode[\"displacement\"][\"y\"]*15 fromNode[\"displacement\"][\"z\"]*15 fromNode[\"angle\"][\"x\"] fromNode[\"angle\"][\"y\"] fromNode[\"angle\"][\"z\"] toNode[\"displacement\"][\"x\"]*15 toNode[\"displacement\"][\"y\"]*15 toNode[\"displacement\"][\"z\"]*15 toNode[\"angle\"][\"x\"] toNode[\"angle\"][\"y\"] toNode[\"angle\"][\"z\"]] # todo change\n", "\n", " # nodal displacement\n", "\n", " q=tau*transpose(global_displacements)\n", " # println(q)\n", " # calculate the strain and stresses\n", " strain =(q[7]-q[1])/norm(element_vector)\n", " E = edge[\"stiffness\"]# youngs modulus\n", " E=2000\n", " stress=E.*strain\n", " edge[\"stress\"]=stress\n", " if stress>max11\n", " max11=stress\n", " end\n", " if stress<min11\n", " min11=stress\n", " end\n", " # println(element)\n", " # println(stress)\n", " end\n", "\n", "\n", "\n", " setup[\"viz\"][\"minStress\"]=min11\n", " setup[\"viz\"][\"maxStress\"]=max11\n", " return stresses\n", " end\n", " \n", " function initialize(setup)\n", " nodes = setup[\"nodes\"]\n", " ndofs = length(nodes)*6\n", " \n", " i=0\n", " for node in nodes\n", " dg=[]\n", " for ii in 0:5\n", " append!(dg,i+ii) \n", " end\n", " i+=6\n", " node[\"degrees_of_freedom\"]=dg\n", " end\n", " end\n", "\n", " #######################################################\n", " function solveFea(setup)\n", " // # determine the global matrices\n", " initialize(setup)\n", " \n", " M,K,F,U,ind=get_matrices(setup)\n", " \n", " #println(M)\n", " #println(K)\n", " #println(F)\n", "\n", " #evals=eigvals(K,M)\n", " #evecs=eigvecs(K,M)\n", " #frequencies=sqrt.(evals)\n", " X=inv(K)*F\n", " U[setdiff(1:end, ind)]=X\n", "\n", " updateDisplacement(setup, U)\n", "\n", " # determine the stresses in each element\n", " stresses=get_stresses(setup)\n", " end\n", " #######################################################\n", " displacementFEA=[]\n", " Load=0\n", " topNodesIndices=[]\n", " solveFea(setup)\n", " return displacementFEA,Load,topNodesIndices\n", "end" ] }, { "cell_type": "code", "execution_count": 33, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "getYoungsModulus (generic function with 1 method)" ] }, "execution_count": 33, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function getYoungsModulus(latticeSize,voxelSize,disp,Load,topNodesIndices)\n", " F=-Load\n", " l0=voxelSize*latticeSize\n", " A=l0*l0\n", "\n", " δl1=-mean( x.y for x in disp[topNodesIndices])\n", " \n", " stresses=F/A\n", " strain=δl1/l0\n", " println(\"Load=$Load\")\n", " println(\"stress=$stresses\")\n", "\n", " E=stresses/strain \n", "\n", " return E\n", "end\n" ] }, { "cell_type": "code", "execution_count": 34, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "getSetup (generic function with 1 method)" ] }, "execution_count": 34, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function getSetup(latticeSize)\n", " setup = Dict()\n", " name=string(\"../json/setupTestUni$latticeSize\",\".json\")\n", " name=string(\"../json/canteliver\",\".json\")\n", " \n", "# open(\"../json/setupValid2.json\", \"r\") do f\n", "# open(\"../json/setupTest.json\", \"r\") do f\n", " # open(\"../json/trialJulia.json\", \"r\") do f\n", "# open(\"../json/setupTestUni4.json\", \"r\") do f\n", " # open(\"../json/setupChiral.json\", \"r\") do f\n", "# open(\"../json/setupTestCubeUni10.json\", \"r\") do f\n", " open(name, \"r\") do f\n", "# global setup\n", " dicttxt = String(read(f)) # file information to string\n", " setup=JSON.parse(dicttxt) # parse and transform data\n", " end\n", "\n", " setup=setup[\"setup\"]\n", " return setup\n", "end" ] }, { "cell_type": "code", "execution_count": 35, "metadata": {}, "outputs": [ { "name": "stdout", "output_type": "stream", "text": [ "36\n" ] }, { "data": { "text/plain": [ "84" ] }, "execution_count": 35, "metadata": {}, "output_type": "execute_result" } ], "source": [ "latticeSize=1\n", "setup=getSetup(latticeSize)\n", "displacementFEA,Load,topNodesIndices=fea(setup)\n", "topNodesIndices\n", "println(length(setup[\"nodes\"]))\n", "length(setup[\"edges\"])" ] }, { "cell_type": "code", "execution_count": 36, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "5-element Array{Float64,1}:\n", " 0.0\n", " 0.0\n", " 0.0\n", " 0.0\n", " 0.0" ] }, "execution_count": 36, "metadata": {}, "output_type": "execute_result" } ], "source": [ "DDisplacements=[[],[],[],[],[]]\n", "DDisplacementsFEA=[[],[],[],[],[]]\n", "Loads=[0.0,0,0,0,0]\n", "EsFEA=[0.0,0,0,0,0]\n", "Es=[0.0,0,0,0,0]" ] }, { "cell_type": "code", "execution_count": 37, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "Dict{String,Any} with 8 entries:\n", " \"nodes\" => Any[Dict{String,Any}(\"degrees_of_freedom\"=>Any[0, 1, 2, 3, …\n", " \"voxelSize\" => 5\n", " \"numTimeSteps\" => 100\n", " \"hierarchical\" => false\n", " \"animation\" => Dict{String,Any}(\"speed\"=>3,\"exaggeration\"=>2.0,\"showDisplac…\n", " \"viz\" => Dict{String,Any}(\"colorMap\"=>0,\"colorMaps\"=>Any[Any[Any[0, …\n", " \"edges\" => Any[Dict{String,Any}(\"source\"=>0,\"area\"=>1,\"density\"=>0.028…\n", " \"ndofs\" => 216" ] }, "execution_count": 37, "metadata": {}, "output_type": "execute_result" } ], "source": [ "setup" ] }, { "cell_type": "code", "execution_count": 39, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "71521" ] }, "execution_count": 39, "metadata": {}, "output_type": "execute_result" } ], "source": [ "latticeSize=1\n", "setup=getSetup(latticeSize)\n", "displacementFEA,Load,topNodesIndices=fea(setup)\n", "# displacementFEA,Load,topNodesIndices=feaDisplacement(setup,latticeSize)\n", "updateDataAndSaveFEA!(setup,\"../json/trialJuliaParallelGPU.json\")\n" ] }, { "cell_type": "code", "execution_count": 29, "metadata": {}, "outputs": [ { "name": "stdout", "output_type": "stream", "text": [ "dt: 0.007294855212986816\n", "first timestep took 0.0004967 seconds\n", "ran latticeSize 1 with 36 voxels and 84 edges for 2000 time steps took 0.6889823 seconds\n", "Load=-60\n", "stress=0.010666666666666666\n", "Load=-60\n", "stress=0.010666666666666666\n", "EsFEA:[0.006574508319567247, 0.0, 0.0, 0.0, 0.0]\n", "Es:[0.022776269378094814, 0.0, 0.0, 0.0, 0.0]\n", "FEA displacement= -143.1011794080455,converged displacement= -41.97987125835496\n" ] }, { "data": { "image/svg+xml": [ "<?xml version=\"1.0\" encoding=\"utf-8\"?>\n", "<svg xmlns=\"http://www.w3.org/2000/svg\" xmlns:xlink=\"http://www.w3.org/1999/xlink\" width=\"600\" height=\"400\" viewBox=\"0 0 2400 1600\">\n", "<defs>\n", " <clipPath id=\"clip7400\">\n", " <rect x=\"0\" y=\"0\" width=\"2400\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip7400)\" d=\"\n", "M0 1600 L2400 1600 L2400 0 L0 0 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip7401\">\n", " <rect x=\"480\" y=\"0\" width=\"1681\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip7400)\" d=\"\n", "M257.245 1425.62 L2352.76 1425.62 L2352.76 121.675 L257.245 121.675 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip7402\">\n", " <rect x=\"257\" y=\"121\" width=\"2097\" height=\"1305\"/>\n", " </clipPath>\n", "</defs>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 306.668,1425.62 306.668,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 800.892,1425.62 800.892,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1295.12,1425.62 1295.12,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1789.34,1425.62 1789.34,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 2283.56,1425.62 2283.56,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 257.245,1190.13 2352.76,1190.13 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 257.245,932.243 2352.76,932.243 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 257.245,674.355 2352.76,674.355 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 257.245,416.467 2352.76,416.467 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 257.245,158.579 2352.76,158.579 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 257.245,1425.62 2352.76,1425.62 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 257.245,1425.62 257.245,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 306.668,1425.62 306.668,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 800.892,1425.62 800.892,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1295.12,1425.62 1295.12,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1789.34,1425.62 1789.34,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2283.56,1425.62 2283.56,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 257.245,1190.13 282.391,1190.13 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 257.245,932.243 282.391,932.243 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 257.245,674.355 282.391,674.355 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 257.245,416.467 282.391,416.467 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 257.245,158.579 282.391,158.579 \n", " \"/>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 306.668, 1479.62)\" x=\"306.668\" y=\"1479.62\">0</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 800.892, 1479.62)\" x=\"800.892\" y=\"1479.62\">50</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1295.12, 1479.62)\" x=\"1295.12\" y=\"1479.62\">100</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1789.34, 1479.62)\" x=\"1789.34\" y=\"1479.62\">150</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 2283.56, 1479.62)\" x=\"2283.56\" y=\"1479.62\">200</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 233.245, 1207.63)\" x=\"233.245\" y=\"1207.63\">-120</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 233.245, 949.743)\" x=\"233.245\" y=\"949.743\">-90</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 233.245, 691.855)\" x=\"233.245\" y=\"691.855\">-60</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 233.245, 433.967)\" x=\"233.245\" y=\"433.967\">-30</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 233.245, 176.079)\" x=\"233.245\" y=\"176.079\">0</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:84px; text-anchor:middle;\" transform=\"rotate(0, 1305, 73.2)\" x=\"1305\" y=\"73.2\">1 Voxel Convergence Study</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(0, 1305, 1559.48)\" x=\"1305\" y=\"1559.48\">timestep</text>\n", "</g>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(-90, 89.2861, 773.647)\" x=\"89.2861\" y=\"773.647\">displacement</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 316.552,158.579 1305,259.555 2293.45,519.449 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7402)\" style=\"stroke:#e26f46; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 316.552,1388.71 1305,1388.71 2293.45,1388.71 \n", " \"/>\n", "<path clip-path=\"url(#clip7400)\" d=\"\n", "M1853.56 386.635 L2280.76 386.635 L2280.76 205.195 L1853.56 205.195 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1853.56,386.635 2280.76,386.635 2280.76,205.195 1853.56,205.195 1853.56,386.635 \n", " \"/>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1877.56,265.675 2021.56,265.675 \n", " \"/>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2045.56, 283.175)\" x=\"2045.56\" y=\"283.175\">Dynamic</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip7400)\" style=\"stroke:#e26f46; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1877.56,326.155 2021.56,326.155 \n", " \"/>\n", "<g clip-path=\"url(#clip7400)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2045.56, 343.655)\" x=\"2045.56\" y=\"343.655\">FEA</text>\n", "</g>\n", "</svg>\n" ] }, "execution_count": 29, "metadata": {}, "output_type": "execute_result" } ], "source": [ "\n", "setup=getSetup(latticeSize)\n", "numTimeSteps=2000\n", "displacements=[]\n", "save=true\n", "returnEvery=10\n", "runMetavoxelGPU!(setup,numTimeSteps,latticeSize,displacements,returnEvery,true)\n", "\n", "numTimeStepsRecorded=length(displacements)\n", "d=[]\n", "dFEA=[]\n", "j=length(displacements[end])\n", "step=100\n", "for i in 1:step:numTimeStepsRecorded\n", " append!(d,displacements[i][j].y)\n", " append!(dFEA,displacementFEA[j].y)\n", "end\n", "Loads[latticeSize]=Load\n", "DDisplacements[latticeSize]=d\n", "DDisplacementsFEA[latticeSize]=dFEA\n", "\n", "E1=getYoungsModulus(latticeSize,75,displacementFEA,Load,topNodesIndices)\n", "E2=getYoungsModulus(latticeSize,75,displacements[end],Load,topNodesIndices)\n", "\n", "EsFEA[latticeSize]=E1\n", "Es[latticeSize]=E2\n", "\n", "print(\"EsFEA:\" )\n", "println(EsFEA)\n", "print(\"Es:\" )\n", "println(Es)\n", "\n", "println(\"FEA displacement= $(displacementFEA[j].y),converged displacement= $(displacements[numTimeStepsRecorded][j].y)\")\n", "plot(1:step:numTimeStepsRecorded,d,label=\"Dynamic\",xlabel=\"timestep\",ylabel=\"displacement\",title=\"$latticeSize Voxel Convergence Study\")\n", "plot!(1:step:numTimeStepsRecorded,dFEA,label=\"FEA\")\n", "# savefig(\"4_voxel_convergence\")\n" ] }, { "cell_type": "code", "execution_count": 26, "metadata": {}, "outputs": [ { "data": { "image/svg+xml": [ "<?xml version=\"1.0\" encoding=\"utf-8\"?>\n", "<svg xmlns=\"http://www.w3.org/2000/svg\" xmlns:xlink=\"http://www.w3.org/1999/xlink\" width=\"600\" height=\"400\" viewBox=\"0 0 2400 1600\">\n", "<defs>\n", " <clipPath id=\"clip1100\">\n", " <rect x=\"0\" y=\"0\" width=\"2400\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip1100)\" d=\"\n", "M0 1600 L2400 1600 L2400 0 L0 0 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip1101\">\n", " <rect x=\"480\" y=\"0\" width=\"1681\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip1100)\" d=\"\n", "M203.721 1425.62 L2352.76 1425.62 L2352.76 121.675 L203.721 121.675 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip1102\">\n", " <rect x=\"203\" y=\"121\" width=\"2150\" height=\"1305\"/>\n", " </clipPath>\n", "</defs>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 260.781,1425.62 260.781,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 636.92,1425.62 636.92,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1013.06,1425.62 1013.06,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1389.2,1425.62 1389.2,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1765.34,1425.62 1765.34,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 2141.48,1425.62 2141.48,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 203.721,1229.96 2352.76,1229.96 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 203.721,962.112 2352.76,962.112 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 203.721,694.268 2352.76,694.268 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 203.721,426.423 2352.76,426.423 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 203.721,158.579 2352.76,158.579 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 203.721,1425.62 2352.76,1425.62 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 203.721,1425.62 203.721,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 260.781,1425.62 260.781,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 636.92,1425.62 636.92,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1013.06,1425.62 1013.06,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1389.2,1425.62 1389.2,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1765.34,1425.62 1765.34,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2141.48,1425.62 2141.48,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 203.721,1229.96 229.509,1229.96 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 203.721,962.112 229.509,962.112 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 203.721,694.268 229.509,694.268 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 203.721,426.423 229.509,426.423 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 203.721,158.579 229.509,158.579 \n", " \"/>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 260.781, 1479.62)\" x=\"260.781\" y=\"1479.62\">0</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 636.92, 1479.62)\" x=\"636.92\" y=\"1479.62\">100</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1013.06, 1479.62)\" x=\"1013.06\" y=\"1479.62\">200</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1389.2, 1479.62)\" x=\"1389.2\" y=\"1479.62\">300</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1765.34, 1479.62)\" x=\"1765.34\" y=\"1479.62\">400</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 2141.48, 1479.62)\" x=\"2141.48\" y=\"1479.62\">500</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 179.721, 1247.46)\" x=\"179.721\" y=\"1247.46\">-4</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 179.721, 979.612)\" x=\"179.721\" y=\"979.612\">-3</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 179.721, 711.768)\" x=\"179.721\" y=\"711.768\">-2</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 179.721, 443.923)\" x=\"179.721\" y=\"443.923\">-1</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 179.721, 176.079)\" x=\"179.721\" y=\"176.079\">0</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:84px; text-anchor:middle;\" transform=\"rotate(0, 1278.24, 73.2)\" x=\"1278.24\" y=\"73.2\">Node Displacement</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(0, 1278.24, 1559.48)\" x=\"1278.24\" y=\"1559.48\">Node ID</text>\n", "</g>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(-90, 89.2861, 773.647)\" x=\"89.2861\" y=\"773.647\">displacement</text>\n", "</g>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"264.542\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"268.304\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"272.065\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"275.827\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"279.588\" cy=\"346.417\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"283.349\" cy=\"261.449\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"287.111\" cy=\"221.302\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"290.872\" cy=\"434.08\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"294.634\" cy=\"429.011\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"298.395\" cy=\"347.432\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"302.156\" cy=\"365.381\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"305.918\" cy=\"262.28\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"309.679\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"313.441\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"317.202\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"320.963\" cy=\"283.065\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"324.725\" cy=\"216.13\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"328.486\" cy=\"299.462\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"332.248\" cy=\"326.915\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"336.009\" cy=\"249.866\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"339.77\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"343.532\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"347.293\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"351.054\" cy=\"308.839\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"354.816\" cy=\"216.787\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"358.577\" cy=\"347.231\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"362.339\" cy=\"327.942\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"366.1\" cy=\"251.505\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"369.861\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"373.623\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"377.384\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"381.146\" cy=\"284.724\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"384.907\" cy=\"222.143\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"388.668\" cy=\"303.756\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"392.43\" cy=\"353.003\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"396.191\" cy=\"265.224\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"399.953\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"403.714\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"407.475\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"411.237\" cy=\"354.3\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"414.998\" cy=\"266.515\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"418.76\" cy=\"443.909\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"422.521\" cy=\"447.395\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"426.282\" cy=\"375.571\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"430.044\" cy=\"499.216\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"433.805\" cy=\"453.066\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"437.567\" cy=\"411.702\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"441.328\" cy=\"506.806\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"445.089\" cy=\"512.285\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"448.851\" cy=\"498.282\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"452.612\" cy=\"491.366\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"456.374\" cy=\"454.757\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"460.135\" cy=\"534.291\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"463.896\" cy=\"391.406\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"467.658\" cy=\"585.726\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"471.419\" cy=\"474.873\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"475.181\" cy=\"415.136\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"478.942\" cy=\"465.95\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"482.703\" cy=\"394.865\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"486.465\" cy=\"467.443\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"490.226\" cy=\"478.065\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"493.987\" cy=\"416.992\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"497.749\" cy=\"543.3\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"501.51\" cy=\"419.481\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"505.272\" cy=\"591.24\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"509.033\" cy=\"509.256\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"512.794\" cy=\"464.875\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"516.556\" cy=\"508.356\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"520.317\" cy=\"464.898\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"524.079\" cy=\"518.26\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"527.84\" cy=\"514.552\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"531.601\" cy=\"501.967\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"535.363\" cy=\"761.672\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"539.124\" cy=\"629.523\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"542.886\" cy=\"615.69\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"546.647\" cy=\"796.829\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"550.408\" cy=\"781.601\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"554.17\" cy=\"771.271\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"557.931\" cy=\"659.219\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"561.693\" cy=\"637.856\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"565.454\" cy=\"679.698\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"569.215\" cy=\"611.818\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"572.977\" cy=\"675.652\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"576.738\" cy=\"792.835\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"580.5\" cy=\"637.414\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"584.261\" cy=\"778.38\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"588.022\" cy=\"618.509\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"591.784\" cy=\"827.37\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"595.545\" cy=\"796.155\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"599.307\" cy=\"641.336\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"603.068\" cy=\"685.801\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"606.829\" cy=\"627.028\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"610.591\" cy=\"676.421\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"614.352\" cy=\"778.883\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"618.114\" cy=\"640.23\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"621.875\" cy=\"785.325\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"625.636\" cy=\"650.33\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"629.398\" cy=\"795.489\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"633.159\" cy=\"810.748\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"636.92\" cy=\"667.533\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"640.682\" cy=\"883.931\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"644.443\" cy=\"815.225\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"648.205\" cy=\"834.7\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"651.966\" cy=\"886.766\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"655.727\" cy=\"858.587\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"659.489\" cy=\"899.558\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"663.25\" cy=\"829.944\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"667.012\" cy=\"849.63\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"670.773\" cy=\"1026.92\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"674.534\" cy=\"840.052\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"678.296\" cy=\"1084.11\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"682.057\" cy=\"894.539\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"685.819\" cy=\"865.485\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"689.58\" cy=\"885.727\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"693.341\" cy=\"842.326\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"697.103\" cy=\"884.895\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"700.864\" cy=\"875.643\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"704.626\" cy=\"852.125\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"708.387\" cy=\"1030.32\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"712.148\" cy=\"847.216\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"715.91\" cy=\"1037.26\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"719.671\" cy=\"895.526\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"723.433\" cy=\"832.537\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"727.194\" cy=\"902.017\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"730.955\" cy=\"853.67\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"734.717\" cy=\"868.227\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"738.478\" cy=\"880.822\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"742.24\" cy=\"835.564\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"746.001\" cy=\"1251.94\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"749.762\" cy=\"1052.91\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"753.524\" cy=\"1081.38\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"757.285\" cy=\"1378.73\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"761.047\" cy=\"1326.99\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"764.808\" cy=\"1341.48\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"768.569\" cy=\"1103.92\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"772.331\" cy=\"1140.22\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"776.092\" cy=\"1095.19\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"779.853\" cy=\"1057.86\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"783.615\" cy=\"1137.12\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"787.376\" cy=\"1286.09\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"791.138\" cy=\"1082.9\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"794.899\" cy=\"1215.72\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"798.66\" cy=\"1052.42\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"802.422\" cy=\"1236.65\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"806.183\" cy=\"1247.41\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"809.945\" cy=\"1040.29\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"813.706\" cy=\"1104.18\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"817.467\" cy=\"1096.37\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"821.229\" cy=\"1093.09\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"824.99\" cy=\"1336.04\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"828.752\" cy=\"1080.9\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"832.513\" cy=\"1344.83\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"836.274\" cy=\"1135.71\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"840.036\" cy=\"1365.6\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"843.797\" cy=\"1373.15\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"847.559\" cy=\"1094.66\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"851.32\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"855.081\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"858.843\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"862.604\" cy=\"327.421\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"866.366\" cy=\"249.759\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"870.127\" cy=\"216.262\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"873.888\" cy=\"300.256\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"877.65\" cy=\"283.956\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"881.411\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"885.173\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"888.934\" cy=\"274.313\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"892.695\" cy=\"213.998\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"896.457\" cy=\"273.822\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"900.218\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"903.98\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"907.741\" cy=\"309.659\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"911.502\" cy=\"214.644\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"915.264\" cy=\"275.749\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"919.025\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"922.786\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"926.548\" cy=\"275.474\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"930.309\" cy=\"216.725\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"934.071\" cy=\"285.058\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"937.832\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"941.593\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"945.355\" cy=\"331.463\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"949.116\" cy=\"252.352\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"952.878\" cy=\"302.351\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"956.639\" cy=\"468.419\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"960.4\" cy=\"410.419\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"964.162\" cy=\"392.52\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"967.923\" cy=\"577.925\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"971.685\" cy=\"532.764\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"975.446\" cy=\"530.686\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"979.207\" cy=\"384.338\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"982.969\" cy=\"529.069\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"986.73\" cy=\"452.887\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"990.492\" cy=\"386.651\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"994.253\" cy=\"533.947\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"998.014\" cy=\"535.597\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1001.78\" cy=\"397.233\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1005.54\" cy=\"542.232\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1009.3\" cy=\"481.431\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1013.06\" cy=\"421.476\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1016.82\" cy=\"599.39\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1020.58\" cy=\"787.037\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1024.34\" cy=\"630.112\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1028.11\" cy=\"610.407\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1031.87\" cy=\"664.034\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1035.63\" cy=\"680.654\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1039.39\" cy=\"661.47\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1043.15\" cy=\"601.311\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1046.91\" cy=\"667.034\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1050.67\" cy=\"774.362\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1054.44\" cy=\"607.129\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1058.2\" cy=\"671.437\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1061.96\" cy=\"672.853\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1065.72\" cy=\"618.619\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1069.48\" cy=\"686.201\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1073.24\" cy=\"800.484\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1077\" cy=\"647.327\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1080.77\" cy=\"681.166\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1084.53\" cy=\"857.348\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1088.29\" cy=\"834.518\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1092.05\" cy=\"835.491\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1095.81\" cy=\"1025.82\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1099.57\" cy=\"1007.43\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1103.33\" cy=\"1013.32\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1107.09\" cy=\"827.557\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1110.86\" cy=\"1004.71\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1114.62\" cy=\"856.6\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1118.38\" cy=\"832.484\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1122.14\" cy=\"1013.37\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1125.9\" cy=\"1012.35\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1129.66\" cy=\"848.514\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1133.42\" cy=\"1035.05\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1137.19\" cy=\"900.906\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1140.95\" cy=\"870.912\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1144.71\" cy=\"1088.75\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1148.47\" cy=\"1233.2\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1152.23\" cy=\"1030.26\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1155.99\" cy=\"1046.25\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1159.75\" cy=\"1058.08\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1163.52\" cy=\"1098.84\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1167.28\" cy=\"1024.44\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1171.04\" cy=\"1021.53\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1174.8\" cy=\"1055.67\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1178.56\" cy=\"1193.32\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1182.32\" cy=\"1024.73\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1186.08\" cy=\"1039.11\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1189.85\" cy=\"1045.31\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1193.61\" cy=\"1060.42\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1197.37\" cy=\"1085.93\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1201.13\" cy=\"1265.57\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1204.89\" cy=\"1077.87\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1208.65\" cy=\"1112.18\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1212.41\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1216.18\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1219.94\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1223.7\" cy=\"327.415\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1227.46\" cy=\"249.618\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1231.22\" cy=\"216.676\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1234.98\" cy=\"343.661\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1238.74\" cy=\"308.239\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1242.51\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1246.27\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1250.03\" cy=\"274.353\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1253.79\" cy=\"214.469\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1257.55\" cy=\"308.216\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1261.31\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1265.07\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1268.83\" cy=\"309.343\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1272.6\" cy=\"214.916\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1276.36\" cy=\"309.499\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1280.12\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1283.88\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1287.64\" cy=\"276.191\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1291.4\" cy=\"217.227\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1295.16\" cy=\"312.516\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1298.93\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1302.69\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1306.45\" cy=\"331.335\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1310.21\" cy=\"253.329\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1313.97\" cy=\"352.957\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1317.73\" cy=\"472.795\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1321.49\" cy=\"413.551\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1325.26\" cy=\"392.615\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1329.02\" cy=\"464.278\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1332.78\" cy=\"465.463\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1336.54\" cy=\"531.831\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1340.3\" cy=\"384.857\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1344.06\" cy=\"453.299\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1347.82\" cy=\"453.944\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1351.59\" cy=\"386.426\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1355.35\" cy=\"456.098\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1359.11\" cy=\"537.69\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1362.87\" cy=\"398.903\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1366.63\" cy=\"467.534\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1370.39\" cy=\"480.885\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1374.15\" cy=\"420.322\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1377.92\" cy=\"468.636\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1381.68\" cy=\"788.538\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1385.44\" cy=\"634.945\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1389.2\" cy=\"611.971\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1392.96\" cy=\"817.897\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1396.72\" cy=\"769.871\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1400.48\" cy=\"665.547\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1404.25\" cy=\"603.201\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1408.01\" cy=\"768.417\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1411.77\" cy=\"771.588\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1415.53\" cy=\"607.308\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1419.29\" cy=\"772.631\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1423.05\" cy=\"670.155\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1426.81\" cy=\"620.08\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1430.57\" cy=\"788.09\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1434.34\" cy=\"801.055\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1438.1\" cy=\"646.08\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1441.86\" cy=\"840.825\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1445.62\" cy=\"880.376\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1449.38\" cy=\"855.376\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1453.14\" cy=\"836.15\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1456.9\" cy=\"868.575\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1460.67\" cy=\"884.895\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1464.43\" cy=\"1006.48\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1468.19\" cy=\"826.281\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1471.95\" cy=\"855.165\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1475.71\" cy=\"855.244\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1479.47\" cy=\"830.02\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1483.23\" cy=\"860.452\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1487\" cy=\"1015.58\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1490.76\" cy=\"845.419\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1494.52\" cy=\"884.793\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1498.28\" cy=\"877.023\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1502.04\" cy=\"857.826\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1505.8\" cy=\"880.945\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1509.56\" cy=\"1224.66\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1513.33\" cy=\"1063.93\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1517.09\" cy=\"1050\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1520.85\" cy=\"1198.43\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1524.61\" cy=\"1198.04\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1528.37\" cy=\"1039.39\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1532.13\" cy=\"1018.38\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1535.89\" cy=\"1189.27\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1539.66\" cy=\"1173.92\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1543.42\" cy=\"1020.64\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1547.18\" cy=\"1170.38\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1550.94\" cy=\"1036.13\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1554.7\" cy=\"1052.76\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1558.46\" cy=\"1235.84\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1562.22\" cy=\"1243.92\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1565.98\" cy=\"1042.38\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1569.75\" cy=\"1237.04\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1573.51\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1577.27\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1581.03\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1584.79\" cy=\"350.228\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1588.55\" cy=\"263.956\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1592.31\" cy=\"221.634\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1596.08\" cy=\"302.164\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1599.84\" cy=\"285.494\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1603.6\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1607.36\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1611.12\" cy=\"281.542\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1614.88\" cy=\"216.457\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1618.64\" cy=\"275.045\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1622.41\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1626.17\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1629.93\" cy=\"311.955\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1633.69\" cy=\"217.112\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1637.45\" cy=\"276.129\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1641.21\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1644.97\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1648.74\" cy=\"284.554\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1652.5\" cy=\"222.38\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1656.26\" cy=\"284.682\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1660.02\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1663.78\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1667.54\" cy=\"354.656\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1671.3\" cy=\"266.2\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1675.07\" cy=\"303.557\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1678.83\" cy=\"498.611\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1682.59\" cy=\"457.459\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1686.35\" cy=\"414.515\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1690.11\" cy=\"583.205\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1693.87\" cy=\"533.396\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1697.63\" cy=\"538.053\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1701.4\" cy=\"393.508\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1705.16\" cy=\"530.643\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1708.92\" cy=\"462.053\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1712.68\" cy=\"395.59\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1716.44\" cy=\"534.107\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1720.2\" cy=\"542.913\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1723.96\" cy=\"419.561\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1727.72\" cy=\"545.872\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1731.49\" cy=\"506.864\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1735.25\" cy=\"464.595\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1739.01\" cy=\"596.985\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1742.77\" cy=\"777.749\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1746.53\" cy=\"636.275\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1750.29\" cy=\"618.499\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1754.05\" cy=\"673.046\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1757.82\" cy=\"680.914\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1761.58\" cy=\"675.231\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1765.34\" cy=\"612.1\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1769.1\" cy=\"666.546\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1772.86\" cy=\"783.931\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1776.62\" cy=\"616.616\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1780.38\" cy=\"673.201\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1784.15\" cy=\"679.465\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1787.91\" cy=\"625.02\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1791.67\" cy=\"680.85\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1795.43\" cy=\"780.981\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1799.19\" cy=\"643.093\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1802.95\" cy=\"673.949\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1806.71\" cy=\"886.664\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1810.48\" cy=\"847.717\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1814.24\" cy=\"835.87\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1818\" cy=\"1079\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1821.76\" cy=\"1016.31\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1825.52\" cy=\"1021.25\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1829.28\" cy=\"837.208\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1833.04\" cy=\"1004.26\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1836.81\" cy=\"878.191\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1840.57\" cy=\"844.067\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1844.33\" cy=\"1006.27\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1848.09\" cy=\"1030.57\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1851.85\" cy=\"839.337\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1855.61\" cy=\"1023.35\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1859.37\" cy=\"881.841\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1863.14\" cy=\"830.472\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1866.9\" cy=\"1045.66\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1870.66\" cy=\"1354.14\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1874.42\" cy=\"1144.26\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1878.18\" cy=\"1086.48\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1881.94\" cy=\"1147.75\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1885.7\" cy=\"1093.97\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1889.46\" cy=\"1082.99\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1893.23\" cy=\"1046.37\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1896.99\" cy=\"1028.91\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1900.75\" cy=\"1225.65\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1904.51\" cy=\"1053.92\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1908.27\" cy=\"1048.15\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1912.03\" cy=\"1070.4\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1915.79\" cy=\"1084.16\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1919.56\" cy=\"1076.87\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1923.32\" cy=\"1331.31\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1927.08\" cy=\"1088.47\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1930.84\" cy=\"1086.6\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1934.6\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1938.36\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1942.12\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1945.89\" cy=\"435.048\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1949.65\" cy=\"368.544\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1953.41\" cy=\"262.44\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1957.17\" cy=\"438.385\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1960.93\" cy=\"348.351\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1964.69\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1968.45\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1972.22\" cy=\"299.353\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1975.98\" cy=\"250.466\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1979.74\" cy=\"328.089\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1983.5\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1987.26\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1991.02\" cy=\"348.289\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1994.78\" cy=\"251.293\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1998.55\" cy=\"329.889\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2002.31\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2006.07\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2009.83\" cy=\"303.749\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2013.59\" cy=\"266.574\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2017.35\" cy=\"355.385\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2021.11\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2024.88\" cy=\"158.579\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2028.64\" cy=\"446.029\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2032.4\" cy=\"374.986\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2036.16\" cy=\"445.556\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2039.92\" cy=\"509.216\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2043.68\" cy=\"493.531\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2047.44\" cy=\"456.366\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2051.2\" cy=\"508.766\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2054.97\" cy=\"505.184\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2058.73\" cy=\"585.06\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2062.49\" cy=\"414.107\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2066.25\" cy=\"472.475\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2070.01\" cy=\"462.719\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2073.77\" cy=\"417.597\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2077.53\" cy=\"478.426\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2081.3\" cy=\"591.175\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2085.06\" cy=\"463.955\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2088.82\" cy=\"503.77\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2092.58\" cy=\"515.018\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2096.34\" cy=\"502.221\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2100.1\" cy=\"515.116\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2103.86\" cy=\"798.604\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2107.63\" cy=\"665.668\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2111.39\" cy=\"634.773\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2115.15\" cy=\"803.435\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2118.91\" cy=\"765.676\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2122.67\" cy=\"660.606\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2126.43\" cy=\"633.469\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2130.19\" cy=\"787.405\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2133.96\" cy=\"825.205\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2137.72\" cy=\"639.094\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2141.48\" cy=\"792.667\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2145.24\" cy=\"672.384\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2149\" cy=\"643.864\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2152.76\" cy=\"783.869\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2156.52\" cy=\"804.945\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2160.29\" cy=\"667.965\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2164.05\" cy=\"799.555\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2167.81\" cy=\"851.038\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2171.57\" cy=\"839.466\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2175.33\" cy=\"817.624\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2179.09\" cy=\"895.353\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2182.85\" cy=\"885.826\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2186.62\" cy=\"1030.24\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2190.38\" cy=\"840.901\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2194.14\" cy=\"864.954\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2197.9\" cy=\"868.005\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2201.66\" cy=\"856.419\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2205.42\" cy=\"883.493\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2209.18\" cy=\"1069.76\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2212.94\" cy=\"840.13\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2216.71\" cy=\"877.442\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2220.47\" cy=\"876.324\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2224.23\" cy=\"832.319\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2227.99\" cy=\"858.75\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2231.75\" cy=\"1364.52\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2235.51\" cy=\"1127.59\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2239.27\" cy=\"1063.72\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2243.04\" cy=\"1378.94\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2246.8\" cy=\"1277.16\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2250.56\" cy=\"1061.19\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2254.32\" cy=\"1028.36\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2258.08\" cy=\"1226.83\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2261.84\" cy=\"1189.89\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2265.6\" cy=\"1052.99\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2269.37\" cy=\"1217.89\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2273.13\" cy=\"1113.36\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2276.89\" cy=\"1121.77\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2280.65\" cy=\"1340.74\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2284.41\" cy=\"1366.22\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2288.17\" cy=\"1109.83\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2291.93\" cy=\"1388.71\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"264.542\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"268.304\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"272.065\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"275.827\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"279.588\" cy=\"345.703\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"283.349\" cy=\"262.768\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"287.111\" cy=\"222.043\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"290.872\" cy=\"435.464\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"294.634\" cy=\"437.415\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"298.395\" cy=\"347.173\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"302.156\" cy=\"367.001\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"305.918\" cy=\"263.106\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"309.679\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"313.441\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"317.202\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"320.963\" cy=\"288.711\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"324.725\" cy=\"216.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"328.486\" cy=\"304.536\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"332.248\" cy=\"324.722\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"336.009\" cy=\"250.218\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"339.77\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"343.532\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"347.293\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"351.054\" cy=\"304.796\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"354.816\" cy=\"216.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"358.577\" cy=\"345.696\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"362.339\" cy=\"324.722\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"366.1\" cy=\"250.218\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"369.861\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"373.623\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"377.384\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"381.146\" cy=\"288.711\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"384.907\" cy=\"222.043\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"388.668\" cy=\"304.536\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"392.43\" cy=\"347.173\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"396.191\" cy=\"263.106\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"399.953\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"403.714\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"407.475\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"411.237\" cy=\"345.703\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"414.998\" cy=\"262.768\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"418.76\" cy=\"435.464\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"422.521\" cy=\"437.415\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"426.282\" cy=\"367.001\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"430.044\" cy=\"515.18\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"433.805\" cy=\"461.086\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"437.567\" cy=\"416.039\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"441.328\" cy=\"521.702\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"445.089\" cy=\"518.413\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"448.851\" cy=\"512.058\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"452.612\" cy=\"499.774\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"456.374\" cy=\"460.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"460.135\" cy=\"527.757\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"463.896\" cy=\"393.751\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"467.658\" cy=\"581.698\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"471.419\" cy=\"482.616\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"475.181\" cy=\"417.007\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"478.942\" cy=\"473.564\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"482.703\" cy=\"393.751\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"486.465\" cy=\"471.128\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"490.226\" cy=\"482.616\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"493.987\" cy=\"417.007\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"497.749\" cy=\"527.757\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"501.51\" cy=\"416.039\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"505.272\" cy=\"581.698\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"509.033\" cy=\"512.058\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"512.794\" cy=\"460.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"516.556\" cy=\"515.18\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"520.317\" cy=\"461.086\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"524.079\" cy=\"521.702\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"527.84\" cy=\"518.413\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"531.601\" cy=\"499.774\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"535.363\" cy=\"760.396\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"539.124\" cy=\"641.137\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"542.886\" cy=\"621.876\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"546.647\" cy=\"791.242\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"550.408\" cy=\"795.899\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"554.17\" cy=\"764.784\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"557.931\" cy=\"668.403\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"561.693\" cy=\"641.387\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"565.454\" cy=\"693.944\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"569.215\" cy=\"612.831\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"572.977\" cy=\"679.848\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"576.738\" cy=\"778.812\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"580.5\" cy=\"636.975\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"584.261\" cy=\"762.568\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"588.022\" cy=\"612.831\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"591.784\" cy=\"815.144\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"595.545\" cy=\"778.812\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"599.307\" cy=\"636.975\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"603.068\" cy=\"693.944\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"606.829\" cy=\"621.876\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"610.591\" cy=\"679.848\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"614.352\" cy=\"764.784\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"618.114\" cy=\"641.387\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"621.875\" cy=\"760.396\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"625.636\" cy=\"641.137\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"629.398\" cy=\"791.242\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"633.159\" cy=\"795.899\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"636.92\" cy=\"668.403\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"640.682\" cy=\"907.642\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"644.443\" cy=\"836.719\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"648.205\" cy=\"839.048\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"651.966\" cy=\"873.025\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"655.727\" cy=\"867.097\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"659.489\" cy=\"902.119\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"663.25\" cy=\"826.743\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"667.012\" cy=\"836.588\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"670.773\" cy=\"1001.9\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"674.534\" cy=\"837.877\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"678.296\" cy=\"1039.26\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"682.057\" cy=\"890.418\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"685.819\" cy=\"851.665\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"689.58\" cy=\"895.072\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"693.341\" cy=\"837.877\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"697.103\" cy=\"881.54\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"700.864\" cy=\"890.418\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"704.626\" cy=\"851.665\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"708.387\" cy=\"1001.9\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"712.148\" cy=\"839.048\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"715.91\" cy=\"1039.26\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"719.671\" cy=\"902.119\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"723.433\" cy=\"836.588\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"727.194\" cy=\"907.642\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"730.955\" cy=\"836.719\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"734.717\" cy=\"873.025\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"738.478\" cy=\"867.097\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"742.24\" cy=\"826.743\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"746.001\" cy=\"1288.96\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"749.762\" cy=\"1095.59\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"753.524\" cy=\"1079.99\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"757.285\" cy=\"1379.98\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"761.047\" cy=\"1385.73\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"764.808\" cy=\"1296.13\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"768.569\" cy=\"1129.2\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"772.331\" cy=\"1096.49\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"776.092\" cy=\"1099.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"779.853\" cy=\"1045.97\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"783.615\" cy=\"1082.42\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"787.376\" cy=\"1228.54\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"791.138\" cy=\"1047.37\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"794.899\" cy=\"1193.84\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"798.66\" cy=\"1045.97\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"802.422\" cy=\"1201.9\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"806.183\" cy=\"1228.54\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"809.945\" cy=\"1047.37\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"813.706\" cy=\"1099.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"817.467\" cy=\"1079.99\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"821.229\" cy=\"1082.42\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"824.99\" cy=\"1296.13\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"828.752\" cy=\"1096.49\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"832.513\" cy=\"1288.96\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"836.274\" cy=\"1095.59\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"840.036\" cy=\"1379.98\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"843.797\" cy=\"1385.73\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"847.559\" cy=\"1129.2\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"851.32\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"855.081\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"858.843\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"862.604\" cy=\"323.153\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"866.366\" cy=\"249.852\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"870.127\" cy=\"216.56\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"873.888\" cy=\"302.857\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"877.65\" cy=\"287.19\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"881.411\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"885.173\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"888.934\" cy=\"279.564\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"892.695\" cy=\"213.985\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"896.457\" cy=\"277.903\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"900.218\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"903.98\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"907.741\" cy=\"302.281\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"911.502\" cy=\"213.985\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"915.264\" cy=\"277.903\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"919.025\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"922.786\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"926.548\" cy=\"279.564\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"930.309\" cy=\"216.56\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"934.071\" cy=\"287.19\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"937.832\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"941.593\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"945.355\" cy=\"323.153\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"949.116\" cy=\"249.852\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"952.878\" cy=\"302.857\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"956.639\" cy=\"485.983\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"960.4\" cy=\"417.442\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"964.162\" cy=\"393.774\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"967.923\" cy=\"585.269\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"971.685\" cy=\"530.798\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"975.446\" cy=\"519.645\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"979.207\" cy=\"383.226\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"982.969\" cy=\"522.795\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"986.73\" cy=\"461.29\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"990.492\" cy=\"383.226\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"994.253\" cy=\"522.795\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"998.014\" cy=\"519.645\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1001.78\" cy=\"393.774\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1005.54\" cy=\"530.798\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1009.3\" cy=\"485.983\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1013.06\" cy=\"417.442\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1016.82\" cy=\"585.269\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1020.58\" cy=\"774.227\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1024.34\" cy=\"636.834\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1028.11\" cy=\"612.882\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1031.87\" cy=\"675.126\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1035.63\" cy=\"689.618\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1039.39\" cy=\"679.643\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1043.15\" cy=\"600.746\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1046.91\" cy=\"675.183\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1050.67\" cy=\"750.763\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1054.44\" cy=\"600.746\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1058.2\" cy=\"675.183\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1061.96\" cy=\"679.643\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1065.72\" cy=\"612.882\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1069.48\" cy=\"689.618\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1073.24\" cy=\"774.227\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1077\" cy=\"636.834\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1080.77\" cy=\"675.126\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1084.53\" cy=\"895.636\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1088.29\" cy=\"851.56\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1092.05\" cy=\"837.793\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1095.81\" cy=\"1044.33\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1099.57\" cy=\"1007.09\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1103.33\" cy=\"984.556\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1107.09\" cy=\"822.801\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1110.86\" cy=\"990.045\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1114.62\" cy=\"868.175\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1118.38\" cy=\"822.801\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1122.14\" cy=\"990.045\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1125.9\" cy=\"984.556\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1129.66\" cy=\"837.793\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1133.42\" cy=\"1007.09\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1137.19\" cy=\"895.636\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1140.95\" cy=\"851.56\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1144.71\" cy=\"1044.33\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1148.47\" cy=\"1220.93\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1152.23\" cy=\"1046.07\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1155.99\" cy=\"1045.51\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1159.75\" cy=\"1075.08\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1163.52\" cy=\"1093.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1167.28\" cy=\"1055.5\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1171.04\" cy=\"1014.66\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1174.8\" cy=\"1050.12\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1178.56\" cy=\"1160.32\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1182.32\" cy=\"1014.66\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1186.08\" cy=\"1050.12\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1189.85\" cy=\"1055.5\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1193.61\" cy=\"1045.51\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1197.37\" cy=\"1093.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1201.13\" cy=\"1220.93\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1204.89\" cy=\"1046.07\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1208.65\" cy=\"1075.08\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1212.41\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1216.18\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1219.94\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1223.7\" cy=\"323.153\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1227.46\" cy=\"249.852\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1231.22\" cy=\"216.56\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1234.98\" cy=\"347.461\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1238.74\" cy=\"306.328\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1242.51\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1246.27\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1250.03\" cy=\"279.564\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1253.79\" cy=\"213.985\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1257.55\" cy=\"303.886\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1261.31\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1265.07\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1268.83\" cy=\"302.281\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1272.6\" cy=\"213.985\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1276.36\" cy=\"303.886\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1280.12\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1283.88\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1287.64\" cy=\"279.564\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1291.4\" cy=\"216.56\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1295.16\" cy=\"306.328\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1298.93\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1302.69\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1306.45\" cy=\"323.153\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1310.21\" cy=\"249.852\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1313.97\" cy=\"347.461\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1317.73\" cy=\"485.983\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1321.49\" cy=\"417.442\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1325.26\" cy=\"393.774\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1329.02\" cy=\"467.986\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1332.78\" cy=\"470.621\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1336.54\" cy=\"519.645\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1340.3\" cy=\"383.226\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1344.06\" cy=\"458.162\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1347.82\" cy=\"461.29\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1351.59\" cy=\"383.226\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1355.35\" cy=\"458.162\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1359.11\" cy=\"519.645\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1362.87\" cy=\"393.774\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1366.63\" cy=\"470.621\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1370.39\" cy=\"485.983\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1374.15\" cy=\"417.442\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1377.92\" cy=\"467.986\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1381.68\" cy=\"774.227\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1385.44\" cy=\"636.834\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1389.2\" cy=\"612.882\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1392.96\" cy=\"819.736\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1396.72\" cy=\"766.867\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1400.48\" cy=\"679.643\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1404.25\" cy=\"600.746\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1408.01\" cy=\"755.189\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1411.77\" cy=\"750.763\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1415.53\" cy=\"600.746\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1419.29\" cy=\"755.189\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1423.05\" cy=\"679.643\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1426.81\" cy=\"612.882\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1430.57\" cy=\"766.867\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1434.34\" cy=\"774.227\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1438.1\" cy=\"636.834\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1441.86\" cy=\"819.736\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1445.62\" cy=\"895.636\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1449.38\" cy=\"851.56\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1453.14\" cy=\"837.793\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1456.9\" cy=\"875.238\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1460.67\" cy=\"889.502\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1464.43\" cy=\"984.556\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1468.19\" cy=\"822.801\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1471.95\" cy=\"862.847\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1475.71\" cy=\"868.175\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1479.47\" cy=\"822.801\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1483.23\" cy=\"862.847\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1487\" cy=\"984.556\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1490.76\" cy=\"837.793\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1494.52\" cy=\"889.502\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1498.28\" cy=\"895.636\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1502.04\" cy=\"851.56\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1505.8\" cy=\"875.238\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1509.56\" cy=\"1220.93\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1513.33\" cy=\"1046.07\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1517.09\" cy=\"1045.51\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1520.85\" cy=\"1206.31\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1524.61\" cy=\"1199.03\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1528.37\" cy=\"1055.5\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1532.13\" cy=\"1014.66\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1535.89\" cy=\"1165.97\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1539.66\" cy=\"1160.32\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1543.42\" cy=\"1014.66\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1547.18\" cy=\"1165.97\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1550.94\" cy=\"1055.5\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1554.7\" cy=\"1045.51\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1558.46\" cy=\"1199.03\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1562.22\" cy=\"1220.93\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1565.98\" cy=\"1046.07\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1569.75\" cy=\"1206.31\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1573.51\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1577.27\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1581.03\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1584.79\" cy=\"345.703\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1588.55\" cy=\"262.768\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1592.31\" cy=\"222.043\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1596.08\" cy=\"302.857\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1599.84\" cy=\"287.19\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1603.6\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1607.36\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1611.12\" cy=\"288.711\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1614.88\" cy=\"216.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1618.64\" cy=\"277.903\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1622.41\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1626.17\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1629.93\" cy=\"304.796\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1633.69\" cy=\"216.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1637.45\" cy=\"277.903\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1641.21\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1644.97\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1648.74\" cy=\"288.711\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1652.5\" cy=\"222.043\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1656.26\" cy=\"287.19\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1660.02\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1663.78\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1667.54\" cy=\"345.703\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1671.3\" cy=\"262.768\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1675.07\" cy=\"302.857\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1678.83\" cy=\"515.18\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1682.59\" cy=\"461.086\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1686.35\" cy=\"416.039\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1690.11\" cy=\"585.269\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1693.87\" cy=\"530.798\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1697.63\" cy=\"527.757\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1701.4\" cy=\"393.751\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1705.16\" cy=\"522.795\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1708.92\" cy=\"473.564\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1712.68\" cy=\"393.751\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1716.44\" cy=\"522.795\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1720.2\" cy=\"527.757\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1723.96\" cy=\"416.039\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1727.72\" cy=\"530.798\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1731.49\" cy=\"515.18\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1735.25\" cy=\"461.086\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1739.01\" cy=\"585.269\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1742.77\" cy=\"760.396\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1746.53\" cy=\"641.137\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1750.29\" cy=\"621.876\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1754.05\" cy=\"675.126\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1757.82\" cy=\"689.618\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1761.58\" cy=\"693.944\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1765.34\" cy=\"612.831\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1769.1\" cy=\"675.183\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1772.86\" cy=\"762.568\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1776.62\" cy=\"612.831\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1780.38\" cy=\"675.183\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1784.15\" cy=\"693.944\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1787.91\" cy=\"621.876\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1791.67\" cy=\"689.618\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1795.43\" cy=\"760.396\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1799.19\" cy=\"641.137\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1802.95\" cy=\"675.126\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1806.71\" cy=\"907.642\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1810.48\" cy=\"836.719\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1814.24\" cy=\"839.048\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1818\" cy=\"1044.33\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1821.76\" cy=\"1007.09\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1825.52\" cy=\"1001.9\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1829.28\" cy=\"837.877\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1833.04\" cy=\"990.045\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1836.81\" cy=\"895.072\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1840.57\" cy=\"837.877\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1844.33\" cy=\"990.045\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1848.09\" cy=\"1001.9\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1851.85\" cy=\"839.048\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1855.61\" cy=\"1007.09\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1859.37\" cy=\"907.642\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1863.14\" cy=\"836.719\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1866.9\" cy=\"1044.33\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1870.66\" cy=\"1288.96\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1874.42\" cy=\"1095.59\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1878.18\" cy=\"1079.99\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1881.94\" cy=\"1075.08\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1885.7\" cy=\"1093.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1889.46\" cy=\"1099.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1893.23\" cy=\"1045.97\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1896.99\" cy=\"1050.12\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1900.75\" cy=\"1193.84\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1904.51\" cy=\"1045.97\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1908.27\" cy=\"1050.12\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1912.03\" cy=\"1099.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1915.79\" cy=\"1079.99\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1919.56\" cy=\"1093.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1923.32\" cy=\"1288.96\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1927.08\" cy=\"1095.59\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1930.84\" cy=\"1075.08\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1934.6\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1938.36\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1942.12\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1945.89\" cy=\"435.464\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1949.65\" cy=\"367.001\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1953.41\" cy=\"263.106\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1957.17\" cy=\"437.415\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1960.93\" cy=\"347.173\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1964.69\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1968.45\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1972.22\" cy=\"304.536\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1975.98\" cy=\"250.218\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1979.74\" cy=\"324.722\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1983.5\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1987.26\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1991.02\" cy=\"345.696\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1994.78\" cy=\"250.218\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"1998.55\" cy=\"324.722\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2002.31\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2006.07\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2009.83\" cy=\"304.536\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2013.59\" cy=\"263.106\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2017.35\" cy=\"347.173\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2021.11\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2024.88\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2028.64\" cy=\"435.464\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2032.4\" cy=\"367.001\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2036.16\" cy=\"437.415\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2039.92\" cy=\"521.702\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2043.68\" cy=\"499.774\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2047.44\" cy=\"460.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2051.2\" cy=\"518.413\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2054.97\" cy=\"512.058\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2058.73\" cy=\"581.698\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2062.49\" cy=\"417.007\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2066.25\" cy=\"482.616\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2070.01\" cy=\"471.128\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2073.77\" cy=\"417.007\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2077.53\" cy=\"482.616\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2081.3\" cy=\"581.698\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2085.06\" cy=\"460.53\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2088.82\" cy=\"512.058\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2092.58\" cy=\"521.702\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2096.34\" cy=\"499.774\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2100.1\" cy=\"518.413\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2103.86\" cy=\"791.242\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2107.63\" cy=\"668.403\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2111.39\" cy=\"641.387\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2115.15\" cy=\"795.899\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2118.91\" cy=\"764.784\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2122.67\" cy=\"679.848\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2126.43\" cy=\"636.975\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2130.19\" cy=\"778.812\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2133.96\" cy=\"815.144\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2137.72\" cy=\"636.975\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2141.48\" cy=\"778.812\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2145.24\" cy=\"679.848\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2149\" cy=\"641.387\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2152.76\" cy=\"764.784\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2156.52\" cy=\"791.242\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2160.29\" cy=\"668.403\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2164.05\" cy=\"795.899\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2167.81\" cy=\"873.025\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2171.57\" cy=\"826.743\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2175.33\" cy=\"836.588\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2179.09\" cy=\"867.097\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2182.85\" cy=\"902.119\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2186.62\" cy=\"1039.26\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2190.38\" cy=\"851.665\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2194.14\" cy=\"890.418\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2197.9\" cy=\"881.54\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2201.66\" cy=\"851.665\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2205.42\" cy=\"890.418\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2209.18\" cy=\"1039.26\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2212.94\" cy=\"836.588\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2216.71\" cy=\"902.119\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2220.47\" cy=\"873.025\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2224.23\" cy=\"826.743\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2227.99\" cy=\"867.097\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2231.75\" cy=\"1379.98\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2235.51\" cy=\"1129.2\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2239.27\" cy=\"1096.49\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2243.04\" cy=\"1385.73\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2246.8\" cy=\"1296.13\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2250.56\" cy=\"1082.42\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2254.32\" cy=\"1047.37\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2258.08\" cy=\"1228.54\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2261.84\" cy=\"1201.9\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2265.6\" cy=\"1047.37\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2269.37\" cy=\"1228.54\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2273.13\" cy=\"1082.42\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2276.89\" cy=\"1096.49\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2280.65\" cy=\"1296.13\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2284.41\" cy=\"1379.98\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2288.17\" cy=\"1129.2\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip1102)\" cx=\"2291.93\" cy=\"1385.73\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<path clip-path=\"url(#clip1100)\" d=\"\n", "M1853.56 386.635 L2280.76 386.635 L2280.76 205.195 L1853.56 205.195 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<polyline clip-path=\"url(#clip1100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1853.56,386.635 2280.76,386.635 2280.76,205.195 1853.56,205.195 1853.56,386.635 \n", " \"/>\n", "<circle clip-path=\"url(#clip1100)\" cx=\"1961.56\" cy=\"265.675\" r=\"21\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2045.56, 283.175)\" x=\"2045.56\" y=\"283.175\">Dyanmic</text>\n", "</g>\n", "<circle clip-path=\"url(#clip1100)\" cx=\"1961.56\" cy=\"326.155\" r=\"21\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<g clip-path=\"url(#clip1100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2045.56, 343.655)\" x=\"2045.56\" y=\"343.655\">FEA</text>\n", "</g>\n", "</svg>\n" ] }, "execution_count": 26, "metadata": {}, "output_type": "execute_result" } ], "source": [ "n=[]\n", "nFEA=[]\n", "j=length(displacements[end])\n", "for i in 1:j\n", " append!(n,displacements[end][i].y)\n", " append!(nFEA,displacementFEA[i].y)\n", "end\n", "scatter(1:j,n,label=\"Dyanmic\",xlabel=\"Node ID\",ylabel=\"displacement\",title=\"Node Displacement\")\n", "scatter!(1:j,nFEA,label=\"FEA\")\n", "# savefig(\"node_displacement_four_voxel\")" ] }, { "cell_type": "code", "execution_count": 27, "metadata": { "scrolled": true }, "outputs": [ { "data": { "image/svg+xml": [ "<?xml version=\"1.0\" encoding=\"utf-8\"?>\n", "<svg xmlns=\"http://www.w3.org/2000/svg\" xmlns:xlink=\"http://www.w3.org/1999/xlink\" width=\"600\" height=\"400\" viewBox=\"0 0 2400 1600\">\n", "<defs>\n", " <clipPath id=\"clip1500\">\n", " <rect x=\"0\" y=\"0\" width=\"2400\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip1500)\" d=\"\n", "M0 1600 L2400 1600 L2400 0 L0 0 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip1501\">\n", " <rect x=\"480\" y=\"0\" width=\"1681\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip1500)\" d=\"\n", "M215.754 1425.62 L2352.76 1425.62 L2352.76 121.675 L215.754 121.675 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip1502\">\n", " <rect x=\"215\" y=\"121\" width=\"2138\" height=\"1305\"/>\n", " </clipPath>\n", "</defs>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 276.235,1425.62 276.235,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 780.245,1425.62 780.245,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1284.25,1425.62 1284.25,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1788.26,1425.62 1788.26,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 2292.27,1425.62 2292.27,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 215.754,1388.71 2352.76,1388.71 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 215.754,1034.12 2352.76,1034.12 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 215.754,679.531 2352.76,679.531 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 215.754,324.94 2352.76,324.94 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 215.754,1425.62 2352.76,1425.62 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 215.754,1425.62 215.754,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 276.235,1425.62 276.235,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 780.245,1425.62 780.245,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1284.25,1425.62 1284.25,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1788.26,1425.62 1788.26,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2292.27,1425.62 2292.27,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 215.754,1388.71 241.398,1388.71 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 215.754,1034.12 241.398,1034.12 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 215.754,679.531 241.398,679.531 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 215.754,324.94 241.398,324.94 \n", " \"/>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 276.235, 1479.62)\" x=\"276.235\" y=\"1479.62\">1</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 780.245, 1479.62)\" x=\"780.245\" y=\"1479.62\">2</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1284.25, 1479.62)\" x=\"1284.25\" y=\"1479.62\">3</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1788.26, 1479.62)\" x=\"1788.26\" y=\"1479.62\">4</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 2292.27, 1479.62)\" x=\"2292.27\" y=\"1479.62\">5</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 191.754, 1406.21)\" x=\"191.754\" y=\"1406.21\">0.0</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 191.754, 1051.62)\" x=\"191.754\" y=\"1051.62\">0.5</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 191.754, 697.031)\" x=\"191.754\" y=\"697.031\">1.0</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 191.754, 342.44)\" x=\"191.754\" y=\"342.44\">1.5</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:84px; text-anchor:middle;\" transform=\"rotate(0, 1284.25, 73.2)\" x=\"1284.25\" y=\"73.2\">Young's Modulus</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(0, 1284.25, 1559.48)\" x=\"1284.25\" y=\"1559.48\">lattice size</text>\n", "</g>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(-90, 89.2861, 773.647)\" x=\"89.2861\" y=\"773.647\">E</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 276.235,1388.71 780.245,1388.71 1284.25,1388.71 1788.26,1388.71 2292.27,168.154 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1502)\" style=\"stroke:#e26f46; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 276.235,1388.71 780.245,1388.71 1284.25,1388.71 1788.26,1388.71 2292.27,158.579 \n", " \"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"276.235\" cy=\"1388.71\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"780.245\" cy=\"1388.71\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"1284.25\" cy=\"1388.71\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"1788.26\" cy=\"1388.71\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"2292.27\" cy=\"168.154\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"276.235\" cy=\"1388.71\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"780.245\" cy=\"1388.71\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"1284.25\" cy=\"1388.71\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"1788.26\" cy=\"1388.71\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip1502)\" cx=\"2292.27\" cy=\"158.579\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<path clip-path=\"url(#clip1500)\" d=\"\n", "M1853.56 386.635 L2280.76 386.635 L2280.76 205.195 L1853.56 205.195 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1853.56,386.635 2280.76,386.635 2280.76,205.195 1853.56,205.195 1853.56,386.635 \n", " \"/>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1877.56,265.675 2021.56,265.675 \n", " \"/>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2045.56, 283.175)\" x=\"2045.56\" y=\"283.175\">Dyanmic</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip1500)\" style=\"stroke:#e26f46; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1877.56,326.155 2021.56,326.155 \n", " \"/>\n", "<g clip-path=\"url(#clip1500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2045.56, 343.655)\" x=\"2045.56\" y=\"343.655\">FEA</text>\n", "</g>\n", "</svg>\n" ] }, "execution_count": 27, "metadata": {}, "output_type": "execute_result" } ], "source": [ "# Es[1]=EsFEA[1]\n", "plot(1:5,Es,label=\"Dyanmic\",xlabel=\"lattice size\",ylabel=\"E\",title=\"Young's Modulus\")\n", "plot!(1:5,EsFEA,label=\"FEA\")\n", "scatter!(1:5,Es,color=\"black\",label=\"\")\n", "scatter!(1:5,EsFEA,color=\"black\",label=\"\")\n", "# savefig(\"youngs_modulus1\")" ] }, { "cell_type": "code", "execution_count": 28, "metadata": {}, "outputs": [ { "ename": "BoundsError", "evalue": "BoundsError: attempt to access 0-element Array{Float64,1} at index [1:201]", "output_type": "error", "traceback": [ "BoundsError: attempt to access 0-element Array{Float64,1} at index [1:201]", "", "Stacktrace:", " [1] throw_boundserror(::Array{Float64,1}, ::Tuple{UnitRange{Int64}}) at .\\abstractarray.jl:538", " [2] checkbounds at .\\abstractarray.jl:503 [inlined]", " [3] getindex(::Array{Float64,1}, ::UnitRange{Int64}) at .\\array.jl:734", " [4] gr_display(::Plots.Subplot{Plots.GRBackend}, ::Measures.Length{:mm,Float64}, ::Measures.Length{:mm,Float64}, ::Array{Float64,1}) at C:\\Users\\amira\\.julia\\packages\\Plots\\cc8wh\\src\\backends\\gr.jl:1597", " [5] gr_display(::Plots.Plot{Plots.GRBackend}, ::String) at C:\\Users\\amira\\.julia\\packages\\Plots\\cc8wh\\src\\backends\\gr.jl:716", " [6] _show(::Base.GenericIOBuffer{Array{UInt8,1}}, ::MIME{Symbol(\"image/svg+xml\")}, ::Plots.Plot{Plots.GRBackend}) at C:\\Users\\amira\\.julia\\packages\\Plots\\cc8wh\\src\\backends\\gr.jl:1922", " [7] show(::Base.GenericIOBuffer{Array{UInt8,1}}, ::MIME{Symbol(\"image/svg+xml\")}, ::Plots.Plot{Plots.GRBackend}) at C:\\Users\\amira\\.julia\\packages\\Plots\\cc8wh\\src\\output.jl:216", " [8] #sprint#342(::Nothing, ::Int64, ::typeof(sprint), ::Function, ::MIME{Symbol(\"image/svg+xml\")}, ::Vararg{Any,N} where N) at .\\strings\\io.jl:107", " [9] sprint(::Function, ::MIME{Symbol(\"image/svg+xml\")}, ::Vararg{Any,N} where N) at .\\strings\\io.jl:103", " [10] _ijulia_display_dict(::Plots.Plot{Plots.GRBackend}) at C:\\Users\\amira\\.julia\\packages\\Plots\\cc8wh\\src\\ijulia.jl:53", " [11] display_dict(::Plots.Plot{Plots.GRBackend}) at C:\\Users\\amira\\.julia\\packages\\Plots\\cc8wh\\src\\init.jl:83", " [12] #invokelatest#1 at .\\essentials.jl:790 [inlined]", " [13] invokelatest at .\\essentials.jl:789 [inlined]", " [14] execute_request(::ZMQ.Socket, ::IJulia.Msg) at C:\\Users\\amira\\.julia\\packages\\IJulia\\DrVMH\\src\\execute_request.jl:112", " [15] #invokelatest#1 at .\\essentials.jl:790 [inlined]", " [16] invokelatest at .\\essentials.jl:789 [inlined]", " [17] eventloop(::ZMQ.Socket) at C:\\Users\\amira\\.julia\\packages\\IJulia\\DrVMH\\src\\eventloop.jl:8", " [18] (::getfield(IJulia, Symbol(\"##15#18\")))() at .\\task.jl:268" ] } ], "source": [ "plot()\n", "for i in 2:5\n", " plot!(1:step:numTimeStepsRecorded,DDisplacements[i],label=\"$i x dynamic\",xlabel=\"timestep\",ylabel=\"displacement\",title=\"Dynamic Model Convergence\")\n", " plot!(1:step:numTimeStepsRecorded,DDisplacementsFEA[i],label=\"$i x fea\",xlabel=\"timestep\",ylabel=\"displacement\",title=\"Dynamic Model Convergence\")\n", "\n", "end\n", "plot!()\n", "# savefig(\"total_convergence1\")" ] }, { "cell_type": "code", "execution_count": 29, "metadata": {}, "outputs": [ { "name": "stdout", "output_type": "stream", "text": [ "[0.0, 0.0, 0.0, 0.0, 1.73458063195242]\n" ] }, { "data": { "image/svg+xml": [ "<?xml version=\"1.0\" encoding=\"utf-8\"?>\n", "<svg xmlns=\"http://www.w3.org/2000/svg\" xmlns:xlink=\"http://www.w3.org/1999/xlink\" width=\"600\" height=\"400\" viewBox=\"0 0 2400 1600\">\n", "<defs>\n", " <clipPath id=\"clip2100\">\n", " <rect x=\"0\" y=\"0\" width=\"2400\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip2100)\" d=\"\n", "M0 1600 L2400 1600 L2400 0 L0 0 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip2101\">\n", " <rect x=\"480\" y=\"0\" width=\"1681\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip2100)\" d=\"\n", "M175.611 1425.62 L2352.76 1425.62 L2352.76 47.2441 L175.611 47.2441 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip2102\">\n", " <rect x=\"175\" y=\"47\" width=\"2178\" height=\"1379\"/>\n", " </clipPath>\n", "</defs>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 237.228,1425.62 237.228,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 750.706,1425.62 750.706,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1264.18,1425.62 1264.18,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1777.66,1425.62 1777.66,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 2291.14,1425.62 2291.14,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 175.611,1386.61 2352.76,1386.61 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 175.611,1030.15 2352.76,1030.15 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 175.611,673.695 2352.76,673.695 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 175.611,317.239 2352.76,317.239 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 175.611,1425.62 2352.76,1425.62 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 175.611,1425.62 175.611,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 237.228,1425.62 237.228,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 750.706,1425.62 750.706,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1264.18,1425.62 1264.18,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1777.66,1425.62 1777.66,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2291.14,1425.62 2291.14,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 175.611,1386.61 201.736,1386.61 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 175.611,1030.15 201.736,1030.15 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 175.611,673.695 201.736,673.695 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 175.611,317.239 201.736,317.239 \n", " \"/>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 237.228, 1479.62)\" x=\"237.228\" y=\"1479.62\">1</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 750.706, 1479.62)\" x=\"750.706\" y=\"1479.62\">2</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1264.18, 1479.62)\" x=\"1264.18\" y=\"1479.62\">3</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1777.66, 1479.62)\" x=\"1777.66\" y=\"1479.62\">4</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 2291.14, 1479.62)\" x=\"2291.14\" y=\"1479.62\">5</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 151.611, 1404.11)\" x=\"151.611\" y=\"1404.11\">0</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 151.611, 1047.65)\" x=\"151.611\" y=\"1047.65\">1</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 151.611, 691.195)\" x=\"151.611\" y=\"691.195\">2</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 151.611, 334.739)\" x=\"151.611\" y=\"334.739\">3</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(0, 1264.18, 1559.48)\" x=\"1264.18\" y=\"1559.48\">lattice size</text>\n", "</g>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(-90, 89.2861, 736.431)\" x=\"89.2861\" y=\"736.431\">E</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 237.228,1386.61 750.706,1386.61 1264.18,1386.61 1777.66,1386.61 2291.14,768.305 \n", " \"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"237.228\" cy=\"1386.61\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"750.706\" cy=\"1386.61\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"1264.18\" cy=\"1386.61\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"1777.66\" cy=\"1386.61\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"2291.14\" cy=\"768.305\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#3da44d; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 237.228,1226.2 750.706,782.093 1264.18,565.653 1777.66,86.2547 \n", " \"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"237.228\" cy=\"1226.2\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"750.706\" cy=\"782.093\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"1264.18\" cy=\"565.653\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"1777.66\" cy=\"86.2547\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<polyline clip-path=\"url(#clip2102)\" style=\"stroke:#ac8d18; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 237.228,1365.22 750.706,901.827 1264.18,855.488 1777.66,787.761 2291.14,769.938 \n", " \"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"237.228\" cy=\"1365.22\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"750.706\" cy=\"901.827\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"1264.18\" cy=\"855.488\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"1777.66\" cy=\"787.761\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip2102)\" cx=\"2291.14\" cy=\"769.938\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<path clip-path=\"url(#clip2100)\" d=\"\n", "M1636.82 372.684 L2280.76 372.684 L2280.76 130.764 L1636.82 130.764 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1636.82,372.684 2280.76,372.684 2280.76,130.764 1636.82,130.764 1636.82,372.684 \n", " \"/>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1660.82,191.244 1804.82,191.244 \n", " \"/>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 1828.82, 208.744)\" x=\"1828.82\" y=\"208.744\">metavoxel (single)</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#3da44d; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1660.82,251.724 1804.82,251.724 \n", " \"/>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 1828.82, 269.224)\" x=\"1828.82\" y=\"269.224\">measured (double)</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip2100)\" style=\"stroke:#ac8d18; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1660.82,312.204 1804.82,312.204 \n", " \"/>\n", "<g clip-path=\"url(#clip2100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 1828.82, 329.704)\" x=\"1828.82\" y=\"329.704\">voxframe (single)</text>\n", "</g>\n", "</svg>\n" ] }, "execution_count": 29, "metadata": {}, "output_type": "execute_result" } ], "source": [ "Emeasured = [0.4500, 1.6959, 2.3031, 3.6480]\n", "voxFrameSingle=[0.06,1.36,1.49,1.68,1.73]#,1.80,1.83]\n", "println(EsFEA)\n", "plot(1:5,EsFEA,label=\"metavoxel (single)\",xlabel=\"lattice size\",ylabel=\"E\")\n", "scatter!(1:5,EsFEA,color=\"black\",label=\"\")\n", "plot!(1:4,Emeasured,label=\"measured (double)\")\n", "scatter!(1:4,Emeasured,color=\"black\",label=\"\")\n", "plot!(1:5,voxFrameSingle,label=\"voxframe (single)\")\n", "scatter!(1:5,voxFrameSingle,color=\"black\",label=\"\")\n", "# savefig(\"youngs_fea_comparison\")" ] }, { "cell_type": "code", "execution_count": 284, "metadata": {}, "outputs": [ { "data": { "image/svg+xml": [ "<?xml version=\"1.0\" encoding=\"utf-8\"?>\n", "<svg xmlns=\"http://www.w3.org/2000/svg\" xmlns:xlink=\"http://www.w3.org/1999/xlink\" width=\"600\" height=\"400\" viewBox=\"0 0 2400 1600\">\n", "<defs>\n", " <clipPath id=\"clip6300\">\n", " <rect x=\"0\" y=\"0\" width=\"2400\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip6300)\" d=\"\n", "M0 1600 L2400 1600 L2400 0 L0 0 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip6301\">\n", " <rect x=\"480\" y=\"0\" width=\"1681\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip6300)\" d=\"\n", "M202.373 1425.62 L2352.76 1425.62 L2352.76 47.2441 L202.373 47.2441 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip6302\">\n", " <rect x=\"202\" y=\"47\" width=\"2151\" height=\"1379\"/>\n", " </clipPath>\n", "</defs>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 262.737,1425.62 262.737,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 758.137,1425.62 758.137,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1253.54,1425.62 1253.54,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1748.94,1425.62 1748.94,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 2244.34,1425.62 2244.34,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 202.373,1386.66 2352.76,1386.66 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 202.373,1119.97 2352.76,1119.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 202.373,853.271 2352.76,853.271 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 202.373,586.575 2352.76,586.575 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 202.373,319.88 2352.76,319.88 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 202.373,53.1845 2352.76,53.1845 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 202.373,1425.62 2352.76,1425.62 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 202.373,1425.62 202.373,47.2441 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 262.737,1425.62 262.737,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 758.137,1425.62 758.137,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1253.54,1425.62 1253.54,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1748.94,1425.62 1748.94,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2244.34,1425.62 2244.34,1409.08 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 202.373,1386.66 228.178,1386.66 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 202.373,1119.97 228.178,1119.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 202.373,853.271 228.178,853.271 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 202.373,586.575 228.178,586.575 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 202.373,319.88 228.178,319.88 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 202.373,53.1845 228.178,53.1845 \n", " \"/>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 262.737, 1479.62)\" x=\"262.737\" y=\"1479.62\">0</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 758.137, 1479.62)\" x=\"758.137\" y=\"1479.62\">1000</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1253.54, 1479.62)\" x=\"1253.54\" y=\"1479.62\">2000</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1748.94, 1479.62)\" x=\"1748.94\" y=\"1479.62\">3000</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 2244.34, 1479.62)\" x=\"2244.34\" y=\"1479.62\">4000</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 178.373, 1404.16)\" x=\"178.373\" y=\"1404.16\">0</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 178.373, 1137.47)\" x=\"178.373\" y=\"1137.47\">5</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 178.373, 870.771)\" x=\"178.373\" y=\"870.771\">10</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 178.373, 604.075)\" x=\"178.373\" y=\"604.075\">15</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 178.373, 337.38)\" x=\"178.373\" y=\"337.38\">20</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 178.373, 70.6845)\" x=\"178.373\" y=\"70.6845\">25</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(0, 1277.56, 1559.48)\" x=\"1277.56\" y=\"1559.48\">number of voxels</text>\n", "</g>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(-90, 89.2861, 736.431)\" x=\"89.2861\" y=\"736.431\">Time(s)</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 263.233,1383.64 266.701,1378.48 294.443,1370.66 516.382,1365.33 2291.9,1343.99 \n", " \"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"263.233\" cy=\"1383.64\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"266.701\" cy=\"1378.48\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"294.443\" cy=\"1370.66\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"516.382\" cy=\"1365.33\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"2291.9\" cy=\"1343.99\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<polyline clip-path=\"url(#clip6302)\" style=\"stroke:#3da44d; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 263.233,1386.61 266.701,1386.53 294.443,1383.71 516.382,1354.93 2291.9,86.2547 \n", " \"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"263.233\" cy=\"1386.61\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"266.701\" cy=\"1386.53\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"294.443\" cy=\"1383.71\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"516.382\" cy=\"1354.93\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<circle clip-path=\"url(#clip6302)\" cx=\"2291.9\" cy=\"86.2547\" r=\"14\" fill=\"#000000\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"none\"/>\n", "<path clip-path=\"url(#clip6300)\" d=\"\n", "M1767.89 312.204 L2280.76 312.204 L2280.76 130.764 L1767.89 130.764 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1767.89,312.204 2280.76,312.204 2280.76,130.764 1767.89,130.764 1767.89,312.204 \n", " \"/>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1791.89,191.244 1935.89,191.244 \n", " \"/>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 1959.89, 208.744)\" x=\"1959.89\" y=\"208.744\">dynamic gpu</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip6300)\" style=\"stroke:#3da44d; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1791.89,251.724 1935.89,251.724 \n", " \"/>\n", "<g clip-path=\"url(#clip6300)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 1959.89, 269.224)\" x=\"1959.89\" y=\"269.224\">c solver</text>\n", "</g>\n", "</svg>\n" ] }, "execution_count": 284, "metadata": {}, "output_type": "execute_result" } ], "source": [ "gpu=[5.668E-02,1.534E-01,3.000E-01,4.000E-01,8.000E-01]\n", "csolver=[1.010E-03,2.483E-03,5.534E-02,5.949E-01,2.438E+01]\n", "X=[1,8,64,512,4096]\n", "plot(X,gpu,label=\"dynamic gpu\",xlabel=\"number of voxels\",ylabel=\"Time(s)\")\n", "scatter!(X,gpu,color=\"black\",label=\"\")\n", "plot!(X,csolver,label=\"c solver\")\n", "scatter!(X,csolver,color=\"black\",label=\"\")\n" ] }, { "cell_type": "code", "execution_count": 279, "metadata": {}, "outputs": [ { "data": { "image/svg+xml": [ "<?xml version=\"1.0\" encoding=\"utf-8\"?>\n", "<svg xmlns=\"http://www.w3.org/2000/svg\" xmlns:xlink=\"http://www.w3.org/1999/xlink\" width=\"600\" height=\"400\" viewBox=\"0 0 2400 1600\">\n", "<defs>\n", " <clipPath id=\"clip4700\">\n", " <rect x=\"0\" y=\"0\" width=\"2400\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip4700)\" d=\"\n", "M0 1600 L2400 1600 L2400 0 L0 0 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip4701\">\n", " <rect x=\"480\" y=\"0\" width=\"1681\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip4700)\" d=\"\n", "M269.279 1425.62 L2352.76 1425.62 L2352.76 121.675 L269.279 121.675 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip4702\">\n", " <rect x=\"269\" y=\"121\" width=\"2084\" height=\"1305\"/>\n", " </clipPath>\n", "</defs>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 328.147,1425.62 328.147,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 819.533,1425.62 819.533,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1310.92,1425.62 1310.92,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1802.31,1425.62 1802.31,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 2293.69,1425.62 2293.69,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 269.279,1258.39 2352.76,1258.39 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 269.279,1011.49 2352.76,1011.49 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 269.279,764.584 2352.76,764.584 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 269.279,517.679 2352.76,517.679 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 269.279,270.773 2352.76,270.773 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 269.279,1425.62 2352.76,1425.62 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 269.279,1425.62 269.279,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 328.147,1425.62 328.147,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 819.533,1425.62 819.533,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1310.92,1425.62 1310.92,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1802.31,1425.62 1802.31,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2293.69,1425.62 2293.69,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 269.279,1258.39 294.28,1258.39 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 269.279,1011.49 294.28,1011.49 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 269.279,764.584 294.28,764.584 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 269.279,517.679 294.28,517.679 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 269.279,270.773 294.28,270.773 \n", " \"/>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 328.147, 1479.62)\" x=\"328.147\" y=\"1479.62\">0</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 734.39, 1500.63)\" x=\"734.39\" y=\"1500.63\">5.0×10</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:38px; text-anchor:start;\" transform=\"rotate(0, 882.931, 1473.22)\" x=\"882.931\" y=\"1473.22\">3</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 1225.78, 1500.63)\" x=\"1225.78\" y=\"1500.63\">1.0×10</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:38px; text-anchor:start;\" transform=\"rotate(0, 1374.32, 1473.22)\" x=\"1374.32\" y=\"1473.22\">4</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 1717.16, 1500.63)\" x=\"1717.16\" y=\"1500.63\">1.5×10</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:38px; text-anchor:start;\" transform=\"rotate(0, 1865.7, 1473.22)\" x=\"1865.7\" y=\"1473.22\">4</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2208.55, 1500.63)\" x=\"2208.55\" y=\"1500.63\">2.0×10</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:38px; text-anchor:start;\" transform=\"rotate(0, 2357.09, 1473.22)\" x=\"2357.09\" y=\"1473.22\">4</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 245.279, 1275.89)\" x=\"245.279\" y=\"1275.89\">0.025</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 245.279, 1028.99)\" x=\"245.279\" y=\"1028.99\">0.050</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 245.279, 782.084)\" x=\"245.279\" y=\"782.084\">0.075</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 245.279, 535.179)\" x=\"245.279\" y=\"535.179\">0.100</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 245.279, 288.273)\" x=\"245.279\" y=\"288.273\">0.125</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:84px; text-anchor:middle;\" transform=\"rotate(0, 1311.02, 73.2)\" x=\"1311.02\" y=\"73.2\">Dynamic Model Convergence</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(0, 1311.02, 1559.48)\" x=\"1311.02\" y=\"1559.48\">timestep</text>\n", "</g>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(-90, 89.2861, 773.647)\" x=\"89.2861\" y=\"773.647\">strain</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 328.245,158.579 338.073,158.579 347.901,158.579 357.728,158.579 367.556,158.579 377.384,158.579 387.211,158.579 397.039,158.579 406.867,158.579 416.695,158.579 \n", " 426.522,158.579 436.35,158.579 446.178,158.579 456.005,158.579 465.833,158.579 475.661,158.579 485.489,158.579 495.316,158.579 505.144,158.579 514.972,158.579 \n", " 524.8,158.579 534.627,158.579 544.455,158.579 554.283,158.579 564.11,158.579 573.938,158.579 583.766,158.579 593.594,158.579 603.421,158.579 613.249,158.579 \n", " 623.077,158.579 632.904,158.579 642.732,158.579 652.56,158.579 662.388,158.579 672.215,158.579 682.043,158.579 691.871,158.579 701.699,158.579 711.526,158.579 \n", " 721.354,158.579 731.182,158.579 741.009,158.579 750.837,158.579 760.665,158.579 770.493,158.579 780.32,158.579 790.148,158.579 799.976,158.579 809.803,158.579 \n", " 819.631,158.579 829.459,158.579 839.287,158.579 849.114,158.579 858.942,158.579 868.77,158.579 878.598,158.579 888.425,158.579 898.253,158.579 908.081,158.579 \n", " 917.908,158.579 927.736,158.579 937.564,158.579 947.392,158.579 957.219,158.579 967.047,158.579 976.875,158.579 986.702,158.579 996.53,158.579 1006.36,158.579 \n", " 1016.19,158.579 1026.01,158.579 1035.84,158.579 1045.67,158.579 1055.5,158.579 1065.32,158.579 1075.15,158.579 1084.98,158.579 1094.81,158.579 1104.64,158.579 \n", " 1114.46,158.579 1124.29,158.579 1134.12,158.579 1143.95,158.579 1153.77,158.579 1163.6,158.579 1173.43,158.579 1183.26,158.579 1193.08,158.579 1202.91,158.579 \n", " 1212.74,158.579 1222.57,158.579 1232.4,158.579 1242.22,158.579 1252.05,158.579 1261.88,158.579 1271.71,158.579 1281.53,158.579 1291.36,158.579 1301.19,158.579 \n", " 1311.02,158.579 1320.85,158.579 1330.67,158.579 1340.5,158.579 1350.33,158.579 1360.16,158.579 1369.98,158.579 1379.81,158.579 1389.64,158.579 1399.47,158.579 \n", " 1409.29,158.579 1419.12,158.579 1428.95,158.579 1438.78,158.579 1448.61,158.579 1458.43,158.579 1468.26,158.579 1478.09,158.579 1487.92,158.579 1497.74,158.579 \n", " 1507.57,158.579 1517.4,158.579 1527.23,158.579 1537.05,158.579 1546.88,158.579 1556.71,158.579 1566.54,158.579 1576.37,158.579 1586.19,158.579 1596.02,158.579 \n", " 1605.85,158.579 1615.68,158.579 1625.5,158.579 1635.33,158.579 1645.16,158.579 1654.99,158.579 1664.82,158.579 1674.64,158.579 1684.47,158.579 1694.3,158.579 \n", " 1704.13,158.579 1713.95,158.579 1723.78,158.579 1733.61,158.579 1743.44,158.579 1753.26,158.579 1763.09,158.579 1772.92,158.579 1782.75,158.579 1792.58,158.579 \n", " 1802.4,158.579 1812.23,158.579 1822.06,158.579 1831.89,158.579 1841.71,158.579 1851.54,158.579 1861.37,158.579 1871.2,158.579 1881.03,158.579 1890.85,158.579 \n", " 1900.68,158.579 1910.51,158.579 1920.34,158.579 1930.16,158.579 1939.99,158.579 1949.82,158.579 1959.65,158.579 1969.47,158.579 1979.3,158.579 1989.13,158.579 \n", " 1998.96,158.579 2008.79,158.579 2018.61,158.579 2028.44,158.579 2038.27,158.579 2048.1,158.579 2057.92,158.579 2067.75,158.579 2077.58,158.579 2087.41,158.579 \n", " 2097.24,158.579 2107.06,158.579 2116.89,158.579 2126.72,158.579 2136.55,158.579 2146.37,158.579 2156.2,158.579 2166.03,158.579 2175.86,158.579 2185.68,158.579 \n", " 2195.51,158.579 2205.34,158.579 2215.17,158.579 2225,158.579 2234.82,158.579 2244.65,158.579 2254.48,158.579 2264.31,158.579 2274.13,158.579 2283.96,158.579 \n", " 2293.79,158.579 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#e26f46; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 328.245,1376.9 338.073,1376.9 347.901,1376.9 357.728,1376.9 367.556,1376.9 377.384,1376.9 387.211,1376.9 397.039,1376.9 406.867,1376.9 416.695,1376.9 \n", " 426.522,1376.9 436.35,1376.9 446.178,1376.9 456.005,1376.9 465.833,1376.9 475.661,1376.9 485.489,1376.9 495.316,1376.9 505.144,1376.9 514.972,1376.9 \n", " 524.8,1376.9 534.627,1376.9 544.455,1376.9 554.283,1376.9 564.11,1376.9 573.938,1376.9 583.766,1376.9 593.594,1376.9 603.421,1376.9 613.249,1376.9 \n", " 623.077,1376.9 632.904,1376.9 642.732,1376.9 652.56,1376.9 662.388,1376.9 672.215,1376.9 682.043,1376.9 691.871,1376.9 701.699,1376.9 711.526,1376.9 \n", " 721.354,1376.9 731.182,1376.9 741.009,1376.9 750.837,1376.9 760.665,1376.9 770.493,1376.9 780.32,1376.9 790.148,1376.9 799.976,1376.9 809.803,1376.9 \n", " 819.631,1376.9 829.459,1376.9 839.287,1376.9 849.114,1376.9 858.942,1376.9 868.77,1376.9 878.598,1376.9 888.425,1376.9 898.253,1376.9 908.081,1376.9 \n", " 917.908,1376.9 927.736,1376.9 937.564,1376.9 947.392,1376.9 957.219,1376.9 967.047,1376.9 976.875,1376.9 986.702,1376.9 996.53,1376.9 1006.36,1376.9 \n", " 1016.19,1376.9 1026.01,1376.9 1035.84,1376.9 1045.67,1376.9 1055.5,1376.9 1065.32,1376.9 1075.15,1376.9 1084.98,1376.9 1094.81,1376.9 1104.64,1376.9 \n", " 1114.46,1376.9 1124.29,1376.9 1134.12,1376.9 1143.95,1376.9 1153.77,1376.9 1163.6,1376.9 1173.43,1376.9 1183.26,1376.9 1193.08,1376.9 1202.91,1376.9 \n", " 1212.74,1376.9 1222.57,1376.9 1232.4,1376.9 1242.22,1376.9 1252.05,1376.9 1261.88,1376.9 1271.71,1376.9 1281.53,1376.9 1291.36,1376.9 1301.19,1376.9 \n", " 1311.02,1376.9 1320.85,1376.9 1330.67,1376.9 1340.5,1376.9 1350.33,1376.9 1360.16,1376.9 1369.98,1376.9 1379.81,1376.9 1389.64,1376.9 1399.47,1376.9 \n", " 1409.29,1376.9 1419.12,1376.9 1428.95,1376.9 1438.78,1376.9 1448.61,1376.9 1458.43,1376.9 1468.26,1376.9 1478.09,1376.9 1487.92,1376.9 1497.74,1376.9 \n", " 1507.57,1376.9 1517.4,1376.9 1527.23,1376.9 1537.05,1376.9 1546.88,1376.9 1556.71,1376.9 1566.54,1376.9 1576.37,1376.9 1586.19,1376.9 1596.02,1376.9 \n", " 1605.85,1376.9 1615.68,1376.9 1625.5,1376.9 1635.33,1376.9 1645.16,1376.9 1654.99,1376.9 1664.82,1376.9 1674.64,1376.9 1684.47,1376.9 1694.3,1376.9 \n", " 1704.13,1376.9 1713.95,1376.9 1723.78,1376.9 1733.61,1376.9 1743.44,1376.9 1753.26,1376.9 1763.09,1376.9 1772.92,1376.9 1782.75,1376.9 1792.58,1376.9 \n", " 1802.4,1376.9 1812.23,1376.9 1822.06,1376.9 1831.89,1376.9 1841.71,1376.9 1851.54,1376.9 1861.37,1376.9 1871.2,1376.9 1881.03,1376.9 1890.85,1376.9 \n", " 1900.68,1376.9 1910.51,1376.9 1920.34,1376.9 1930.16,1376.9 1939.99,1376.9 1949.82,1376.9 1959.65,1376.9 1969.47,1376.9 1979.3,1376.9 1989.13,1376.9 \n", " 1998.96,1376.9 2008.79,1376.9 2018.61,1376.9 2028.44,1376.9 2038.27,1376.9 2048.1,1376.9 2057.92,1376.9 2067.75,1376.9 2077.58,1376.9 2087.41,1376.9 \n", " 2097.24,1376.9 2107.06,1376.9 2116.89,1376.9 2126.72,1376.9 2136.55,1376.9 2146.37,1376.9 2156.2,1376.9 2166.03,1376.9 2175.86,1376.9 2185.68,1376.9 \n", " 2195.51,1376.9 2205.34,1376.9 2215.17,1376.9 2225,1376.9 2234.82,1376.9 2244.65,1376.9 2254.48,1376.9 2264.31,1376.9 2274.13,1376.9 2283.96,1376.9 \n", " 2293.79,1376.9 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#3da44d; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 328.245,1366.51 338.073,1366.51 347.901,1366.51 357.728,1366.51 367.556,1366.51 377.384,1366.51 387.211,1366.51 397.039,1366.51 406.867,1366.51 416.695,1366.51 \n", " 426.522,1366.51 436.35,1366.51 446.178,1366.51 456.005,1366.51 465.833,1366.51 475.661,1366.51 485.489,1366.51 495.316,1366.51 505.144,1366.51 514.972,1366.51 \n", " 524.8,1366.51 534.627,1366.51 544.455,1366.51 554.283,1366.51 564.11,1366.51 573.938,1366.51 583.766,1366.51 593.594,1366.51 603.421,1366.51 613.249,1366.51 \n", " 623.077,1366.51 632.904,1366.51 642.732,1366.51 652.56,1366.51 662.388,1366.51 672.215,1366.51 682.043,1366.51 691.871,1366.51 701.699,1366.51 711.526,1366.51 \n", " 721.354,1366.51 731.182,1366.51 741.009,1366.51 750.837,1366.51 760.665,1366.51 770.493,1366.51 780.32,1366.51 790.148,1366.51 799.976,1366.51 809.803,1366.51 \n", " 819.631,1366.51 829.459,1366.51 839.287,1366.51 849.114,1366.51 858.942,1366.51 868.77,1366.51 878.598,1366.51 888.425,1366.51 898.253,1366.51 908.081,1366.51 \n", " 917.908,1366.51 927.736,1366.51 937.564,1366.51 947.392,1366.51 957.219,1366.51 967.047,1366.51 976.875,1366.51 986.702,1366.51 996.53,1366.51 1006.36,1366.51 \n", " 1016.19,1366.51 1026.01,1366.51 1035.84,1366.51 1045.67,1366.51 1055.5,1366.51 1065.32,1366.51 1075.15,1366.51 1084.98,1366.51 1094.81,1366.51 1104.64,1366.51 \n", " 1114.46,1366.51 1124.29,1366.51 1134.12,1366.51 1143.95,1366.51 1153.77,1366.51 1163.6,1366.51 1173.43,1366.51 1183.26,1366.51 1193.08,1366.51 1202.91,1366.51 \n", " 1212.74,1366.51 1222.57,1366.51 1232.4,1366.51 1242.22,1366.51 1252.05,1366.51 1261.88,1366.51 1271.71,1366.51 1281.53,1366.51 1291.36,1366.51 1301.19,1366.51 \n", " 1311.02,1366.51 1320.85,1366.51 1330.67,1366.51 1340.5,1366.51 1350.33,1366.51 1360.16,1366.51 1369.98,1366.51 1379.81,1366.51 1389.64,1366.51 1399.47,1366.51 \n", " 1409.29,1366.51 1419.12,1366.51 1428.95,1366.51 1438.78,1366.51 1448.61,1366.51 1458.43,1366.51 1468.26,1366.51 1478.09,1366.51 1487.92,1366.51 1497.74,1366.51 \n", " 1507.57,1366.51 1517.4,1366.51 1527.23,1366.51 1537.05,1366.51 1546.88,1366.51 1556.71,1366.51 1566.54,1366.51 1576.37,1366.51 1586.19,1366.51 1596.02,1366.51 \n", " 1605.85,1366.51 1615.68,1366.51 1625.5,1366.51 1635.33,1366.51 1645.16,1366.51 1654.99,1366.51 1664.82,1366.51 1674.64,1366.51 1684.47,1366.51 1694.3,1366.51 \n", " 1704.13,1366.51 1713.95,1366.51 1723.78,1366.51 1733.61,1366.51 1743.44,1366.51 1753.26,1366.51 1763.09,1366.51 1772.92,1366.51 1782.75,1366.51 1792.58,1366.51 \n", " 1802.4,1366.51 1812.23,1366.51 1822.06,1366.51 1831.89,1366.51 1841.71,1366.51 1851.54,1366.51 1861.37,1366.51 1871.2,1366.51 1881.03,1366.51 1890.85,1366.51 \n", " 1900.68,1366.51 1910.51,1366.51 1920.34,1366.51 1930.16,1366.51 1939.99,1366.51 1949.82,1366.51 1959.65,1366.51 1969.47,1366.51 1979.3,1366.51 1989.13,1366.51 \n", " 1998.96,1366.51 2008.79,1366.51 2018.61,1366.51 2028.44,1366.51 2038.27,1366.51 2048.1,1366.51 2057.92,1366.51 2067.75,1366.51 2077.58,1366.51 2087.41,1366.51 \n", " 2097.24,1366.51 2107.06,1366.51 2116.89,1366.51 2126.72,1366.51 2136.55,1366.51 2146.37,1366.51 2156.2,1366.51 2166.03,1366.51 2175.86,1366.51 2185.68,1366.51 \n", " 2195.51,1366.51 2205.34,1366.51 2215.17,1366.51 2225,1366.51 2234.82,1366.51 2244.65,1366.51 2254.48,1366.51 2264.31,1366.51 2274.13,1366.51 2283.96,1366.51 \n", " 2293.79,1366.51 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#c271d2; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 328.245,1388.71 338.073,1388.71 347.901,1388.71 357.728,1388.71 367.556,1388.71 377.384,1388.71 387.211,1388.71 397.039,1388.71 406.867,1388.71 416.695,1388.71 \n", " 426.522,1388.71 436.35,1388.71 446.178,1388.71 456.005,1388.71 465.833,1388.71 475.661,1388.71 485.489,1388.71 495.316,1388.71 505.144,1388.71 514.972,1388.71 \n", " 524.8,1388.71 534.627,1388.71 544.455,1388.71 554.283,1388.71 564.11,1388.71 573.938,1388.71 583.766,1388.71 593.594,1388.71 603.421,1388.71 613.249,1388.71 \n", " 623.077,1388.71 632.904,1388.71 642.732,1388.71 652.56,1388.71 662.388,1388.71 672.215,1388.71 682.043,1388.71 691.871,1388.71 701.699,1388.71 711.526,1388.71 \n", " 721.354,1388.71 731.182,1388.71 741.009,1388.71 750.837,1388.71 760.665,1388.71 770.493,1388.71 780.32,1388.71 790.148,1388.71 799.976,1388.71 809.803,1388.71 \n", " 819.631,1388.71 829.459,1388.71 839.287,1388.71 849.114,1388.71 858.942,1388.71 868.77,1388.71 878.598,1388.71 888.425,1388.71 898.253,1388.71 908.081,1388.71 \n", " 917.908,1388.71 927.736,1388.71 937.564,1388.71 947.392,1388.71 957.219,1388.71 967.047,1388.71 976.875,1388.71 986.702,1388.71 996.53,1388.71 1006.36,1388.71 \n", " 1016.19,1388.71 1026.01,1388.71 1035.84,1388.71 1045.67,1388.71 1055.5,1388.71 1065.32,1388.71 1075.15,1388.71 1084.98,1388.71 1094.81,1388.71 1104.64,1388.71 \n", " 1114.46,1388.71 1124.29,1388.71 1134.12,1388.71 1143.95,1388.71 1153.77,1388.71 1163.6,1388.71 1173.43,1388.71 1183.26,1388.71 1193.08,1388.71 1202.91,1388.71 \n", " 1212.74,1388.71 1222.57,1388.71 1232.4,1388.71 1242.22,1388.71 1252.05,1388.71 1261.88,1388.71 1271.71,1388.71 1281.53,1388.71 1291.36,1388.71 1301.19,1388.71 \n", " 1311.02,1388.71 1320.85,1388.71 1330.67,1388.71 1340.5,1388.71 1350.33,1388.71 1360.16,1388.71 1369.98,1388.71 1379.81,1388.71 1389.64,1388.71 1399.47,1388.71 \n", " 1409.29,1388.71 1419.12,1388.71 1428.95,1388.71 1438.78,1388.71 1448.61,1388.71 1458.43,1388.71 1468.26,1388.71 1478.09,1388.71 1487.92,1388.71 1497.74,1388.71 \n", " 1507.57,1388.71 1517.4,1388.71 1527.23,1388.71 1537.05,1388.71 1546.88,1388.71 1556.71,1388.71 1566.54,1388.71 1576.37,1388.71 1586.19,1388.71 1596.02,1388.71 \n", " 1605.85,1388.71 1615.68,1388.71 1625.5,1388.71 1635.33,1388.71 1645.16,1388.71 1654.99,1388.71 1664.82,1388.71 1674.64,1388.71 1684.47,1388.71 1694.3,1388.71 \n", " 1704.13,1388.71 1713.95,1388.71 1723.78,1388.71 1733.61,1388.71 1743.44,1388.71 1753.26,1388.71 1763.09,1388.71 1772.92,1388.71 1782.75,1388.71 1792.58,1388.71 \n", " 1802.4,1388.71 1812.23,1388.71 1822.06,1388.71 1831.89,1388.71 1841.71,1388.71 1851.54,1388.71 1861.37,1388.71 1871.2,1388.71 1881.03,1388.71 1890.85,1388.71 \n", " 1900.68,1388.71 1910.51,1388.71 1920.34,1388.71 1930.16,1388.71 1939.99,1388.71 1949.82,1388.71 1959.65,1388.71 1969.47,1388.71 1979.3,1388.71 1989.13,1388.71 \n", " 1998.96,1388.71 2008.79,1388.71 2018.61,1388.71 2028.44,1388.71 2038.27,1388.71 2048.1,1388.71 2057.92,1388.71 2067.75,1388.71 2077.58,1388.71 2087.41,1388.71 \n", " 2097.24,1388.71 2107.06,1388.71 2116.89,1388.71 2126.72,1388.71 2136.55,1388.71 2146.37,1388.71 2156.2,1388.71 2166.03,1388.71 2175.86,1388.71 2185.68,1388.71 \n", " 2195.51,1388.71 2205.34,1388.71 2215.17,1388.71 2225,1388.71 2234.82,1388.71 2244.65,1388.71 2254.48,1388.71 2264.31,1388.71 2274.13,1388.71 2283.96,1388.71 \n", " 2293.79,1388.71 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4702)\" style=\"stroke:#ac8d18; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 328.245,1384.64 338.073,1384.64 347.901,1384.64 357.728,1384.64 367.556,1384.64 377.384,1384.64 387.211,1384.64 397.039,1384.64 406.867,1384.64 416.695,1384.64 \n", " 426.522,1384.64 436.35,1384.64 446.178,1384.64 456.005,1384.64 465.833,1384.64 475.661,1384.64 485.489,1384.64 495.316,1384.64 505.144,1384.64 514.972,1384.64 \n", " 524.8,1384.64 534.627,1384.64 544.455,1384.64 554.283,1384.64 564.11,1384.64 573.938,1384.64 583.766,1384.64 593.594,1384.64 603.421,1384.64 613.249,1384.64 \n", " 623.077,1384.64 632.904,1384.64 642.732,1384.64 652.56,1384.64 662.388,1384.64 672.215,1384.64 682.043,1384.64 691.871,1384.64 701.699,1384.64 711.526,1384.64 \n", " 721.354,1384.64 731.182,1384.64 741.009,1384.64 750.837,1384.64 760.665,1384.64 770.493,1384.64 780.32,1384.64 790.148,1384.64 799.976,1384.64 809.803,1384.64 \n", " 819.631,1384.64 829.459,1384.64 839.287,1384.64 849.114,1384.64 858.942,1384.64 868.77,1384.64 878.598,1384.64 888.425,1384.64 898.253,1384.64 908.081,1384.64 \n", " 917.908,1384.64 927.736,1384.64 937.564,1384.64 947.392,1384.64 957.219,1384.64 967.047,1384.64 976.875,1384.64 986.702,1384.64 996.53,1384.64 1006.36,1384.64 \n", " 1016.19,1384.64 1026.01,1384.64 1035.84,1384.64 1045.67,1384.64 1055.5,1384.64 1065.32,1384.64 1075.15,1384.64 1084.98,1384.64 1094.81,1384.64 1104.64,1384.64 \n", " 1114.46,1384.64 1124.29,1384.64 1134.12,1384.64 1143.95,1384.64 1153.77,1384.64 1163.6,1384.64 1173.43,1384.64 1183.26,1384.64 1193.08,1384.64 1202.91,1384.64 \n", " 1212.74,1384.64 1222.57,1384.64 1232.4,1384.64 1242.22,1384.64 1252.05,1384.64 1261.88,1384.64 1271.71,1384.64 1281.53,1384.64 1291.36,1384.64 1301.19,1384.64 \n", " 1311.02,1384.64 1320.85,1384.64 1330.67,1384.64 1340.5,1384.64 1350.33,1384.64 1360.16,1384.64 1369.98,1384.64 1379.81,1384.64 1389.64,1384.64 1399.47,1384.64 \n", " 1409.29,1384.64 1419.12,1384.64 1428.95,1384.64 1438.78,1384.64 1448.61,1384.64 1458.43,1384.64 1468.26,1384.64 1478.09,1384.64 1487.92,1384.64 1497.74,1384.64 \n", " 1507.57,1384.64 1517.4,1384.64 1527.23,1384.64 1537.05,1384.64 1546.88,1384.64 1556.71,1384.64 1566.54,1384.64 1576.37,1384.64 1586.19,1384.64 1596.02,1384.64 \n", " 1605.85,1384.64 1615.68,1384.64 1625.5,1384.64 1635.33,1384.64 1645.16,1384.64 1654.99,1384.64 1664.82,1384.64 1674.64,1384.64 1684.47,1384.64 1694.3,1384.64 \n", " 1704.13,1384.64 1713.95,1384.64 1723.78,1384.64 1733.61,1384.64 1743.44,1384.64 1753.26,1384.64 1763.09,1384.64 1772.92,1384.64 1782.75,1384.64 1792.58,1384.64 \n", " 1802.4,1384.64 1812.23,1384.64 1822.06,1384.64 1831.89,1384.64 1841.71,1384.64 1851.54,1384.64 1861.37,1384.64 1871.2,1384.64 1881.03,1384.64 1890.85,1384.64 \n", " 1900.68,1384.64 1910.51,1384.64 1920.34,1384.64 1930.16,1384.64 1939.99,1384.64 1949.82,1384.64 1959.65,1384.64 1969.47,1384.64 1979.3,1384.64 1989.13,1384.64 \n", " 1998.96,1384.64 2008.79,1384.64 2018.61,1384.64 2028.44,1384.64 2038.27,1384.64 2048.1,1384.64 2057.92,1384.64 2067.75,1384.64 2077.58,1384.64 2087.41,1384.64 \n", " 2097.24,1384.64 2107.06,1384.64 2116.89,1384.64 2126.72,1384.64 2136.55,1384.64 2146.37,1384.64 2156.2,1384.64 2166.03,1384.64 2175.86,1384.64 2185.68,1384.64 \n", " 2195.51,1384.64 2205.34,1384.64 2215.17,1384.64 2225,1384.64 2234.82,1384.64 2244.65,1384.64 2254.48,1384.64 2264.31,1384.64 2274.13,1384.64 2283.96,1384.64 \n", " 2293.79,1384.64 \n", " \"/>\n", "<path clip-path=\"url(#clip4700)\" d=\"\n", "M1896.26 568.075 L2280.76 568.075 L2280.76 205.195 L1896.26 205.195 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1896.26,568.075 2280.76,568.075 2280.76,205.195 1896.26,205.195 1896.26,568.075 \n", " \"/>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1920.26,265.675 2064.26,265.675 \n", " \"/>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2088.26, 283.175)\" x=\"2088.26\" y=\"283.175\">1 x fea</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#e26f46; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1920.26,326.155 2064.26,326.155 \n", " \"/>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2088.26, 343.655)\" x=\"2088.26\" y=\"343.655\">2 x fea</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#3da44d; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1920.26,386.635 2064.26,386.635 \n", " \"/>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2088.26, 404.135)\" x=\"2088.26\" y=\"404.135\">3 x fea</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#c271d2; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1920.26,447.115 2064.26,447.115 \n", " \"/>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2088.26, 464.615)\" x=\"2088.26\" y=\"464.615\">4 x fea</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip4700)\" style=\"stroke:#ac8d18; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1920.26,507.595 2064.26,507.595 \n", " \"/>\n", "<g clip-path=\"url(#clip4700)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2088.26, 525.095)\" x=\"2088.26\" y=\"525.095\">5 x fea</text>\n", "</g>\n", "</svg>\n" ] }, "execution_count": 279, "metadata": {}, "output_type": "execute_result" } ], "source": [ "plot()\n", "for i in 1:5\n", " l0=75*i\n", " A=l0*l0\n", "# plot!(1:step:numTimeStepsRecorded,DDisplacements[i]/A,label=\"$i x dynamic\",xlabel=\"timestep\",ylabel=\"strain\",title=\"Dynamic Model Convergence\")\n", " plot!(1:step:numTimeStepsRecorded,-DDisplacementsFEA[i]/l0,label=\"$i x fea\",xlabel=\"timestep\",ylabel=\"strain\",title=\"Dynamic Model Convergence\")\n", "\n", "end\n", "plot!()\n", "# savefig(\"total_convergence\")" ] }, { "cell_type": "code", "execution_count": 280, "metadata": {}, "outputs": [ { "data": { "image/svg+xml": [ "<?xml version=\"1.0\" encoding=\"utf-8\"?>\n", "<svg xmlns=\"http://www.w3.org/2000/svg\" xmlns:xlink=\"http://www.w3.org/1999/xlink\" width=\"600\" height=\"400\" viewBox=\"0 0 2400 1600\">\n", "<defs>\n", " <clipPath id=\"clip5100\">\n", " <rect x=\"0\" y=\"0\" width=\"2400\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip5100)\" d=\"\n", "M0 1600 L2400 1600 L2400 0 L0 0 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip5101\">\n", " <rect x=\"480\" y=\"0\" width=\"1681\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip5100)\" d=\"\n", "M255.898 1425.62 L2352.76 1425.62 L2352.76 121.675 L255.898 121.675 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip5102\">\n", " <rect x=\"255\" y=\"121\" width=\"2098\" height=\"1305\"/>\n", " </clipPath>\n", "</defs>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 327.161,1425.62 327.161,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 805.16,1425.62 805.16,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1283.16,1425.62 1283.16,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1761.16,1425.62 1761.16,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 2239.16,1425.62 2239.16,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 255.898,1183.69 2352.76,1183.69 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 255.898,927.414 2352.76,927.414 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 255.898,671.136 2352.76,671.136 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 255.898,414.857 2352.76,414.857 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 255.898,158.579 2352.76,158.579 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 255.898,1425.62 2352.76,1425.62 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 255.898,1425.62 255.898,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 327.161,1425.62 327.161,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 805.16,1425.62 805.16,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1283.16,1425.62 1283.16,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1761.16,1425.62 1761.16,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2239.16,1425.62 2239.16,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 255.898,1183.69 281.06,1183.69 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 255.898,927.414 281.06,927.414 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 255.898,671.136 281.06,671.136 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 255.898,414.857 281.06,414.857 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 255.898,158.579 281.06,158.579 \n", " \"/>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 327.161, 1479.62)\" x=\"327.161\" y=\"1479.62\">2</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 805.16, 1479.62)\" x=\"805.16\" y=\"1479.62\">4</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1283.16, 1479.62)\" x=\"1283.16\" y=\"1479.62\">6</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1761.16, 1479.62)\" x=\"1761.16\" y=\"1479.62\">8</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 2239.16, 1479.62)\" x=\"2239.16\" y=\"1479.62\">10</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 231.898, 1201.19)\" x=\"231.898\" y=\"1201.19\">500</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 231.898, 944.914)\" x=\"231.898\" y=\"944.914\">1000</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 231.898, 688.636)\" x=\"231.898\" y=\"688.636\">1500</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 231.898, 432.357)\" x=\"231.898\" y=\"432.357\">2000</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 231.898, 176.079)\" x=\"231.898\" y=\"176.079\">2500</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:84px; text-anchor:middle;\" transform=\"rotate(0, 1304.33, 73.2)\" x=\"1304.33\" y=\"73.2\">load vs displacement</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(0, 1304.33, 1559.48)\" x=\"1304.33\" y=\"1559.48\">displacement</text>\n", "</g>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(-90, 89.2861, 773.647)\" x=\"89.2861\" y=\"773.647\">load</text>\n", "</g>\n", "<polyline clip-path=\"url(#clip5102)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2293.41,1388.71 315.243,1234.95 604.848,978.669 695.551,619.88 944.154,158.579 \n", " \"/>\n", "<circle clip-path=\"url(#clip5102)\" cx=\"2293.41\" cy=\"1388.71\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip5102)\" cx=\"315.243\" cy=\"1234.95\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip5102)\" cx=\"604.848\" cy=\"978.669\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip5102)\" cx=\"695.551\" cy=\"619.88\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip5102)\" cx=\"944.154\" cy=\"158.579\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<path clip-path=\"url(#clip5100)\" d=\"\n", "M1973.85 386.635 L2280.76 386.635 L2280.76 205.195 L1973.85 205.195 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1973.85,386.635 2280.76,386.635 2280.76,205.195 1973.85,205.195 1973.85,386.635 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5100)\" style=\"stroke:#009af9; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1997.85,265.675 2141.85,265.675 \n", " \"/>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2165.85, 283.175)\" x=\"2165.85\" y=\"283.175\">fea</text>\n", "</g>\n", "<circle clip-path=\"url(#clip5100)\" cx=\"2081.85\" cy=\"326.155\" r=\"21\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<g clip-path=\"url(#clip5100)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2165.85, 343.655)\" x=\"2165.85\" y=\"343.655\">fea</text>\n", "</g>\n", "</svg>\n" ] }, "execution_count": 280, "metadata": {}, "output_type": "execute_result" } ], "source": [ "strains=[-DDisplacementsFEA[1][1],-DDisplacementsFEA[2][1],-DDisplacementsFEA[3][1],-DDisplacementsFEA[4][1],-DDisplacementsFEA[5][1]]\n", "plot(strains,-Loads,label=\"fea\",xlabel=\"displacement\",ylabel=\"load\",title=\"load vs displacement\")\n", "scatter!(strains,-Loads,label=\"fea\",xlabel=\"displacement\",ylabel=\"load\",title=\"load vs displacement\")\n" ] }, { "cell_type": "code", "execution_count": 281, "metadata": {}, "outputs": [ { "data": { "image/svg+xml": [ "<?xml version=\"1.0\" encoding=\"utf-8\"?>\n", "<svg xmlns=\"http://www.w3.org/2000/svg\" xmlns:xlink=\"http://www.w3.org/1999/xlink\" width=\"600\" height=\"400\" viewBox=\"0 0 2400 1600\">\n", "<defs>\n", " <clipPath id=\"clip5500\">\n", " <rect x=\"0\" y=\"0\" width=\"2400\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip5500)\" d=\"\n", "M0 1600 L2400 1600 L2400 0 L0 0 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip5501\">\n", " <rect x=\"480\" y=\"0\" width=\"1681\" height=\"1600\"/>\n", " </clipPath>\n", "</defs>\n", "<path clip-path=\"url(#clip5500)\" d=\"\n", "M389.709 1425.62 L2352.76 1425.62 L2352.76 121.675 L389.709 121.675 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<defs>\n", " <clipPath id=\"clip5502\">\n", " <rect x=\"389\" y=\"121\" width=\"1964\" height=\"1305\"/>\n", " </clipPath>\n", "</defs>\n", "<polyline clip-path=\"url(#clip5502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 641.46,1425.62 641.46,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1013.17,1425.62 1013.17,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1384.88,1425.62 1384.88,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 1756.58,1425.62 1756.58,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 2128.29,1425.62 2128.29,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 389.709,1142.69 2352.76,1142.69 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 389.709,773.647 2352.76,773.647 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 389.709,404.606 2352.76,404.606 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5502)\" style=\"stroke:#000000; stroke-width:2; stroke-opacity:0.1; fill:none\" points=\"\n", " 389.709,158.579 2352.76,158.579 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 389.709,1425.62 2352.76,1425.62 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 389.709,1425.62 389.709,121.675 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 641.46,1425.62 641.46,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1013.17,1425.62 1013.17,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1384.88,1425.62 1384.88,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 1756.58,1425.62 1756.58,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2128.29,1425.62 2128.29,1409.97 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 389.709,1142.69 413.266,1142.69 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 389.709,773.647 413.266,773.647 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 389.709,404.606 413.266,404.606 \n", " \"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 389.709,158.579 413.266,158.579 \n", " \"/>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 641.46, 1479.62)\" x=\"641.46\" y=\"1479.62\">0.025</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1013.17, 1479.62)\" x=\"1013.17\" y=\"1479.62\">0.050</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1384.88, 1479.62)\" x=\"1384.88\" y=\"1479.62\">0.075</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 1756.58, 1479.62)\" x=\"1756.58\" y=\"1479.62\">0.100</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:middle;\" transform=\"rotate(0, 2128.29, 1479.62)\" x=\"2128.29\" y=\"1479.62\">0.125</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 365.709, 1160.19)\" x=\"365.709\" y=\"1160.19\">400000000</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 365.709, 791.147)\" x=\"365.709\" y=\"791.147\">400000001</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 365.709, 422.106)\" x=\"365.709\" y=\"422.106\">400000001</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:end;\" transform=\"rotate(0, 365.709, 176.079)\" x=\"365.709\" y=\"176.079\">400000001</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:84px; text-anchor:middle;\" transform=\"rotate(0, 1371.23, 73.2)\" x=\"1371.23\" y=\"73.2\">stress vs strain</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(0, 1371.23, 1559.48)\" x=\"1371.23\" y=\"1559.48\">strain</text>\n", "</g>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:66px; text-anchor:middle;\" transform=\"rotate(-90, 89.2861, 773.647)\" x=\"89.2861\" y=\"773.647\">stess</text>\n", "</g>\n", "<circle clip-path=\"url(#clip5502)\" cx=\"2297.2\" cy=\"1388.71\" r=\"14\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip5502)\" cx=\"463.054\" cy=\"1388.71\" r=\"14\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip5502)\" cx=\"478.694\" cy=\"1388.71\" r=\"14\" fill=\"#3da44d\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip5502)\" cx=\"445.267\" cy=\"1388.71\" r=\"14\" fill=\"#c271d2\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<circle clip-path=\"url(#clip5502)\" cx=\"451.406\" cy=\"1388.71\" r=\"14\" fill=\"#ac8d18\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<path clip-path=\"url(#clip5500)\" d=\"\n", "M2013.99 568.075 L2280.76 568.075 L2280.76 205.195 L2013.99 205.195 Z\n", " \" fill=\"#ffffff\" fill-rule=\"evenodd\" fill-opacity=\"1\"/>\n", "<polyline clip-path=\"url(#clip5500)\" style=\"stroke:#000000; stroke-width:4; stroke-opacity:1; fill:none\" points=\"\n", " 2013.99,568.075 2280.76,568.075 2280.76,205.195 2013.99,205.195 2013.99,568.075 \n", " \"/>\n", "<circle clip-path=\"url(#clip5500)\" cx=\"2121.99\" cy=\"265.675\" r=\"21\" fill=\"#009af9\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2205.99, 283.175)\" x=\"2205.99\" y=\"283.175\">1</text>\n", "</g>\n", "<circle clip-path=\"url(#clip5500)\" cx=\"2121.99\" cy=\"326.155\" r=\"21\" fill=\"#e26f46\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2205.99, 343.655)\" x=\"2205.99\" y=\"343.655\">2</text>\n", "</g>\n", "<circle clip-path=\"url(#clip5500)\" cx=\"2121.99\" cy=\"386.635\" r=\"21\" fill=\"#3da44d\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2205.99, 404.135)\" x=\"2205.99\" y=\"404.135\">3</text>\n", "</g>\n", "<circle clip-path=\"url(#clip5500)\" cx=\"2121.99\" cy=\"447.115\" r=\"21\" fill=\"#c271d2\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2205.99, 464.615)\" x=\"2205.99\" y=\"464.615\">4</text>\n", "</g>\n", "<circle clip-path=\"url(#clip5500)\" cx=\"2121.99\" cy=\"507.595\" r=\"21\" fill=\"#ac8d18\" fill-rule=\"evenodd\" fill-opacity=\"1\" stroke=\"#000000\" stroke-opacity=\"1\" stroke-width=\"3.2\"/>\n", "<g clip-path=\"url(#clip5500)\">\n", "<text style=\"fill:#000000; fill-opacity:1; font-family:Arial,Helvetica Neue,Helvetica,sans-serif; font-size:48px; text-anchor:start;\" transform=\"rotate(0, 2205.99, 525.095)\" x=\"2205.99\" y=\"525.095\">5</text>\n", "</g>\n", "</svg>\n" ] }, "execution_count": 281, "metadata": {}, "output_type": "execute_result" } ], "source": [ "plot()\n", "stresss=[]\n", "strainn=[]\n", "for i in 1:5\n", " l0=75*i\n", " A=l0*l0\n", " append!(stresss,400000000)\n", "# append!(stresss,-Loads[i]/A)\n", " append!(strainn,-DDisplacementsFEA[i][1]/l0)\n", " scatter!([-DDisplacementsFEA[i][1]/l0],[400000000],label=\"$i\",xlabel=\"strain\",ylabel=\"stess\",title=\"stress vs strain\")\n", "\n", "end\n", "plot!()\n", "\n" ] }, { "cell_type": "code", "execution_count": 282, "metadata": {}, "outputs": [ { "name": "stdout", "output_type": "stream", "text": [ "dt: 0.007294855212986816\n", "first timestep took 0.001470699 seconds\n", "ran latticeSize 5 with 540 voxels and 1800 edges for 20000 time steps took 9.3035085 seconds\n" ] } ], "source": [ "setup=getSetup(latticeSize)\n", "numTimeSteps=20000\n", "displacements=[]\n", "save=true\n", "returnEvery=1\n", "runMetavoxelGPU!(setup,numTimeSteps,latticeSize,displacements,returnEvery,false)\n" ] }, { "cell_type": "code", "execution_count": 31, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "feaDisplacement (generic function with 1 method)" ] }, "execution_count": 31, "metadata": {}, "output_type": "execute_result" } ], "source": [ "function feaDisplacement(setup,latticeSize)\n", " #######################################################\n", " function points(element, properties)\n", " elements = properties[\"elements\"]\n", " nodes = properties[\"nodes\"]\n", " degrees_of_freedom = properties[\"degrees_of_freedom\"]\n", "\n", " # find the nodes that the lements connects\n", " fromNode = elements[element][1]\n", " toNode = elements[element][2]\n", "\n", " # the coordinates for each node\n", " fromPoint = nodes[fromNode]\n", " toPoint = nodes[toNode]\n", "\n", " # find the degrees of freedom for each node\n", " dofs = degrees_of_freedom[fromNode]\n", " dofs=vcat(dofs,degrees_of_freedom[toNode])\n", "\n", " return fromPoint, toPoint, dofs\n", " end\n", "\n", " function direction_cosine(vec1, vec2)\n", " return dot(vec1,vec2) / (norm(vec1) * norm(vec2))\n", " end\n", "\n", " function rotation_matrix(element_vector, x_axis, y_axis,z_axis)\n", " # find the direction cosines\n", " x_proj = direction_cosine(element_vector, x_axis)\n", " y_proj = direction_cosine(element_vector, y_axis)\n", " z_proj = direction_cosine(element_vector, z_axis);\n", " return [[x_proj y_proj z_proj 0 0 0];[0 0 0 x_proj y_proj z_proj]]\n", " end\n", "\n", " function rotation_matrix(element_vector, x_axis, y_axis,z_axis)\n", " # find the direction cosines\n", " L=norm(element_vector)\n", " l = (element_vector[1])/L\n", " m = (element_vector[2])/L\n", " n = (element_vector[3])/L\n", " D = ( l^2+ m^2+n^2)^0.5\n", "\n", " transMatrix=[[l m n 0 0 0 0 0 0 0 0 0];[-m/D l/D 0 0 0 0 0 0 0 0 0 0];[ -l*n/D -m*n/D D 0 0 0 0 0 0 0 0 0];[ 0 0 0 l m n 0 0 0 0 0 0];[ 0 0 0 -m/D l/D 0 0 0 0 0 0 0];[ 0 0 0 -l*n/D -m*n/D D 0 0 0 0 0 0];[ 0 0 0 0 0 0 l m n 0 0 0];[ 0 0 0 0 0 0 -m/D l/D 0 0 0 0];[ 0 0 0 0 0 0 -l*n/D -m*n/D D 0 0 0];[ 0 0 0 0 0 0 0 0 0 l m n];[ 0 0 0 0 0 0 0 0 0 -m/D l/D 0];[ 0 0 0 0 0 0 0 0 0 -l*n/D -m*n/D D]]\n", "\n", " return transMatrix\n", " end\n", " \n", " #######################################################\n", " function get_matrices(setup)\n", "\n", " nodes = setup[\"nodes\"]\n", " edges = setup[\"edges\"]\n", " ndofs = length(nodes)*6\n", "\n", " x_axis = [1 0 0]\n", " y_axis = [0 1 0]\n", " z_axis = [0 0 1]\n", "\n", " M = zeros((ndofs,ndofs))\n", " K = zeros((ndofs,ndofs))\n", " \n", " \n", " for edge in edges\n", " #degrees_of_freedom = properties[\"degrees_of_freedom\"]\n", "\n", " element=parse(Int,edge[\"id\"][2:end])\n", "\n", " # find the nodes that the lements connects\n", " fromNode = nodes[edge[\"source\"]+1]\n", " toNode = nodes[edge[\"target\"]+1]\n", " \n", "\n", " # the coordinates for each node\n", " fromPoint = [fromNode[\"position\"][\"x\"]*15.0 fromNode[\"position\"][\"y\"]*15.0 fromNode[\"position\"][\"z\"]*15.0]\n", " toPoint = [toNode[\"position\"][\"x\"]*15.0 toNode[\"position\"][\"y\"]*15.0 toNode[\"position\"][\"z\"]*15.0]\n", "\n", " # find the degrees of freedom for each node\n", " dofs = convert(Array{Int}, fromNode[\"degrees_of_freedom\"])\n", " dofs=vcat(dofs,convert(Array{Int}, toNode[\"degrees_of_freedom\"]))\n", "\n", " element_vector=toPoint-fromPoint\n", "\n", " # find element mass and stifness matrices\n", " length = norm(element_vector)\n", " rho = edge[\"density\"]\n", " area = edge[\"area\"]\n", " E = edge[\"stiffness\"]# youngs modulus\n", "\n", " A = edge[\"area\"]\n", " G=1.0#todo shear_modulus\n", " ixx = 1.0#todo section ixx\n", " iyy = 1.0#todo section.iyy#\n", " l0=length\n", " j=1.0;#todo check\n", " l02 = l0 * l0\n", " l03 = l0 * l0 * l0\n", " \n", " # find element mass and stifness matrices\n", " length = norm(element_vector)\n", " rho = edge[\"density\"]\n", " area = edge[\"area\"]\n", " E = edge[\"stiffness\"]# youngs modulus\n", " \n", " \n", " \n", " A = edge[\"area\"]\n", " G=1.0#todo shear_modulus\n", " ixx = 1.0#todo section ixx\n", " iyy = 1.0#todo section.iyy#\n", " j=1.0;#todo check\n", " \n", " \n", " h = 2.38 # mm\n", " b = 2.38 # mm\n", " E = 2000 # MPa\n", " rho = 7.85e-9 / 3 # kg/mm^3\n", " G = E * 1 / 3 # MPa\n", " A=h*b\n", " Q = 1 / 3 - 0.2244 / (min(h / b, b / h) + 0.1607)\n", " J = Q * min(h * b^3, b * h^3)\n", " I= b*h^3/12\n", " ixx=I\n", " iyy=I\n", " j=J\n", " \n", " l0=length\n", " l02 = l0 * l0\n", " l03 = l0 * l0 * l0\n", "\n", "\n", " k = [[E*A/l0 0 0 0 0 0 -E*A/l0 0 0 0 0 0];[0 12*E*ixx/l03 0 0 0 6*E*ixx/l02 0 -12*E*ixx/l03 0 0 0 6*E*ixx/l02];[0 0 12*E*iyy/l03 0 -6*E*iyy/l02 0 0 0 -12*E*iyy/l03 0 -6*E*iyy/l02 0];[0 0 0 G*j/l0 0 0 0 0 0 -G*j/l0 0 0];[0 0 -6*E*iyy/l02 0 4*E*iyy/l0 0 0 0 6*E*iyy/l02 0 2*E*iyy/l0 0];[0 6*E*ixx/l02 0 0 0 4*E*ixx/l0 0 -6*E*ixx/l02 0 0 0 2*E*ixx/l0];[-E*A/l0 0 0 0 0 0 E*A/l0 0 0 0 0 0];[0 -12*E*ixx/l03 0 0 0 -6*E*ixx/l02 0 12*E*ixx/l03 0 0 0 -6*E*ixx/l02];[0 0 -12*E*iyy/l03 0 6*E*iyy/l02 0 0 0 12*E*iyy/l03 0 6*E*iyy/l02 0];[0 0 0 -G*j/l0 0 0 0 0 0 G*j/l0 0 0];[0 0 -6*E*iyy/l02 0 2*E*iyy/l0 0 0 0 6*E*iyy/l02 0 4*E*iyy/l0 0];[0 6*E*ixx/l02 0 0 0 2*E*ixx/l0 0 -6*E*ixx/l02 0 0 0 4*E*ixx/l0]]\n", "\n", "\n", " # find rotated mass and stifness matrices\n", " tau = rotation_matrix(element_vector, x_axis,y_axis,z_axis)\n", "\n", " # m_r=transpose(tau)*m*tau\n", " k_r=transpose(tau)*k*tau\n", "\n", " # change from element to global coordinate\n", " index= dofs.+1\n", "\n", " B=zeros((12,ndofs))\n", " for i in 1:12\n", " B[i,index[i]]=1.0\n", " end\n", "\n", "\n", " # M_rG= transpose(B)*m_r*B\n", " K_rG= transpose(B)*k_r*B\n", "\n", " # M += Cm .* M_rG\n", " # K += Ck .* K_rG\n", " K += K_rG\n", "\n", " end\n", " \n", " \n", " # construct the force vector\n", " F=zeros(ndofs)\n", " U=zeros(ndofs)\n", " remove_indices=[];\n", " for node in nodes\n", " #insert!(F,i, value);\n", " #F=vcat(F,value)\n", " \n", " \n", " \n", " \n", " i=parse(Int,node[\"id\"][2:end])\n", " f=node[\"force\"]\n", " \n", " # println(f)\n", " U[(i)*6+1]=0\n", " U[(i)*6+2]=-0.01*(node[\"position\"][\"y\"]+2.5)*15.0 *((node[\"position\"][\"y\"]+2.5)/(5*latticeSize))\n", " U[(i)*6+3]=0\n", " U[(i)*6+4]=0\n", " U[(i)*6+5]=0\n", " U[(i)*6+6]=0\n", " \n", " # println(f)\n", " F[(i)*6+1]+=f[\"x\"]\n", " F[(i)*6+2]+=f[\"y\"]\n", " F[(i)*6+3]+=f[\"z\"]\n", " F[(i)*6+4]+=0\n", " F[(i)*6+5]+=0\n", " F[(i)*6+6]+=0\n", " Load+=f[\"y\"]\n", " if (F[(i)*6+2]!=0)\n", " append!(topNodesIndices,i+1)\n", " end\n", " \n", " dofs = convert(Array{Int}, node[\"degrees_of_freedom\"]).+1\n", " restrained_dofs=node[\"restrained_degrees_of_freedom\"]\n", " for (index, value) in enumerate(dofs)\n", " if restrained_dofs[index]\n", " append!( remove_indices, value)\n", " end\n", " end\n", " \n", " end\n", "\n", " #println(remove_indices)\n", " #print(K)\n", " #print(F)\n", " \n", "\n", " #M = M[setdiff(1:end, remove_indices), :]\n", " K = K[setdiff(1:end, remove_indices), :]\n", "\n", " #M = M[:,setdiff(1:end, remove_indices)]\n", " K = K[:,setdiff(1:end, remove_indices)]\n", "\n", " F = F[setdiff(1:end, remove_indices)]\n", " X = U[setdiff(1:end, remove_indices)]\n", " \n", " return M,K,F,U,remove_indices,X\n", " end\n", "\n", " \n", " function updateDisplacement(setup, X)\n", " nodes= setup[\"nodes\"]\n", " i=0\n", " for node in nodes\n", " \n", "# if !node[\"restrained_degrees_of_freedom\"][2]\n", " #i=parse(Int,node[\"id\"][2:end])\n", " node[\"displacement\"][\"x\"]=X[(i)*6+1]\n", " node[\"displacement\"][\"y\"]=X[(i)*6+2]\n", " node[\"displacement\"][\"z\"]=X[(i)*6+3]\n", " node[\"angle\"][\"x\"]=X[(i)*6+4]\n", " node[\"angle\"][\"y\"]=X[(i)*6+5]\n", " node[\"angle\"][\"z\"]=X[(i)*6+6]\n", " append!(displacementFEA,[Vector3(X[(i)*6+1],X[(i)*6+2],X[(i)*6+3])])\n", " i=i+1\n", "# else\n", "# append!(displacementFEA,[Vector3(0,0,0)])\n", "# end\n", " end\n", " end\n", " \n", " #######################################################\n", "\n", " function get_stresses(setup)\n", " nodes = setup[\"nodes\"]\n", " edges = setup[\"edges\"]\n", " ndofs = length(nodes)*6\n", "\n", " x_axis = [1 0 0]\n", " y_axis = [0 1 0]\n", " z_axis = [0 0 1]\n", "\n", " # find the stresses in each member\n", " stresses=zeros(length(edges))\n", " max11=-10e6\n", " min11=10e6\n", " for edge in edges\n", " #degrees_of_freedom = properties[\"degrees_of_freedom\"]\n", "\n", " element=parse(Int,edge[\"id\"][2:end])\n", "\n", " # find the nodes that the lements connects\n", " fromNode = nodes[edge[\"source\"]+1]\n", " toNode = nodes[edge[\"target\"]+1]\n", "\n", " # the coordinates for each node\n", " fromPoint = [fromNode[\"position\"][\"x\"]*15 fromNode[\"position\"][\"y\"]*15 fromNode[\"position\"][\"z\"]*15]\n", " toPoint = [toNode[\"position\"][\"x\"]*15 toNode[\"position\"][\"y\"]*15 toNode[\"position\"][\"z\"]*15]\n", "\n", " # find the degrees of freedom for each node\n", " dofs = convert(Array{Int}, fromNode[\"degrees_of_freedom\"])\n", " dofs=vcat(dofs,convert(Array{Int}, toNode[\"degrees_of_freedom\"]))\n", "\n", " element_vector=toPoint-fromPoint\n", "\n", "\n", " # find rotated mass and stifness matrices\n", " tau = rotation_matrix(element_vector, x_axis,y_axis,z_axis)\n", "\n", " # i1=parse(Int,fromNode[\"id\"][2:end])\n", " # i2=parse(Int,toNode[\"id\"][2:end])\n", "\n", " # global_displacements=[X[(i1)*6+1] X[(i1)*6+2] X[(i1)*6+3] X[(i1)*6+4] X[(i1)*6+5] X[(i1)*6+6] X[(i2)*6+1] X[(i2)*6+2] X[(i2)*6+3] X[(i2)*6+4] X[(i2)*6+5] X[(i2)*6+6]] # todo change\n", " global_displacements=[fromNode[\"displacement\"][\"x\"]*15 fromNode[\"displacement\"][\"y\"]*15 fromNode[\"displacement\"][\"z\"]*15 fromNode[\"angle\"][\"x\"] fromNode[\"angle\"][\"y\"] fromNode[\"angle\"][\"z\"] toNode[\"displacement\"][\"x\"]*15 toNode[\"displacement\"][\"y\"]*15 toNode[\"displacement\"][\"z\"]*15 toNode[\"angle\"][\"x\"] toNode[\"angle\"][\"y\"] toNode[\"angle\"][\"z\"]] # todo change\n", "\n", " # nodal displacement\n", "\n", " q=tau*transpose(global_displacements)\n", " # println(q)\n", " # calculate the strain and stresses\n", " strain =(q[7]-q[1])/norm(element_vector)\n", " E = edge[\"stiffness\"]# youngs modulus\n", " E=2000\n", " stress=E.*strain\n", " edge[\"stress\"]=stress\n", " if stress>max11\n", " max11=stress\n", " end\n", " if stress<min11\n", " min11=stress\n", " end\n", " # println(element)\n", " # println(stress)\n", " end\n", "\n", "\n", "\n", " setup[\"viz\"][\"minStress\"]=min11\n", " setup[\"viz\"][\"maxStress\"]=max11\n", " return stresses\n", " end\n", " \n", " function initialize(setup)\n", " nodes = setup[\"nodes\"]\n", " ndofs = length(nodes)*6\n", " \n", " i=0\n", " for node in nodes\n", " dg=[]\n", " for ii in 0:5\n", " append!(dg,i+ii) \n", " end\n", " i+=6\n", " node[\"degrees_of_freedom\"]=dg\n", " end\n", " end\n", " \n", "\n", " #######################################################\n", " function solveFea(setup)\n", " // # determine the global matrices\n", " initialize(setup)\n", " \n", " M,K,F,U,ind,X=get_matrices(setup)\n", " \n", " #println(M)\n", " #println(K)\n", " #println(F)\n", " \n", "# X = deepcopy(F)\n", " iiind=F.!=0\n", " \n", "# X[X.!=0] .= -0.01*5/100*latticeSize\n", "# print(\"displacementtt: \")\n", "# println(X)\n", "\n", "# X=inv(K)*F\n", " F=inv(K)*X\n", " \n", " Load=sum(F[iiind])\n", "# print(\"load: \")\n", "# println(F)\n", " \n", "# X=inv(K)*F\n", " \n", "# U[setdiff(1:end, ind)]=X\n", "\n", " updateDisplacement(setup, U)\n", "\n", " # determine the stresses in each element\n", " stresses=get_stresses(setup)\n", " end\n", " #######################################################\n", " displacementFEA=[]\n", " Load=0\n", " topNodesIndices=[]\n", " solveFea(setup)\n", " return displacementFEA,Load,topNodesIndices\n", "end" ] }, { "cell_type": "code", "execution_count": 621, "metadata": {}, "outputs": [ { "data": { "text/plain": [ "5-element Array{Int64,1}:\n", " 1\n", " 2\n", " 3\n", " 5\n", " 7" ] }, "execution_count": 621, "metadata": {}, "output_type": "execute_result" } ], "source": [ "A=[1,2,3,0,0,5,7,0]\n", "iiind=A.!=0\n", "A[iiind]" ] } ], "metadata": { "@webio": { "lastCommId": null, "lastKernelId": null }, "kernelspec": { "display_name": "Julia 1.2.0", "language": "julia", "name": "julia-1.2" }, "language_info": { "file_extension": ".jl", "mimetype": "application/julia", "name": "julia", "version": "1.2.0" } }, "nbformat": 4, "nbformat_minor": 4 }