数学上产生球形六边形网格

时间:2017-10-16 19:20:52

标签: algorithm geometry computational-geometry tiling hexagonal-tiles

我正在尝试创建一个类似于此的形状,带有12个五边形的六边形,任意大小。

https://i.stack.imgur.com/F35J0.png

Image Source

唯一的问题是,我完全不知道生成它需要什么样的代码!

目标是能够在3D空间中获取一个点并将其转换为网格上的位置坐标,反之亦然,并获取网格位置并获取绘制网格的相关顶点。

我甚至不知道如何为此存储网格位置。 3个五边形之间的每个“三部分”是否都有自己的二维坐标集?

我很可能会使用C#,但我更感兴趣的是使用哪种算法以及它们如何工作的解释,而不是仅仅给我一段代码。

3 个答案:

答案 0 :(得分:8)

首先对问题中的图像进行一些分析:由相邻五边形中心跨越的球形三角形似乎是等边的。当五个等边三角形在一个角落相遇并覆盖整个球体时,这只能是由icosahedron引起的配置。所以有12个五边形和20个贴片的六角形网格的三角形切口映射到球体。

所以这是在球体上构建这样一个六边形网格的方法:

  1. 创建六边形网格的三角形切口:固定三角形(我选择(-0.5,0),(0.5,0),(0,sqrt(3)/ 2))得到叠加的六边形网格决议n st三角形角与六边形中心重合,请参阅n = 0,1,2,20的示例: enter image description here

  2. 计算icosahedron的角并定义它的20个三角形面(参见下面的代码)。二十面体的角落定义了五边形的中心,二十面体的面部定义了映射的六边形网格的斑块。 (二十面体将球体表面最精细的常规划分为三角形,即划分为全等边三角形。其他此类划分可以从四面体或八面体得出;然后在三角形的角落处一个将具有三角形或正方形,相反。更少和更大的三角形将使平面网格到曲面的任何映射中的不可避免的失真更加可见。因此选择二十面体作为三角形补丁的基础有助于最小化失真。六边形。)

  3. 将六边形网格的三角形切口映射到与icosaeder面相对应的球形三角形:基于slerp的双重barycentric coordinates可以实现。下面是将具有分辨率n = 10的六边形网格的三角形切口映射到一个球形三角形(由icosaeder的一个面定义)的图示,以及将网格映射到覆盖所有这些球形三角形的图示。整个球体(不同映射的不同颜色):

  4. enter image description here enter image description here

    这是用于生成二十面体的角(坐标)和三角形(点索引)的Python代码:

    from math import sin,cos,acos,sqrt,pi
    s,c = 2/sqrt(5),1/sqrt(5)
    topPoints = [(0,0,1)] + [(s*cos(i*2*pi/5.), s*sin(i*2*pi/5.), c) for i in range(5)]
    bottomPoints = [(-x,y,-z) for (x,y,z) in topPoints]
    icoPoints = topPoints + bottomPoints
    icoTriangs = [(0,i+1,(i+1)%5+1) for i in range(5)] +\
                 [(6,i+7,(i+1)%5+7) for i in range(5)] +\
                 [(i+1,(i+1)%5+1,(7-i)%5+7) for i in range(5)] +\
                 [(i+1,(7-i)%5+7,(8-i)%5+7) for i in range(5)]
    

    以下是使用双slerp将固定三角形(点)映射到球形三角形的Python代码:

    # barycentric coords for triangle (-0.5,0),(0.5,0),(0,sqrt(3)/2)
    def barycentricCoords(p):
      x,y = p
      # l3*sqrt(3)/2 = y
      l3 = y*2./sqrt(3.)
      # l1 + l2 + l3 = 1
      # 0.5*(l2 - l1) = x
      l2 = x + 0.5*(1 - l3)
      l1 = 1 - l2 - l3
      return l1,l2,l3
    
    from math import atan2
    def scalProd(p1,p2):
      return sum([p1[i]*p2[i] for i in range(len(p1))])
    # uniform interpolation of arc defined by p0, p1 (around origin)
    # t=0 -> p0, t=1 -> p1
    def slerp(p0,p1,t):
      assert abs(scalProd(p0,p0) - scalProd(p1,p1)) < 1e-7
      ang0Cos = scalProd(p0,p1)/scalProd(p0,p0)
      ang0Sin = sqrt(1 - ang0Cos*ang0Cos)
      ang0 = atan2(ang0Sin,ang0Cos)
      l0 = sin((1-t)*ang0)
      l1 = sin(t    *ang0)
      return tuple([(l0*p0[i] + l1*p1[i])/ang0Sin for i in range(len(p0))])
    
    # map 2D point p to spherical triangle s1,s2,s3 (3D vectors of equal length)
    def mapGridpoint2Sphere(p,s1,s2,s3):
      l1,l2,l3 = barycentricCoords(p)
      if abs(l3-1) < 1e-10: return s3
      l2s = l2/(l1+l2)
      p12 = slerp(s1,s2,l2s)
      return slerp(p12,s3,l3)
    

答案 1 :(得分:7)

你拥有的形状是所谓的“戈德堡多面体”之一,也是geodesic polyhedra

相当优雅的)生成这个(以及更多)的算法可以简洁地编码为Conway Polyhedron Notation

构造很容易一步一步地进行,您可以单击下面的图像以获得实时预览。

  1. 您正在寻找的多面体可以从isosahedron生成 - 初始化具有isosahedron的网格。 isosahedron

  2. 我们将"Truncate"操作(Conway符号t)应用于网格物体(此球的精确映射是足球)。 enter image description here

  3. 我们应用"Dual"运算符(Conway表示法d)。 enter image description here

  4. 我们再次应用“截断”操作。此时配方为tdtI(从右边读取!)。你已经可以看到它的发展方向。 enter image description here

  5. 应用步骤3&amp; 4反复,直到你满意为止。

  6. 例如,下面是dtdtdtdtI的网格。 enter image description here

    这很容易实现。我建议使用一个数据结构,它可以很容易地遍历邻域给出一个顶点,边缘等,如网格的边缘或半边数据结构。您只需要为要查找的形状实现truncate和dual运算符。

答案 2 :(得分:6)

[完全重新编辑18.10.2017]

几何存储在你身上。您可以将它存储在某种Mesh中,也可以在运行时生成它。我喜欢存放它。以2个表的形式。一个包含所有顶点(没有重复),另一个包含每个十六进制使用点的6个索引和一些附加信息,如球形位置,以便于后期处理。

现在如何生成这个:

  1. 创建十六进制三角形

    大小应该是球体的半径。不包括角六角形,也可以跳过三角形的最后一条线(在径向和轴向都有,因此在球体上的相邻三角形之间有1个六角形间隙),因为在连接三角形线段时会重叠。

  2. 60deg六角形三角形转换为72deg

    所以只需转换为极坐标坐标(radius,angle),围绕0 deg的中心三角形。然后将半径乘以cos(angle)/cos(30);,将三角形转换为饼图。然后使用比率72/60重新缩放角度。这将使我们的三角形可以连接......

  3. 复制并旋转三角形以填充五段五边形

    轻松旋转第一个三角形的点并存储为新的。

  4. 计算z

    根据此Hexagonal tilling of hemi-sphere,您可以将 2D 地图中的距离转换为弧长,以尽可能地限制扭曲。

    然而,当我尝试它时(下面的示例),六边形有点失真,所以深度和缩放需要一些调整。或后期处理。

  5. 复制半球以形成球体

    只需复制点/十六进制并取消z轴(如果你想保留缠绕,则旋转180度)。

  6. 添加赤道以及所有缺失的五边形和六边形

    您应该使用相邻六边形的坐标,这样就不会再将失真和重叠添加到网格中。这里预览:

    img

    蓝色是起始三角形。 深蓝色是它的副本。 红色是五边形。 深绿色是赤道,浅绿色是三角形之间的连接线。 黄色深橙色五边形附近缺少的赤道六边形。

  7. 这里简单的 C ++ OpenGL 示例(由#4 中的链接答案构成):

    //$$---- Form CPP ----
    //---------------------------------------------------------------------------
    #include <vcl.h>
    #include <math.h>
    #pragma hdrstop
    #include "win_main.h"
    #include "gl/OpenGL3D_double.cpp"
    #include "PolyLine.h"
    //---------------------------------------------------------------------------
    #pragma package(smart_init)
    #pragma resource "*.dfm"
    TMain *Main;
    OpenGLscreen scr;
    bool _redraw=true;
    double animx=  0.0,danimx=0.0;
    double animy=  0.0,danimy=0.0;
    //---------------------------------------------------------------------------
    PointTab     pnt;   // (x,y,z)
    
    struct _hexagon
        {
        int ix[6];      // index of 6 points, last point duplicate for pentagon
        int a,b;        // spherical coordinate
        DWORD col;      // color
    
        // inline
        _hexagon()      {}
        _hexagon(_hexagon& a)   { *this=a; }
        ~_hexagon() {}
        _hexagon* operator = (const _hexagon *a) { *this=*a; return this; }
        //_hexagon* operator = (const _hexagon &a) { ...copy... return this; }
        };
    List<_hexagon> hex;
    //---------------------------------------------------------------------------
    // https://stackoverflow.com/a/46787885/2521214
    //---------------------------------------------------------------------------
    void hex_sphere(int N,double R)
        {
        const double c=cos(60.0*deg);
        const double s=sin(60.0*deg);
        const double sy=       R/(N+N-2);
        const double sz=sy/s;
        const double sx=sz*c;
        const double sz2=0.5*sz;
    
        const int na=5*(N-2);
        const int nb=  N;
        const int b0=  N;
        double *q,p[3],ang,len,l,l0,ll;
        int i,j,n,a,b,ix;
        _hexagon h,*ph;
    
        hex.allocate(na*nb);
        hex.num=0;
        pnt.reset3D(N*N);
        b=0; a=0; ix=0;
    
        // generate triangle hex grid
        h.col=0x00804000;
        for (b=1;b<N-1;b++)                             // skip first line b=0
         for (a=1;a<b;a++)                              // skip first and last line
            {
            p[0]=double(a       )*(sx+sz);
            p[1]=double(b-(a>>1))*(sy*2.0);
            p[2]=0.0;
            if (int(a&1)!=0) p[1]-=sy;
            ix=pnt.add(p[0]+sz2+sx,p[1]   ,p[2]); h.ix[0]=ix; //  2 1
            ix=pnt.add(p[0]+sz2   ,p[1]+sy,p[2]); h.ix[1]=ix; // 3   0
            ix=pnt.add(p[0]-sz2   ,p[1]+sy,p[2]); h.ix[2]=ix; //  4 5
            ix=pnt.add(p[0]-sz2-sx,p[1]   ,p[2]); h.ix[3]=ix;
            ix=pnt.add(p[0]-sz2   ,p[1]-sy,p[2]); h.ix[4]=ix;
            ix=pnt.add(p[0]+sz2   ,p[1]-sy,p[2]); h.ix[5]=ix;
            h.a=a;
            h.b=N-1-b;
            hex.add(h);
            } n=hex.num; // remember number of hexs for the first triangle
    
        // distort points to match area
        for (ix=0;ix<pnt.nn;ix+=3)
            {
            // point pointer
            q=pnt.pnt.dat+ix;
            // convert to polar coordinates
            ang=atan2(q[1],q[0]);
            len=vector_len(q);
            // match area of pentagon (72deg) triangle as we got hexagon (60deg) triangle
            ang-=60.0*deg;  // rotate so center of generated triangle is angle 0deg
            while (ang>+60.0*deg) ang-=pi2;
            while (ang<-60.0*deg) ang+=pi2;
            len*=cos(ang)/cos(30.0*deg);        // scale radius so triangle converts to pie
            ang*=72.0/60.0;                     // scale up angle so rotated triangles merge
            // convert back to cartesian
            q[0]=len*cos(ang);
            q[1]=len*sin(ang);
            }
    
        // copy and rotate the triangle to cover pentagon
        h.col=0x00404000;
        for (ang=72.0*deg,a=1;a<5;a++,ang+=72.0*deg)
         for (ph=hex.dat,i=0;i<n;i++,ph++)
            {
            for (j=0;j<6;j++)
                {
                vector_copy(p,pnt.pnt.dat+ph->ix[j]);
                rotate2d(-ang,p[0],p[1]);
                h.ix[j]=pnt.add(p[0],p[1],p[2]);
                }
            h.a=ph->a+(a*(N-2));
            h.b=ph->b;
            hex.add(h);
            }
    
        // compute z
        for (q=pnt.pnt.dat,ix=0;ix<pnt.nn;ix+=pnt.dn,q+=pnt.dn)
            {
            q[2]=0.0;
            ang=vector_len(q)*0.5*pi/R;
            q[2]=R*cos(ang);
            ll=fabs(R*sin(ang)/sqrt((q[0]*q[0])+(q[1]*q[1])));
            q[0]*=ll;
            q[1]*=ll;
            }
    
        // copy and mirror the other half-sphere
        n=hex.num;
        for (ph=hex.dat,i=0;i<n;i++,ph++)
            {
            for (j=0;j<6;j++)
                {
                vector_copy(p,pnt.pnt.dat+ph->ix[j]);
                p[2]=-p[2];
                h.ix[j]=pnt.add(p[0],p[1],p[2]);
                }
            h.a= ph->a;
            h.b=-ph->b;
            hex.add(h);
            }
    
        // create index search table
        int i0,i1,j0,j1,a0,a1,ii[5];
        int **ab=new int*[na];
        for (a=0;a<na;a++)
            {
            ab[a]=new int[nb+nb+1];
            for (b=-nb;b<=nb;b++) ab[a][b0+b]=-1;
            }
        n=hex.num;
        for (ph=hex.dat,i=0;i<n;i++,ph++) ab[ph->a][b0+ph->b]=i;
    
        // add join ring
        h.col=0x00408000;
        for (a=0;a<na;a++)
            {
            h.a=a;
            h.b=0;
            a0=a;
            a1=a+1; if (a1>=na) a1-=na;
            i0=ab[a0][b0+1];
            i1=ab[a1][b0+1];
            j0=ab[a0][b0-1];
            j1=ab[a1][b0-1];
            if ((i0>=0)&&(i1>=0))
             if ((j0>=0)&&(j1>=0))
                {
                h.ix[0]=hex[i1].ix[1];
                h.ix[1]=hex[i0].ix[0];
                h.ix[2]=hex[i0].ix[1];
                h.ix[3]=hex[j0].ix[1];
                h.ix[4]=hex[j0].ix[0];
                h.ix[5]=hex[j1].ix[1];
                hex.add(h);
                ab[h.a][b0+h.b]=hex.num-1;
                }
            }
    
        // add 2x5 join lines
        h.col=0x00008040;
        for (a=0;a<na;a+=N-2)
         for (b=1;b<N-3;b++)
            {
            // +b hemisphere
            h.a= a;
            h.b=+b;
            a0=a-b; if (a0<  0) a0+=na; i0=ab[a0][b0+b+0];
            a0--;   if (a0<  0) a0+=na; i1=ab[a0][b0+b+1];
            a1=a+1; if (a1>=na) a1-=na; j0=ab[a1][b0+b+0];
                                        j1=ab[a1][b0+b+1];
            if ((i0>=0)&&(i1>=0))
             if ((j0>=0)&&(j1>=0))
                {
                h.ix[0]=hex[i0].ix[5];
                h.ix[1]=hex[i0].ix[4];
                h.ix[2]=hex[i1].ix[5];
                h.ix[3]=hex[j1].ix[3];
                h.ix[4]=hex[j0].ix[4];
                h.ix[5]=hex[j0].ix[3];
                hex.add(h);
                }
            // -b hemisphere
            h.a= a;
            h.b=-b;
            a0=a-b; if (a0<  0) a0+=na; i0=ab[a0][b0-b+0];
            a0--;   if (a0<  0) a0+=na; i1=ab[a0][b0-b-1];
            a1=a+1; if (a1>=na) a1-=na; j0=ab[a1][b0-b+0];
                                        j1=ab[a1][b0-b-1];
            if ((i0>=0)&&(i1>=0))
             if ((j0>=0)&&(j1>=0))
                {
                h.ix[0]=hex[i0].ix[5];
                h.ix[1]=hex[i0].ix[4];
                h.ix[2]=hex[i1].ix[5];
                h.ix[3]=hex[j1].ix[3];
                h.ix[4]=hex[j0].ix[4];
                h.ix[5]=hex[j0].ix[3];
                hex.add(h);
                }
            }
    
        // add pentagons at poles
        _hexagon h0,h1;
        h0.col=0x00000080;
        h0.a=0; h0.b=N-1; h1=h0; h1.b=-h1.b;
        p[2]=sqrt((R*R)-(sz*sz));
        for (ang=0.0,a=0;a<5;a++,ang+=72.0*deg)
            {
            p[0]=2.0*sz*cos(ang);
            p[1]=2.0*sz*sin(ang);
            h0.ix[a]=pnt.add(p[0],p[1],+p[2]);
            h1.ix[a]=pnt.add(p[0],p[1],-p[2]);
            }
        h0.ix[5]=h0.ix[4]; hex.add(h0);
        h1.ix[5]=h1.ix[4]; hex.add(h1);
    
        // add 5 missing hexagons at poles
        h.col=0x00600060;
        for (ph=&h0,b=N-3,h.b=N-2,i=0;i<2;i++,b=-b,ph=&h1,h.b=-h.b)
            {
            a =  1; if (a>=na) a-=na; ii[0]=ab[a][b0+b];
            a+=N-2; if (a>=na) a-=na; ii[1]=ab[a][b0+b];
            a+=N-2; if (a>=na) a-=na; ii[2]=ab[a][b0+b];
            a+=N-2; if (a>=na) a-=na; ii[3]=ab[a][b0+b];
            a+=N-2; if (a>=na) a-=na; ii[4]=ab[a][b0+b];
            for (j=0;j<5;j++)
                {
                h.a=((4+j)%5)*(N-2)+1;
                h.ix[0]=ph->ix[ (5-j)%5 ];
                h.ix[1]=ph->ix[ (6-j)%5 ];
                h.ix[2]=hex[ii[(j+4)%5]].ix[4];
                h.ix[3]=hex[ii[(j+4)%5]].ix[5];
                h.ix[4]=hex[ii[ j     ]].ix[3];
                h.ix[5]=hex[ii[ j     ]].ix[4];
                hex.add(h);
                }
            }
    
        // add 2*5 pentagons and 2*5 missing hexagons at equator
        h0.a=0; h0.b=N-1; h1=h0; h1.b=-h1.b;
        for (ang=36.0*deg,a=0;a<na;a+=N-2,ang-=72.0*deg)
            {
            p[0]=R*cos(ang);
            p[1]=R*sin(ang);
            p[2]=sz;
            i0=pnt.add(p[0],p[1],+p[2]);
            i1=pnt.add(p[0],p[1],-p[2]);
            a0=a-1;if (a0<  0) a0+=na;
            a1=a+1;if (a1>=na) a1-=na;
            ii[0]=ab[a0][b0-1]; ii[2]=ab[a1][b0-1];
            ii[1]=ab[a0][b0+1]; ii[3]=ab[a1][b0+1];
            // hexagons
            h.col=0x00008080;
            h.a=a; h.b=0;
            h.ix[0]=hex[ii[0]].ix[0];
            h.ix[1]=hex[ii[0]].ix[1];
            h.ix[2]=hex[ii[1]].ix[1];
            h.ix[3]=hex[ii[1]].ix[0];
            h.ix[4]=i0;
            h.ix[5]=i1;
            hex.add(h);
            h.a=a; h.b=0;
            h.ix[0]=hex[ii[2]].ix[2];
            h.ix[1]=hex[ii[2]].ix[1];
            h.ix[2]=hex[ii[3]].ix[1];
            h.ix[3]=hex[ii[3]].ix[2];
            h.ix[4]=i0;
            h.ix[5]=i1;
            hex.add(h);
            // pentagons
            h.col=0x000040A0;
            h.a=a; h.b=0;
            h.ix[0]=hex[ii[0]].ix[0];
            h.ix[1]=hex[ii[0]].ix[5];
            h.ix[2]=hex[ii[2]].ix[3];
            h.ix[3]=hex[ii[2]].ix[2];
            h.ix[4]=i1;
            h.ix[5]=i1;
            hex.add(h);
            h.a=a; h.b=0;
            h.ix[0]=hex[ii[1]].ix[0];
            h.ix[1]=hex[ii[1]].ix[5];
            h.ix[2]=hex[ii[3]].ix[3];
            h.ix[3]=hex[ii[3]].ix[2];
            h.ix[4]=i0;
            h.ix[5]=i0;
            hex.add(h);
            }
    
        // release index search table
        for (a=0;a<na;a++) delete[] ab[a];
        delete[] ab;
        }
    //---------------------------------------------------------------------------
    void hex_draw(GLuint style)     // draw hex
        {
        int i,j;
        _hexagon *h;
        for (h=hex.dat,i=0;i<hex.num;i++,h++)
            {
            if (style==GL_POLYGON) glColor4ubv((BYTE*)&h->col);
            glBegin(style);
            for (j=0;j<6;j++) glVertex3dv(pnt.pnt.dat+h->ix[j]);
            glEnd();
            }
        if (0)
        if (style==GL_POLYGON)
            {
            scr.text_init_pixel(0.1,-0.2);
            glColor3f(1.0,1.0,1.0);
            for (h=hex.dat,i=0;i<hex.num;i++,h++)
             if (abs(h->b)<2)
                {
                double p[3];
                vector_ld(p,0.0,0.0,0.0);
                for (j=0;j<6;j++)
                 vector_add(p,p,pnt.pnt.dat+h->ix[j]);
                vector_mul(p,p,1.0/6.0);
                scr.text(p[0],p[1],p[2],AnsiString().sprintf("%i,%i",h->a,h->b));
                }
            scr.text_exit_pixel();
            }
        }
    //---------------------------------------------------------------------------
    void TMain::draw()
        {
        scr.cls();
        int x,y;
    
        glMatrixMode(GL_MODELVIEW);
        glLoadIdentity();
        glTranslatef(0.0,0.0,-5.0);
        glRotated(animx,1.0,0.0,0.0);
        glRotated(animy,0.0,1.0,0.0);
    
        hex_draw(GL_POLYGON);
    
        glMatrixMode(GL_MODELVIEW);
        glLoadIdentity();
        glTranslatef(0.0,0.0,-5.0+0.01);
        glRotated(animx,1.0,0.0,0.0);
        glRotated(animy,0.0,1.0,0.0);
    
        glColor3f(1.0,1.0,1.0);
        glLineWidth(2);
        hex_draw(GL_LINE_LOOP);
        glCirclexy(0.0,0.0,0.0,1.5);
        glLineWidth(1);
    
        scr.exe();
        scr.rfs();
        }
    //---------------------------------------------------------------------------
    __fastcall TMain::TMain(TComponent* Owner) : TForm(Owner)
        {
        scr.init(this);
        hex_sphere(10,1.5);
        _redraw=true;
        }
    //---------------------------------------------------------------------------
    void __fastcall TMain::FormDestroy(TObject *Sender)
        {
        scr.exit();
        }
    //---------------------------------------------------------------------------
    void __fastcall TMain::FormPaint(TObject *Sender)
        {
        _redraw=true;
        }
    //---------------------------------------------------------------------------
    void __fastcall TMain::FormResize(TObject *Sender)
        {
        scr.resize();
        glMatrixMode(GL_PROJECTION);
        glLoadIdentity();
        gluPerspective(60,float(scr.xs)/float(scr.ys),0.1,100.0);
        _redraw=true;
        }
    //-----------------------------------------------------------------------
    void __fastcall TMain::Timer1Timer(TObject *Sender)
        {
        animx+=danimx; if (animx>=360.0) animx-=360.0; _redraw=true;
        animy+=danimy; if (animy>=360.0) animy-=360.0; _redraw=true;
        if (_redraw) { draw(); _redraw=false; }
        }
    //---------------------------------------------------------------------------
    void __fastcall TMain::FormKeyDown(TObject *Sender, WORD &Key, TShiftState Shift)
        {
        Caption=Key;
        if (Key==40){ animx+=2.0; _redraw=true; }
        if (Key==38){ animx-=2.0; _redraw=true; }
        if (Key==39){ animy+=2.0; _redraw=true; }
        if (Key==37){ animy-=2.0; _redraw=true; }
        }
    //---------------------------------------------------------------------------
    

    我知道这是一个索引混乱,也不能保证缠绕规则,因为我懒得做统一的索引。请注意每个十六进制的a索引不是线性的,如果要使用它们映射到 2D 地图,则需要使用atan2 x,y重新计算它它的中心点位置。

    此处预览:

    preview preview

    仍有一些扭曲现象。它们是由于我们使用5个三角形在赤道连接(因此保证了连接)。这意味着周长为5*R而不是6.28*R。然而,通过现场模拟仍然可以改善这一点。只需取出所有点并根据它们的距离添加回缩力并绑定到球体表面。运行模拟,当振荡低于阈值时,你得到球形网格......

    另一种选择是找出一些方程式来重新映射网格点(类似于我为三角形到饼形转换所做的那样)会产生更好的结果。