// Hyperbolic Rogue -- nonisotropic spaces (Solv and Nil) // Copyright (C) 2011-2019 Zeno Rogue, see 'hyper.cpp' for details /** \file nonisotropic.cpp * \brief nonisotropic spaces (Solv and Nil) */ #include "hyper.h" namespace hr { EX namespace nisot { #if HDR inline bool local_perspective_used() { return nonisotropic || prod; } #endif EX bool geodesic_movement = true; EX transmatrix translate(hyperpoint h) { if(sl2) return slr::translate(h); transmatrix T = Id; for(int i=0; i compressed_point; inline hyperpoint decompress(compressed_point p) { return point3(p[0], p[1], p[2]); } inline compressed_point compress(hyperpoint h) { return make_array(h[0], h[1], h[2]); } struct tabled_inverses { int PRECX, PRECY, PRECZ; vector tab; string fname; bool loaded; void load(); hyperpoint get(ld ix, ld iy, ld iz, bool lazy); compressed_point& get_int(int ix, int iy, int iz) { return tab[(iz*PRECY+iy)*PRECX+ix]; } GLuint texture_id; bool toload; GLuint get_texture_id(); tabled_inverses(string s) : fname(s), texture_id(0), toload(true) {} }; #endif void tabled_inverses::load() { if(loaded) return; FILE *f = fopen(fname.c_str(), "rb"); // if(!f) f = fopen("/usr/lib/soltable.dat", "rb"); if(!f) { addMessage(XLAT("geodesic table missing")); pmodel = mdPerspective; return; } ignore(fread(&PRECX, 4, 1, f)); ignore(fread(&PRECY, 4, 1, f)); ignore(fread(&PRECZ, 4, 1, f)); tab.resize(PRECX * PRECY * PRECZ); ignore(fread(&tab[0], sizeof(compressed_point) * PRECX * PRECY * PRECZ, 1, f)); fclose(f); loaded = true; } hyperpoint tabled_inverses::get(ld ix, ld iy, ld iz, bool lazy) { ix *= PRECX-1; iy *= PRECY-1; iz *= PRECZ-1; hyperpoint res; if(lazy) { return decompress(get_int(int(ix+.5), int(iy+.5), int(iz+.5))); } else { if(ix >= PRECX-1) ix = PRECX-2; if(iy >= PRECX-1) iy = PRECX-2; if(iz >= PRECZ-1) iz = PRECZ-2; int ax = ix, bx = ax+1; int ay = iy, by = ay+1; int az = iz, bz = az+1; #define S0(x,y,z) get_int(x, y, z)[t] #define S1(x,y) (S0(x,y,az) * (bz-iz) + S0(x,y,bz) * (iz-az)) #define S2(x) (S1(x,ay) * (by-iy) + S1(x,by) * (iy-ay)) for(int t=0; t<3; t++) res[t] = S2(ax) * (bx-ix) + S2(bx) * (ix-ax); res[3] = 0; } return res; } GLuint tabled_inverses::get_texture_id() { if(!toload) return texture_id; load(); if(!loaded) return 0; println(hlog, "installing table"); toload = false; if(texture_id == 0) glGenTextures(1, &texture_id); glBindTexture( GL_TEXTURE_3D, texture_id); glTexParameteri(GL_TEXTURE_3D, GL_TEXTURE_MIN_FILTER, GL_LINEAR); glTexParameteri(GL_TEXTURE_3D, GL_TEXTURE_MAG_FILTER, GL_LINEAR); glTexParameteri(GL_TEXTURE_3D, GL_TEXTURE_WRAP_S, GL_CLAMP_TO_EDGE); glTexParameteri(GL_TEXTURE_3D, GL_TEXTURE_WRAP_T, GL_CLAMP_TO_EDGE); glTexParameteri(GL_TEXTURE_3D, GL_TEXTURE_WRAP_R, GL_CLAMP_TO_EDGE); auto xbuffer = new glvertex[PRECZ*PRECY*PRECX]; for(int z=0; z iz) minz--; ld maxz = minz + 1; for(int it=0; it<20; it++) { ld z = (minz + maxz) / 2; if(z_to_iz(z) < iz) minz = z; else maxz = z; } return (minz+maxz) / 2; } EX hyperpoint azeq_to_table(hyperpoint x) { // azimuthal equidistant to Poincare ld r = hypot_d(3, x); if(r == 0) return point3(0,0,0); ld make_r = sinh(r) / (1 + cosh(r)); ld d = make_r / r; return x * d; } EX hyperpoint table_to_azeq(hyperpoint x) { // Poincare to azimuthal equidistant ld hr = sqhypot_d(3, x); if(hr < 1e-5) return x * 2; if(hr >= 1) return x * 60; ld hz = (1 + hr) / (1 - hr); ld d = (hz+1) * acosh(hz) / sinh(acosh(hz)); return x * d; } struct hrmap_solnih : hrmap { hrmap *binary_map; hrmap *ternary_map; /* nih only */ unordered_map, heptagon*> at; unordered_map> coords; heptagon *origin; heptagon *getOrigin() override { return origin; } heptagon *get_at(heptagon *x, heptagon *y) { auto& h = at[make_pair(x, y)]; if(h) return h; h = tailored_alloc (S7); h->c7 = newCell(S7, h); coords[h] = make_pair(x, y); h->distance = x->distance; h->dm4 = 0; h->zebraval = x->emeraldval; h->emeraldval = y->emeraldval; h->fieldval = 0; h->cdata = NULL; h->alt = NULL; return h; } hrmap_solnih() { heptagon *alt; heptagon *alt3; if(true) { dynamicval g(geometry, gBinary4); alt = tailored_alloc (S7); alt->s = hsOrigin; alt->alt = alt; alt->cdata = NULL; alt->c7 = NULL; alt->zebraval = 0; alt->distance = 0; alt->emeraldval = 0; binary_map = bt::new_alt_map(alt); } if(nih) { dynamicval g(geometry, gTernary); alt3 = tailored_alloc (S7); alt3->s = hsOrigin; alt3->alt = alt3; alt3->cdata = NULL; alt3->c7 = NULL; alt3->zebraval = 0; alt3->distance = 0; alt3->emeraldval = 0; ternary_map = bt::new_alt_map(alt3); } else { alt3 = alt; ternary_map = nullptr; } origin = get_at(alt, alt3); } heptagon *altstep(heptagon *h, int d) { dynamicval g(geometry, gBinary4); dynamicval cm(currentmap, binary_map); return h->cmove(d); } heptagon *altstep3(heptagon *h, int d) { dynamicval g(geometry, gTernary); dynamicval cm(currentmap, ternary_map); return h->cmove(d); } heptagon *create_step(heptagon *parent, int d) override { auto p = coords[parent]; auto pf = p.first, ps = p.second; auto rule = [&] (heptagon *c1, heptagon *c2, int d1) { auto g = get_at(c1, c2); parent->c.connect(d, g, d1, false); return g; }; switch(geometry){ case gSol: switch(d) { case 0: // right return rule(altstep(pf, 2), ps, 4); case 1: // up return rule(pf, altstep(ps, 2), 5); case 2: // front left return rule(altstep(pf, 0), altstep(ps, 3), ps->zebraval ? 7 : 6); case 3: // front right return rule(altstep(pf, 1), altstep(ps, 3), ps->zebraval ? 7 : 6); case 4: // left return rule(altstep(pf, 4), ps, 0); case 5: // down return rule(pf, altstep(ps, 4), 1); case 6: // back down return rule(altstep(pf, 3), altstep(ps, 0), pf->zebraval ? 3 : 2); case 7: // back up return rule(altstep(pf, 3), altstep(ps, 1), pf->zebraval ? 3 : 2); default: return NULL; } case gNIH: switch(d) { case 0: // right return rule(altstep(pf, 2), ps, 2); case 1: // up return rule(pf, altstep3(ps, 3), 3); case 2: // left return rule(altstep(pf, 4), ps, 0); case 3: // down return rule(pf, altstep3(ps, 5), 1); case 4: // back return rule(altstep(pf, 3), altstep3(ps, 4), 5 + pf->zebraval + 2 * ps->zebraval); default: return rule(altstep(pf, (d-5) % 2), altstep3(ps, (d-5)/2), 4); } case gSolN: switch(d) { case 0: // right return rule(altstep(pf, 2), ps, 2); case 1: // up return rule(pf, altstep3(ps, 3), 3); case 2: // left return rule(altstep(pf, 4), ps, 0); case 3: // down return rule(pf, altstep3(ps, 5), 1); case 4: case 5: return rule(altstep(pf, d-4), altstep3(ps, 4), ps->zebraval + 6); case 6: case 7: case 8: return rule(altstep(pf, 3), altstep3(ps, d-6), pf->zebraval + 4); default: return NULL; } default: throw "not solnihv"; } } ~hrmap_solnih() { delete binary_map; if(ternary_map) delete ternary_map; for(auto& p: at) clear_heptagon(p.second); } transmatrix adjmatrix(int i, int j) { switch(geometry) { case gSol: { ld z = log(2); ld bw = vid.binary_width * z; switch(i) { case 0: return xpush(+bw); case 1: return ypush(+bw); case 2: case 3: return ypush(bw*(6.5-j)) * zpush(+z) * xpush(bw*(i-2.5)); case 4: return xpush(-bw); case 5: return ypush(-bw); case 6: case 7: return xpush(bw*(2.5-j)) * zpush(-z) * ypush(bw*(i-6.5)); default:return Id; } } case gNIH: { ld bw = vid.binary_width; switch(i) { case 0: return xpush(+bw); case 1: return ypush(+bw); case 2: return xpush(-bw); case 3: return ypush(-bw); case 4: return xpush(-((j-5)%2-.5)*bw) * ypush(-((j-5)/2-1)*bw) * zpush(1); default: return zpush(-1) * xpush(((i-5)%2-.5)*bw) * ypush(((i-5)/2-1)*bw); } } case gSolN: { ld bw = vid.binary_width; switch(i) { case 0: return xpush(+bw); case 1: return ypush(+bw); case 2: return xpush(-bw); case 3: return ypush(-bw); case 4: case 5: return ypush(bw*(7-j)) * zpush(+1) * xpush(bw*(i-4.5)); case 6: case 7: case 8: return xpush(bw*(4.5-j)) * zpush(-1) * ypush(bw*(i-7)); } } default: throw "not nihsolv"; } } transmatrix adj(heptagon *h, int d) override { h->cmove(d); return adjmatrix(d, h->c.spin(d)); } virtual transmatrix relative_matrix(heptagon *h2, heptagon *h1, const hyperpoint& hint) override { for(int i=0; itype; i++) if(h1->move(i) == h2) return adjmatrix(i, h1->c.spin(i)); if(gmatrix0.count(h2->c7) && gmatrix0.count(h1->c7)) return inverse(gmatrix0[h1->c7]) * gmatrix0[h2->c7]; transmatrix front = Id, back = Id; int up, down; switch(geometry) { case gSol: up = 2; down = 6; break; case gSolN: up = 4; down = 7; break; case gNIH: up = 4; down = 4; break; default: throw "not nihsolv"; } while(h1->distance > h2->distance) front = front * adj(h1, down), h1 = h1->cmove(down); while(h1->distance < h2->distance) back = iadj(h2, down) * back, h2 = h2->cmove(down); while(coords[h1].first != coords[h2].first) front = front * adj(h1, down), back = iadj(h2, down) * back, h1 = h1->cmove(down), h2 = h2->cmove(down); while(coords[h1].second != coords[h2].second) front = front * adj(h1, up), back = iadj(h2, up) * back, h1 = h1->cmove(up), h2 = h2->cmove(up); return front * back; } void draw() override { dq::visited.clear(); dq::enqueue(centerover->master, cview()); while(!dq::drawqueue.empty()) { auto& p = dq::drawqueue.front(); heptagon *h = get<0>(p); transmatrix V = get<1>(p); dq::drawqueue.pop(); cell *c = h->c7; if(!do_draw(c, V)) continue; drawcell(c, V); if(in_wallopt() && isWall3(c) && isize(dq::drawqueue) > 1000) continue; for(int i=0; icmove(i); dq::enqueue(h1, V * adjmatrix(i, h->c.spin(i))); } } } }; EX pair getcoord(heptagon *h) { return ((hrmap_solnih*)currentmap)->coords[h]; } EX heptagon *get_at(heptagon *h1, heptagon *h2, bool gen) { auto m = ((hrmap_solnih*)currentmap); if(!gen && !m->at.count(make_pair(h1, h2))) return nullptr; return m->get_at(h1, h2); } EX string common = "uniform mediump sampler3D tInvExpTable;" "uniform mediump float PRECX, PRECY, PRECZ;" "float x_to_ix(float u) {" " if(u < 1e-6) return 0.;" " float diag = u*u/2.;" " float x = diag;" " float y = u;" " float z = diag+1.;" " x /= (1.+z);" " y /= (1.+z);" " return 0.5 - atan((0.5-x) / y) / 3.1415926535897932384626433832795;" " }" "float z_to_iz_s(float z) {" "return sinh(z) / (1. + cosh(z));" "}" "float z_to_iz_ns(float z) {" "z = sinh(z) / (1. + cosh(z));" "return (z+1.)/2.;" "}"; hyperpoint christoffel(const hyperpoint at, const hyperpoint velocity, const hyperpoint transported) { const ld l2 = log(2); const ld l3 = log(3); switch(geom()) { case gSolN: return hpxyz3( -(velocity[2] * transported[0] + velocity[0] * transported[2]) * l2, (velocity[2] * transported[1] + velocity[1] * transported[2]) * l3, velocity[0] * transported[0] * exp(2*l2*at[2]) * l2 - velocity[1] * transported[1] * exp(-2*l3*at[2]) * l3, 0 ); case gSol: return hpxyz3( -velocity[2] * transported[0] - velocity[0] * transported[2], velocity[2] * transported[1] + velocity[1] * transported[2], velocity[0] * transported[0] * exp(2*at[2]) - velocity[1] * transported[1] * exp(-2*at[2]), 0 ); case gNIH: return hpxyz3( (velocity[2] * transported[0] + velocity[0] * transported[2]) * l2, (velocity[2] * transported[1] + velocity[1] * transported[2]) * l3, -(velocity[0] * transported[0] * exp(-2*l2*at[2]) * l2 + velocity[1] * transported[1] * exp(-2*l3*at[2]) * l3), 0 ); default: throw "christoffel not in solnihv"; } } EX hyperpoint get_inverse_exp_symsol(hyperpoint h, flagtype flags) { auto& s = get_tabled(); s.load(); ld ix = h[0] >= 0. ? sn::x_to_ix(h[0]) : sn::x_to_ix(-h[0]); ld iy = h[1] >= 0. ? sn::x_to_ix(h[1]) : sn::x_to_ix(-h[1]); ld iz = sn::z_to_iz(h[2]); if(h[2] < 0.) { iz = -iz; swap(ix, iy); } hyperpoint res = s.get(ix, iy, iz, flags & pfNO_INTERPOLATION); if(h[2] < 0.) { swap(res[0], res[1]); res[2] = -res[2]; } if(h[0] < 0.) res[0] = -res[0]; if(h[1] < 0.) res[1] = -res[1]; if(flags & pfNO_DISTANCE) return res; return table_to_azeq(res); } EX hyperpoint get_inverse_exp_nsym(hyperpoint h, flagtype flags) { auto& s = get_tabled(); s.load(); ld ix = h[0] >= 0. ? sn::x_to_ix(h[0]) : sn::x_to_ix(-h[0]); ld iy = h[1] >= 0. ? sn::x_to_ix(h[1]) : sn::x_to_ix(-h[1]); ld iz = sn::z_to_iz(h[2]); hyperpoint res = s.get(ix, iy, iz, flags & pfNO_INTERPOLATION); if(h[0] < 0.) res[0] = -res[0]; if(h[1] < 0.) res[1] = -res[1]; if(flags & pfNO_DISTANCE) return res; return table_to_azeq(res); } EX string shader_symsol = sn::common + "vec4 inverse_exp(vec4 h) {" "float ix = h[0] >= 0. ? x_to_ix(h[0]) : x_to_ix(-h[0]);" "float iy = h[1] >= 0. ? x_to_ix(h[1]) : x_to_ix(-h[1]);" "float iz = z_to_iz_s(h[2]);" "if(h[2] < 1e-6) { iz = -iz; float s = ix; ix = iy; iy = s; }" "if(iz < 0.) iz = 0.;" "vec4 res;" "float cx = ix*(1.-1./PRECX) + .5/PRECX;" "float cy = iy*(1.-1./PRECY) + .5/PRECY;" "float cz = iz*(1.-1./PRECZ) + .5/PRECZ;" // "if(ix > .5 && iy > .6 && ix < iy + .05 && iz < .2 && iz < (iy - 0.5) * 0.6)" "if(ix > .65 + iz * .25 && iy > .55) res = vec4(0.,0.,0.,1.); " "else " "res = texture3D(tInvExpTable, vec3(cx, cy, cz));" "if(h[2] < 1e-6) { res.xy = res.yx; res[2] = -res[2]; }" "if(h[0] < 0.) res[0] = -res[0];" "if(h[1] < 0.) res[1] = -res[1];" "return res;" "}"; EX string shader_nsymsol = sn::common + R"*( vec4 inverse_exp(vec4 h) { float ix = h[0] >= 0. ? x_to_ix(h[0]) : x_to_ix(-h[0]); float iy = h[1] >= 0. ? x_to_ix(h[1]) : x_to_ix(-h[1]); float iz = z_to_iz_ns(h[2]); vec4 res; float cx = ix*(1.-1./PRECX) + .5/PRECX; float cy = iy*(1.-1./PRECY) + .5/PRECY; float cz = iz*(1.-1./PRECZ) + .5/PRECZ; if(ix > .65 && iy > .5 && iz > .45 && iz < .55) res = vec4(0.,0.,0.,1.); else if(ix > .55 && iy > .75 && ix < .7 && iz > .45 && iz < .55) res = vec4(0.,0.,0.,1.); else if(ix > .45 && iy > .75 && ix < .7 && iz > .4 && iz < .5) res = vec4(0.,0.,0.,1.); else if(ix > .85 && iy > .5 && iz > .55 && iz < .75) res = vec4(0.,0.,0.,1.); else if(ix > .7 && iy > .55 && iz > .42 && iz < .58) res = vec4(0.,0.,0.,1.); else if(iz > 0.45 && ix > 0.8 && iy > 0.3 && iy < 0.6) res = vec4(0.,0.,0.,1.); else if(iz > 0.45 && ix > 0.8 && iy > 0.3 && iy < 0.6) res = vec4(0.,0.,0.,1.); else if(iz > .4 && iz < .55 && ix > .7 && iy > .36 && iy < .5 && ix < .8 && ix+iy > 1.2) res = vec4(0.,0.,0.,1.); else res = texture3D(tInvExpTable, vec3(cx, cy, cz)); if(h[0] < 0.) res[0] = -res[0]; if(h[1] < 0.) res[1] = -res[1]; return res; })*"; EX string shader_nsym = sn::common + "vec4 inverse_exp(vec4 h) {" "float ix = h[0] >= 0. ? x_to_ix(h[0]) : x_to_ix(-h[0]);" "float iy = h[1] >= 0. ? x_to_ix(h[1]) : x_to_ix(-h[1]);" "float iz = z_to_iz_ns(h[2]);" "vec4 res;" "float cx = ix*(1.-1./PRECX) + .5/PRECX;" "float cy = iy*(1.-1./PRECY) + .5/PRECY;" "float cz = iz*(1.-1./PRECZ) + .5/PRECZ;" "res = texture3D(tInvExpTable, vec3(cx, cy, cz));" "if(h[0] < 0.) res[0] = -res[0];" "if(h[1] < 0.) res[1] = -res[1];" "return res;" "}"; EX ld solrange_xy = 15; EX ld solrange_z = 4; EX bool in_table_range(hyperpoint h) { return abs(h[0]) < solrange_xy && abs(h[1]) < solrange_xy && abs(h[2]) < solrange_z; } EX tabled_inverses solt = sn::tabled_inverses("solv-geodesics.dat"); EX tabled_inverses niht = sn::tabled_inverses("shyp-geodesics.dat"); EX tabled_inverses sont = sn::tabled_inverses("ssol-geodesics.dat"); EX tabled_inverses& get_tabled() { switch(geom()) { case gSol: return solt; case gNIH: return niht; case gSolN: return sont; default: throw "not solnih"; } } EX int approx_distance(heptagon *h1, heptagon *h2) { auto m = (sn::hrmap_solnih*) currentmap; dynamicval g(geometry, gBinary4); dynamicval cm(currentmap, m->binary_map); int d1 = bt::celldistance3_approx(m->coords[h1].first, m->coords[h2].first); int d2 = bt::celldistance3_approx(m->coords[h1].second, m->coords[h2].second); return d1 + d2 - abs(h1->distance - h2->distance); } EX } #endif EX namespace nilv { hyperpoint christoffel(const hyperpoint Position, const hyperpoint Velocity, const hyperpoint Transported) { ld x = Position[0]; return point3( x * Velocity[1] * Transported[1] - 0.5 * (Velocity[1] * Transported[2] + Velocity[2] * Transported[1]), -.5 * x * (Velocity[1] * Transported[0] + Velocity[0] * Transported[1]) + .5 * (Velocity[2] * Transported[0] + Velocity[0] * Transported[2]), -.5 * (x*x-1) * (Velocity[1] * Transported[0] + Velocity[0] * Transported[1]) + .5 * x * (Velocity[2] * Transported[0] + Velocity[0] * Transported[2]) ); } EX hyperpoint formula_exp(hyperpoint v) { // copying Modelling Nil-geometry in Euclidean Space with Software Presentation // v[0] = c cos alpha // v[1] = c sin alpha // v[2] = w if(v[0] == 0 && v[1] == 0) return point31(v[0], v[1], v[2]); if(v[2] == 0) return point31(v[0], v[1], v[0] * v[1] / 2); ld alpha = atan2(v[1], v[0]); ld w = v[2]; ld c = hypot(v[0], v[1]) / v[2]; return point31( 2 * c * sin(w/2) * cos(w/2 + alpha), 2 * c * sin(w/2) * sin(w/2 + alpha), w * (1 + (c*c/2) * ((1 - sin(w)/w) + (1-cos(w))/w * sin(w + 2 * alpha))) ); } EX hyperpoint get_inverse_exp(hyperpoint h, flagtype prec IS(pNORMAL)) { ld wmin, wmax; ld side = h[2] - h[0] * h[1] / 2; if(hypot_d(2, h) < 1e-6) return point3(h[0], h[1], h[2]); else if(side > 1e-6) { wmin = 0, wmax = 2 * M_PI; } else if(side < -1e-6) { wmin = - 2 * M_PI, wmax = 0; } else return point3(h[0], h[1], 0); ld alpha_total = h[0] ? atan(h[1] / h[0]) : M_PI/2; ld b; if(abs(h[0]) > abs(h[1])) b = h[0] / 2 / cos(alpha_total); else b = h[1] / 2 / sin(alpha_total); ld s = sin(2 * alpha_total); int max_iter = (prec & pfLOW_BS_ITER) ? 5 : 20; for(int it=0;; it++) { ld w = (wmin + wmax) / 2; ld z = b * b * (s + (sin(w) - w)/(cos(w) - 1)) + w; if(it == max_iter) { ld alpha = alpha_total - w/2; ld c = b / sin(w/2); return point3(c * w * cos(alpha), c * w * sin(alpha), w); } if(h[2] > z) wmin = w; else wmax = w; } } EX string nilshader = "vec4 inverse_exp(vec4 h) {" "float wmin, wmax;" "float side = h[2] - h[0] * h[1] / 2.;" "if(h[0]*h[0] + h[1]*h[1] < 1e-12) return vec4(h[0], h[1], h[2], 1);" "if(side > 1e-6) { wmin = 0.; wmax = 2.*PI; }" "else if(side < -1e-6) { wmin = -2.*PI; wmax = 0.; }" "else return vec4(h[0], h[1], 0., 1.);" "float at = h[0] != 0. ? atan(h[1] / h[0]) : PI/2.;" "float b = abs(h[0]) > abs(h[1]) ? h[0] / 2. / cos(at) : h[1] / 2. / sin(at);" "float s = sin(2. * at);" "for(int it=0; it<50; it++) {" "float w = (wmin + wmax) / 2.;" // the formula after ':' produces visible numerical artifacts for w~0 "float z = b * b * (s + (abs(w) < .1 ? w/3. + w*w*w/90. + w*w*w*w*w/2520.: (sin(w) - w)/(cos(w) - 1.))) + w;" "if(h[2] > z) wmin = w;" "else wmax = w;" "}" "float w = (wmin + wmax) / 2.;" "float alpha = at - w/2.;" "float c = b / sin(w/2.);" "return vec4(c*w*cos(alpha), c*w*sin(alpha), w, 1.);" "}"; #if HDR struct mvec : array { mvec() { } mvec(int x, int y, int z) { auto& a = *this; a[0] = x; a[1] = y; a[2] = z; } mvec inverse() { auto& a = *this; return mvec(-a[0], -a[1], -a[2]+a[1] * a[0]); } mvec operator * (const mvec b) { auto& a = *this; return mvec(a[0] + b[0], a[1] + b[1], a[2] + b[2] + a[0] * b[1]); } }; #endif static const mvec mvec_zero = mvec(0, 0, 0); EX ld nilwidth = 1; hyperpoint mvec_to_point(mvec m) { return hpxy3(m[0] * nilwidth, m[1] * nilwidth, m[2] * nilwidth * nilwidth); } #if HDR struct nilstructure { vector movevectors; vector> facevertices; }; #endif nilstructure ns6 = { {{ mvec(-1,0,0), mvec(0,-1,0), mvec(0,0,-1), mvec(1,0,0), mvec(0,1,0), mvec(0,0,1) }}, {{ { point31(-0.5,-0.5,-0.25), point31(-0.5,-0.5,0.75), point31(-0.5,0.5,0.25), point31(-0.5,0.5,-0.75), }, { point31(0.5,-0.5,-0.5), point31(0.5,-0.5,0.5), point31(-0.5,-0.5,0.5), point31(-0.5,-0.5,-0.5), }, { point31(0,0,-0.5), point31(-0.5,0.5,-0.75), point31(-0.5,-0.5,-0.25), point31(0,0,-0.5), point31(-0.5,-0.5,-0.25), point31(-0.5,-0.5,-0.5), point31(0,0,-0.5), point31(-0.5,-0.5,-0.5), point31(0.5,-0.5,-0.5), point31(0,0,-0.5), point31(0.5,-0.5,-0.5), point31(0.5,-0.5,-0.75), point31(0,0,-0.5), point31(0.5,-0.5,-0.75), point31(0.5,0.5,-0.25), point31(0,0,-0.5), point31(0.5,0.5,-0.25), point31(0.5,0.5,-0.5), point31(0,0,-0.5), point31(0.5,0.5,-0.5), point31(-0.5,0.5,-0.5), point31(0,0,-0.5), point31(-0.5,0.5,-0.5), point31(-0.5,0.5,-0.75), }, { point31(0.5,0.5,-0.25), point31(0.5,0.5,0.75), point31(0.5,-0.5,0.25), point31(0.5,-0.5,-0.75), }, { point31(-0.5,0.5,-0.5), point31(-0.5,0.5,0.5), point31(0.5,0.5,0.5), point31(0.5,0.5,-0.5), }, { point31(0,0,0.5), point31(-0.5,0.5,0.25), point31(-0.5,-0.5,0.75), point31(0,0,0.5), point31(-0.5,-0.5,0.75), point31(-0.5,-0.5,0.5), point31(0,0,0.5), point31(-0.5,-0.5,0.5), point31(0.5,-0.5,0.5), point31(0,0,0.5), point31(0.5,-0.5,0.5), point31(0.5,-0.5,0.25), point31(0,0,0.5), point31(0.5,-0.5,0.25), point31(0.5,0.5,0.75), point31(0,0,0.5), point31(0.5,0.5,0.75), point31(0.5,0.5,0.5), point31(0,0,0.5), point31(0.5,0.5,0.5), point31(-0.5,0.5,0.5), point31(0,0,0.5), point31(-0.5,0.5,0.5), point31(-0.5,0.5,0.25), }, }} }; nilstructure ns8 = { {{ mvec(-1,0,0), mvec(-1,0,1), mvec(0,-1,0), mvec(0,0,-1), mvec(1,0,0), mvec(1,0,-1), mvec(0,1,0), mvec(0,0,1) }}, {{ { point31(-0.5,-0.5,-0.25), point31(-0.5,-0.5,0.75), point31(-0.5,0.5,-0.25), }, { point31(-0.5,-0.5,0.75), point31(-0.5,0.5,0.75), point31(-0.5,0.5,-0.25), }, { point31(-0.5,-0.5,-0.25), point31(-0.5,-0.5,0.75), point31(0.5,-0.5,0.25), point31(0.5,-0.5,-0.75), }, { point31(-0.5,-0.5,-0.25), point31(-0.5,0.5,-0.25), point31(0.5,0.5,-0.75), point31(0.5,-0.5,-0.75), }, { point31(0.5,0.5,0.25), point31(0.5,-0.5,0.25), point31(0.5,-0.5,-0.75), }, { point31(0.5,0.5,-0.75), point31(0.5,0.5,0.25), point31(0.5,-0.5,-0.75), }, { point31(-0.5,0.5,0.75), point31(-0.5,0.5,-0.25), point31(0.5,0.5,-0.75), point31(0.5,0.5,0.25), }, { point31(-0.5,-0.5,0.75), point31(-0.5,0.5,0.75), point31(0.5,0.5,0.25), point31(0.5,-0.5,0.25), }, }} }; EX nilstructure& current_ns() { return S7 == 6 ? ns6 : ns8; } EX array nilperiod, nilperiod_edit; int S7_edit; EX transmatrix adjmatrix(int i) { return nisot::translate(mvec_to_point(current_ns().movevectors[i])); } struct hrmap_nil : hrmap { unordered_map at; unordered_map coords; heptagon *getOrigin() override { return get_at(mvec_zero); } ~hrmap_nil() { for(auto& p: at) clear_heptagon(p.second); } heptagon *get_at(mvec c) { auto& h = at[c]; if(h) return h; h = tailored_alloc (S7); h->c7 = newCell(S7, h); coords[h] = c; h->dm4 = 0; h->zebraval = c[0]; h->emeraldval = c[1]; h->fieldval = c[2]; h->cdata = NULL; h->alt = NULL; return h; } heptagon *create_step(heptagon *parent, int d) override { auto p = coords[parent]; auto q = p * current_ns().movevectors[d]; for(int a=0; a<3; a++) q[a] = zgmod(q[a], nilperiod[a]); auto child = get_at(q); parent->c.connect(d, child, (d + S7/2) % S7, false); return child; } transmatrix adj(heptagon *h, int i) override { return adjmatrix(i); } virtual transmatrix relative_matrix(heptagon *h2, heptagon *h1, const hyperpoint& hint) override { for(int a=0; amove(a)) return adjmatrix(a); auto p = coords[h1].inverse() * coords[h2]; for(int a=0; a<3; a++) p[a] = szgmod(p[a], nilperiod[a]); return nisot::translate(mvec_to_point(p)); } void draw() override { dq::visited_by_matrix.clear(); dq::enqueue_by_matrix(centerover->master, cview()); while(!dq::drawqueue.empty()) { auto& p = dq::drawqueue.front(); heptagon *h = get<0>(p); transmatrix V = get<1>(p); dq::drawqueue.pop(); cell *c = h->c7; if(!do_draw(c, V)) continue; drawcell(c, V); if(in_wallopt() && isWall3(c) && isize(dq::drawqueue) > 1000) continue; if(0) for(int t=0; ttype; t++) { if(!c->move(t)) continue; dynamicval g(poly_outline, darkena((0x142968*t) & 0xFFFFFF, 0, 255) ); queuepoly(V, cgi.shWireframe3D[t], 0); } for(int i=0; icmove(i); dq::enqueue_by_matrix(h1, V * adjmatrix(i)); } } } }; EX mvec get_coord(heptagon *h) { return ((hrmap_nil*)currentmap)->coords[h]; } EX heptagon *get_heptagon_at(mvec m) { return ((hrmap_nil*)currentmap)->get_at(m); } EX void set_flags() { int coords = 0; for(int a=0; a<3; a++) if(nilperiod[a]) coords++; set_flag(ginf[gNil].flags, qANYQ, coords); set_flag(ginf[gNil].flags, qBOUNDED, coords == 3); set_flag(ginf[gNil].flags, qSMALL, coords == 3 && nilperiod[0] * nilperiod[1] * nilperiod[2] <= 4096); } EX hyperpoint on_geodesic(hyperpoint s0, hyperpoint s1, ld x) { hyperpoint local = inverse(nisot::translate(s0)) * s1; hyperpoint h = get_inverse_exp(local); return nisot::translate(s0) * formula_exp(h * x); } EX color_t colorize(cell *c, char whichCanvas) { mvec at = ((hrmap_nil*)currentmap)->coords[c->master]; color_t res = 0; auto setres = [&] (int z, color_t which) { if(zgmod(at[2] - z, nilperiod[2]) == 0) res = which; if(zgmod(at[2] - z-1, nilperiod[2]) == 0) res = which; }; if(at[1] == 0 && at[0] >=0 && at[0] < 4) setres(-at[0], gradient(0x1FF0000, 0x10000FF, 0, at[0], 4)); else if(at[0] == 4 && at[1] >= 0 && at[1] < 4) setres(at[1]*3-4, gradient(0x10000FF, 0x100FF00, 0, at[1], 4)); else if(at[1] == 4 && at[0] >= 0 && at[0] <= 4) setres(4+at[0], gradient(0x100FF00, 0x1FFFF00, 4, at[0], 0)); else if(at[0] == 0 && at[1] >= 0 && at[1] <= 4) setres(at[1], gradient(0x1FFFF00, 0x1FF0000, 4, at[1], 0)); return res; } EX void prepare_niltorus3() { nilperiod_edit = nilperiod; S7_edit = ginf[gNil].sides; } EX void show_niltorus3() { cmode = sm::SIDE | sm::MAYDARK; gamescreen(1); dialog::init(XLAT("Nil quotient spaces")); for(int a=0; a<3; a++) { string title = XLAT("%1 period", s0+char('X'+a)); dialog::addSelItem(title, its(nilperiod_edit[a]), 'x'); dialog::add_action([=] { dialog::editNumber(nilperiod_edit[a], 0, 60, 1, 0, title, XLAT("Set to 0 to make it non-periodic.") ); dialog::bound_low(0); }); } dialog::addSelItem(XLAT("honeycomb"), its(S7_edit), 'h'); dialog::add_action([] { S7_edit = S7_edit ^ 6 ^ 8; }); bool ok = (!nilperiod_edit[1]) || (nilperiod_edit[2] && nilperiod_edit[1] % nilperiod_edit[2] == 0); dialog::addBreak(50); if(ok) { dialog::addItem(XLAT("activate"), 'a'); dialog::add_action([] { stop_game(); nilperiod = nilperiod_edit; ginf[gNil].sides = S7_edit; set_flags(); geometry = gNil; start_game(); }); } else dialog::addInfo(XLAT("Y period must be divisible by Z period")); dialog::addBreak(50); dialog::addBack(); dialog::display(); } EX } EX bool in_s2xe() { return prod && hybrid::under_class() == gcSphere; } EX bool in_h2xe() { return prod && hybrid::under_class() == gcHyperbolic; } EX bool in_e2xe() { return prod && hybrid::under_class() == gcEuclid; } EX namespace hybrid { EX eGeometry underlying; EX geometry_information *underlying_cgip; EX eGeometryClass under_class() { return ginf[hybrid::underlying].cclass; } EX void configure(eGeometry g) { if(WDIM == 3) return; ray::reset_raycaster(); check_cgi(); cgi.require_basics(); underlying = geometry; underlying_cgip = cgip; bool sph = sphere; auto keep = ginf[g].menu_displayed_name; ginf[g] = ginf[underlying]; ginf[g].menu_displayed_name = keep; if(g == gRotSpace) { ginf[g].g = sph ? giSphere3 : giSL2; ginf[g].tiling_name = "Iso(" + ginf[g].tiling_name + ")"; string& qn = ginf[g].quotient_name; string qplus = sph ? "elliptic" : qn; if(qn == "none" || qn == "elliptic") qn = qplus; else qn = qn + "/" + qplus; if(sph) ginf[g].flags |= qELLIPTIC; } else { ginf[g].cclass = g == gRotSpace ? gcSL2 : gcProduct; ginf[g].g.gameplay_dimension++; ginf[g].g.graphical_dimension++; ginf[g].tiling_name += "xZ"; if(product::csteps) ginf[g].flags |= qANYQ, ginf[g].tiling_name += its(product::csteps); } ginf[g].flags |= qHYBRID; } EX void reconfigure() { if(!hybri) return; stop_game(); auto g = geometry; geometry = underlying; configure(g); geometry = g; } EX hrmap *pmap; EX geometry_information *pcgip; EX eGeometry actual_geometry; template auto in_actual(const T& t) -> decltype(t()) { dynamicval g(geometry, actual_geometry); dynamicval gc(cgip, pcgip); dynamicval gu(currentmap, pmap); dynamicval gup(pmap, NULL); return t(); } struct hrmap_hybrid : hrmap { hrmap *underlying_map; bool twisted; map> spins; map, cell*> at; map> where; heptagon *getOrigin() override { return underlying_map->getOrigin(); } template auto in_underlying(const T& t) -> decltype(t()) { pcgip = cgip; dynamicval gpm(pmap, this); dynamicval gag(actual_geometry, geometry); dynamicval g(geometry, underlying); dynamicval gc(cgip, underlying_cgip); dynamicval gu(currentmap, underlying_map); return t(); } cell *getCell(cell *u, int h) { if(twisted) { if(!spins.count(u)) println(hlog, "link missing: ", u); else { while(h >= cgi.steps) h -= cgi.steps, u = spins[u].first.at; while(h < 0) h += cgi.steps, u = spins[u].second.at; } } h = zgmod(h, cgi.steps); cell*& c = at[make_pair(u, h)]; if(!c) { c = newCell(u->type+2, u->master); where[c] = {u, h}; } return c; } cell* gamestart() override { return getCell(underlying_map->gamestart(), 0); } hrmap_hybrid() { twisted = false; in_underlying([this] { initcells(); underlying_map = currentmap; }); for(hrmap*& m: allmaps) if(m == underlying_map) m = NULL; } ~hrmap_hybrid() { in_underlying([] { delete currentmap; }); for(auto& p: at) destroy_cell(p.second); } virtual transmatrix spin_to(cell *c, int d, ld bonus) override { if(d >= c->type-2) return Id; c = get_where(c).first; return in_underlying([&] { return currentmap->spin_to(c, d, bonus); }); } virtual transmatrix spin_from(cell *c, int d, ld bonus) override { if(d >= c->type-2) return Id; c = get_where(c).first; return in_underlying([&] { return currentmap->spin_from(c, d, bonus); }); } void draw() override { cell* start = centerover; dq::visited_by_matrix.clear(); dq::enqueue_by_matrix_c(start, cview()); while(!dq::drawqueue_c.empty()) { auto& p = dq::drawqueue_c.front(); cell *c = get<0>(p); transmatrix V = get<1>(p); dq::drawqueue_c.pop(); if(!do_draw(c, V)) continue; drawcell(c, V); if(in_wallopt() && isWall3(c) && isize(dq::drawqueue) > 1000) continue; for(int i=0; itype; i++) { cell *c1 = c->cmove(i); dq::enqueue_by_matrix_c(c1, V * adj(c, i)); } } } }; hrmap_hybrid* hmap() { return (hrmap_hybrid*) currentmap; } EX cell *get_at(cell *base, int level) { return hmap()->getCell(base, level); } EX pair get_where(cell *c) { return hmap()->where[c]; } EX void find_cell_connection(cell *c, int d) { auto m = hmap(); if(d >= c->type - 2) { int s = cgi.single_step; cell *c1 = get_at(m->where[c].first, m->where[c].second + (d == c->type-1 ? s : -s)); c->c.connect(d, c1, c1->type - 3 + c->type - d, false); } else { auto cu = m->where[c].first; auto cu1 = m->in_underlying([&] { return cu->cmove(d); }); int d1 = cu->c.spin(d); int s = (geometry == gRotSpace && cgi.steps) ? d*cgi.steps / cu->type - d1*cgi.steps / cu1->type + cgi.steps/2 : 0; cell *c1 = get_at(cu1, m->where[c].second + s); c->c.connect(d, c1, d1, cu->c.mirror(d)); } } EX hrmap* get_umap() { if(!dynamic_cast(currentmap)) return nullptr; else return ((hrmap_hybrid*)currentmap)->underlying_map; } #if HDR template auto in_underlying_geometry(const T& f) -> decltype(f()) { if(!hybri) return f(); dynamicval g(geometry, underlying); dynamicval gag(actual_geometry, geometry); dynamicval gc(cgip, underlying_cgip); dynamicval gpm(pmap, currentmap); dynamicval gm(currentmap, get_umap()); return f(); } #define PIU(x) hr::hybrid::in_underlying_geometry([&] { return (x); }) #endif EX hyperpoint get_corner(cell *c, int i, int next, ld z) { ld lev = cgi.plevel * z / 2; if(prod) { dynamicval g(geometry, hybrid::underlying); dynamicval gc(cgip, hybrid::underlying_cgip); dynamicval gm(currentmap, ((hrmap_hybrid*)currentmap)->underlying_map); return mscale(get_corner_position(c, i+next), exp(lev)); } else { ld tf, he, alpha; in_underlying_geometry([&] { hyperpoint h1 = get_corner_position(c, i); hyperpoint h2 = get_corner_position(c, i+1); hyperpoint hm = mid(h1, h2); tf = hdist0(hm)/2; he = hdist(hm, h2)/2; alpha = atan2(hm[1], hm[0]); }); return spin(alpha) * rots::uxpush(tf) * rots::uypush(next?he:-he) * rots::uzpush(lev) * C0; } } EX int wall_offset(cell *c) { int id = hybrid::underlying == gArchimedean ? arcm::id_of(c->master) + 20 * arcm::parent_index_of(c->master) : shvid(c); if(isize(cgi.walloffsets) <= id) cgi.walloffsets.resize(id+1, -1); int &wo = cgi.walloffsets[id]; if(wo == -1) { cell *c1 = hybrid::get_where(c).first; wo = isize(cgi.shWall3D); int won = wo + c->type; if(!cgi.wallstart.empty()) cgi.wallstart.pop_back(); cgi.reserve_wall3d(won); if(prod) for(int i=0; itype; i++) { hyperpoint w; ((hrmap_hybrid*)currentmap)->in_underlying([&] { /* mirror image of C0 in the axis h1-h2 */ hyperpoint h1 = get_corner_position(c1, i); hyperpoint h2 = get_corner_position(c1, i+1); transmatrix T = gpushxto0(h1); T = spintox(T * h2) * T; w = T * C0; w[1] = -w[1]; w = inverse(T) * w; }); cgi.walltester[wo + i] = w; } for(int i=0; itype; i++) cgi.make_wall(wo + i, {hybrid::get_corner(c1, i, 0, -1), hybrid::get_corner(c1, i, 0, +1), hybrid::get_corner(c1, i, 1, +1), hybrid::get_corner(c1, i, 1, -1)}); for(int a: {0,1}) { vector l; int z = a ? 1 : -1; hyperpoint ctr = zpush0(z * cgi.plevel/2); for(int i=0; itype; i++) if(prod) l.push_back(hybrid::get_corner(c1, i, 0, z)); else { l.push_back(ctr); l.push_back(hybrid::get_corner(c1, i, 0, z)); l.push_back(hybrid::get_corner(c1, i+1, 1, z)); l.push_back(ctr); l.push_back(hybrid::get_corner(c1, i, 1, z)); l.push_back(hybrid::get_corner(c1, i, 0, z)); } if(a == 0) std::reverse(l.begin()+1, l.end()); cgi.make_wall(won-2+a, l); } cgi.wallstart.push_back(isize(cgi.raywall)); cgi.compute_cornerbonus(); cgi.extra_vertices(); } return wo; } vector to_link; EX void will_link(cell *c) { if(pmap && ((hrmap_hybrid*) pmap)->twisted) to_link.push_back(c); } EX bool in_link = false; EX void link() { if(in_link) return; dynamicval b(in_link, true); auto pm = (hrmap_hybrid*) pmap; if(!pm) return; auto& ss = pm->spins; int success = -1; while(success) { vector xlink = std::move(to_link); success = 0; for(cell *c: xlink) { bool success_here = ss.count(c); if(!success_here) forCellIdEx(c2, i, c) if(ss.count(c2)) { ss[c].first = ss[c2].first + c->c.spin(i) + wstep - i; ss[c].second = ss[c2].second + c->c.spin(i) + wstep - i; success++; success_here = true; break; } if(!success_here) to_link.push_back(c); } } } EX int celldistance(cell *c1, cell *c2) { if(sl2) { auto w1 = hybrid::get_where(c1), w2 = hybrid::get_where(c2); return PIU (hr::celldistance(w1.first, w2.first)); } else if(cgi.steps == 0) { auto w1 = hybrid::get_where(c1), w2 = hybrid::get_where(c2); return PIU (hr::celldistance(w1.first, w2.first)) + abs(w1.second - w2.second); } else { int s = 0; int a = 999999, b = -999999; auto c = c1; do { auto w1 = hybrid::get_where(c), w2 = hybrid::get_where(c2); if(w1.second == w2.second) { int d = PIU(hr::celldistance(w1.first, w2.first)); a = min(s+d, a); b = max(s-d, a); } c = c->cmove(c1->type-1); s++; } while(c != c1); return min(a, s-b); } } EX } EX namespace product { int z0; struct hrmap_product : hybrid::hrmap_hybrid { transmatrix relative_matrix(cell *c2, cell *c1, const hyperpoint& hint) override { return in_underlying([&] { return calc_relative_matrix(where[c2].first, where[c1].first, hint); }) * mscale(Id, cgi.plevel * szgmod(where[c2].second - where[c1].second, csteps)); } transmatrix adj(cell *c, int i) override { if(twisted && i == c->type-1 && where[c].second == cgi.steps-1) { auto b = spins[where[c].first].first; transmatrix T = mscale(Id, cgi.plevel); T = T * spin(2 * M_PI * b.spin / b.at->type); if(b.mirrored) T = T * Mirror; return T; } if(twisted && i == c->type-2 && where[c].second == 0) { auto b = spins[where[c].first].second; transmatrix T = mscale(Id, -cgi.plevel); T = T * spin(2 * M_PI * b.spin / b.at->type); if(b.mirrored) T = T * Mirror; return T; } if(i == c->type-1) return mscale(Id, cgi.plevel); else if(i == c->type-2) return mscale(Id, -cgi.plevel); c = where[c].first; return PIU(currentmap->adj(c, i)); } hrmap_product() { current_spin_invalid = false; if((cspin || cmirror) && csteps) { in_underlying([&] { twisted = validate_spin(); if(!twisted) { current_spin_invalid = true; return; } auto ugs = currentmap->gamestart(); spins[ugs] = make_pair( cellwalker(ugs, gmod(+cspin, ugs->type), cmirror), cellwalker(ugs, gmod(-cspin, ugs->type), cmirror) ); manual_celllister cl; cl.add(ugs); for(int i=0; i cws; manual_celllister cl; cell *start = currentmap->gamestart(); cl.add(start); cws[start] = cellwalker(start, gmod(cspin, start->type), cmirror); for(int i=0; ic.spin(j); if(!cws.count(c2)) cws[c2] = cwc2; else if(cws[c2] != cwc2) return false; cl.add(c2); } } return true; } EX void show_config() { cmode = sm::SIDE | sm::MAYDARK; gamescreen(1); dialog::init(XLAT("quotient product spaces")); dialog::addSelItem(XLAT("%1 period", "Z"), its(product::csteps), 'z'); dialog::add_action([] { static int s; s = product::csteps; dialog::editNumber(s, 0, 16, 1, 0, XLAT("%1 period", "Z"), XLAT("Set to 0 to make it non-periodic.")); dialog::bound_low(0); dialog::reaction_final = [] { product::csteps = s; if(product::csteps == cgi.steps) return; hybrid::reconfigure(); start_game(); println(hlog, "csteps = ", cgi.steps); }; }); dialog::addSelItem(XLAT("rotation"), its(product::cspin), 'r'); dialog::add_action([] { static int s; dialog::editNumber(s, 0, 16, 1, 0, XLAT("rotation", "Z"), XLAT("Works if the underlying space is symmetric.") ); dialog::reaction_final = [] { if(s == product::cspin) return; stop_game(); product::cspin = s; start_game(); }; }); dialog::addBoolItem(XLAT("reflect"), product::cmirror, 'f'); dialog::add_action([]{ stop_game(); product::cmirror = !product::cmirror; start_game(); }); if(current_spin_invalid) dialog::addInfo("the current rotation is invalid"); else dialog::addBreak(100); dialog::addBreak(50); dialog::addBack(); dialog::display(); } EX } EX namespace slr { /* This implementation is based on: // https://pdfs.semanticscholar.org/bf46/824df892593a1b6d1c84a5f99e90eece7c54.pdf // However, to make it consistent with the conventions in HyperRogue, // coordinates 0<->2 and 1<->3 are swapped, // then coordinates 2<->3 are swapped */ EX ld range_xy = 2; EX int steps = 15; EX hyperpoint from_phigans(hyperpoint h) { ld r = asinh(hypot_d(2, h)); ld x = h[0]; ld y = h[1]; ld z = h[2]; return hyperpoint(x * cos(z) + y * sin(z), y * cos(z) - x * sin(z), cosh(r) * sin(z), cosh(r) * cos(z)); } EX hyperpoint to_phigans(hyperpoint h) { ld z = atan2(h[2], h[3]); ld x = h[0]; ld y = h[1]; return point31(x * cos(z) - y * sin(z), y * cos(z) + x * sin(z), z); } /** in the 'phigans' model */ hyperpoint christoffel(const hyperpoint Position, const hyperpoint Velocity, const hyperpoint Transported) { ld x = Position[0]; ld y = Position[1]; ld s = x*x + y*y + 1; ld x2 = x * x; ld y2 = y * y; ld x4 = x2 * x2; ld y4 = y2 * y2; return point3( + Velocity[ 0 ] * Transported[ 0 ] * (x*(4*x2*y2 + 4*y4 + 9*y2 + 1)) + Velocity[ 0 ] * Transported[ 1 ] * (-y*(4*x4 + 4*x2*y2 + 9*x2 + 2)) + Velocity[ 0 ] * Transported[ 2 ] * (-x*y*(x2 + y2 + 2)) + Velocity[ 1 ] * Transported[ 0 ] * (-y*(4*x4 + 4*x2*y2 + 9*x2 + 2)) + Velocity[ 1 ] * Transported[ 1 ] * (x*(4*x4 + 4*x2*y2 + 9*x2 + 5)) + Velocity[ 1 ] * Transported[ 2 ] * (x4 + x2*y2 + 2*x2 + 1) + Velocity[ 2 ] * Transported[ 0 ] * (-x*y*(x2 + y2 + 2)) + Velocity[ 2 ] * Transported[ 1 ] * (x4 + x2*y2 + 2*x2 + 1), + Velocity[ 0 ] * Transported[ 0 ] * (y*(4*x2*y2 + 4*y4 + 9*y2 + 5)) + Velocity[ 0 ] * Transported[ 1 ] * (-x*(4*x2*y2 + 4*y4 + 9*y2 + 2)) + Velocity[ 0 ] * Transported[ 2 ] * (-x2*y2 - y4 - 2*y2 - 1) + Velocity[ 1 ] * Transported[ 0 ] * (-x*(4*x2*y2 + 4*y4 + 9*y2 + 2)) + Velocity[ 1 ] * Transported[ 1 ] * (y*(4*x4 + 4*x2*y2 + 9*x2 + 1)) + Velocity[ 1 ] * Transported[ 2 ] * (x*y*(x2 + y2 + 2)) + Velocity[ 2 ] * Transported[ 0 ] * (-x2*y2 - y4 - 2*y2 - 1) + Velocity[ 2 ] * Transported[ 1 ] * (x*y*(x2 + y2 + 2)), + Velocity[ 0 ] * Transported[ 0 ] * (-4*x*y) + Velocity[ 0 ] * Transported[ 1 ] * (2*x2 - 2*y2) + Velocity[ 0 ] * Transported[ 2 ] * x + Velocity[ 1 ] * Transported[ 0 ] * (2*x2 - 2*y2) + Velocity[ 1 ] * Transported[ 1 ] * 4*x*y + Velocity[ 1 ] * Transported[ 2 ] * y + Velocity[ 2 ] * Transported[ 0 ] * x + Velocity[ 2 ] * Transported[ 1 ] * y ) / s; } EX transmatrix translate(hyperpoint h) { return matrix4( h[3], -h[2], h[1], h[0], h[2], h[3], -h[0], h[1], h[1], -h[0], h[3], h[2], h[0], h[1], -h[2], h[3] ); } EX hyperpoint polar(ld r, ld theta, ld phi) { return hyperpoint(sinh(r) * cos(theta-phi), sinh(r) * sin(theta-phi), cosh(r) * sin(phi), cosh(r) * cos(phi)); } EX hyperpoint xyz_point(ld x, ld y, ld z) { ld r = hypot(x, y); ld f = r ? sinh(r) / r : 1; return hyperpoint(x * f * cos(z) + y * f * sin(z), y * f * cos(z) - x * f * sin(z), cosh(r) * sin(z), cosh(r) * cos(z)); } ld rootsin(ld square, ld s) { if(square > 0) return sinh(sqrt(square) * s) / sqrt(square); else if(square < 0) return sin(sqrt(-square) * s) / sqrt(-square); else return s; } /** it==0 is standard asin, it==1 is the next solution (PI-asin) */ ld asin_it(ld z, int it) { auto ans = asin(z); if(it & 1) ans = M_PI - ans; return ans; } ld arootsin(ld square, ld v, int it) { if(square > 0) return asinh(v * sqrt(square)) / sqrt(square); else if(square < 0) return asin_it(v * sqrt(-square), it) / sqrt(-square); else return v; } ld roottan(ld square, ld s) { if(square > 0) return tanh(sqrt(square) * s) / sqrt(square); else if(square < 0) return tan(sqrt(-square) * s) / sqrt(-square); else return s; } hyperpoint geodesic_polar(ld alpha, ld beta, ld s) { auto c = cos(2*alpha); ld t; if(c > 0) t = atan(sin(alpha) * tanh(sqrt(c) * s) / sqrt(c)); else if(c < 0) { /* the formula in the paper is roughly atan(k*tan(s)) * however, atan is not always to be taken in [-PI/2,PI/2]: * if s is in [kPI-PI/2, kPI+PI/2], we should also increase the result by kPI */ ld x = sqrt(-c) * s; ld steps = floor(x/M_PI + 0.5); t = atan(sin(alpha) * tan(sqrt(-c) * s) / sqrt(-c)) + M_PI * steps; } else t = atan(sin(alpha) * s); return polar( asinh(cos(alpha) * rootsin(c, s)), beta - t, 2*sin(alpha)*s - t ); } EX hyperpoint formula_exp(hyperpoint h) { ld s = hypot_d(3, h); ld beta = atan2(h[1], h[0]); ld alpha = asin(h[2] / s); return geodesic_polar(alpha, beta, s); } void find_alpha(ld phi, ld r, ld theta, ld &alpha, ld &s, ld &beta) { if(phi < 0) { find_alpha(-phi, r, -theta, alpha, s, beta); alpha = -alpha; beta = -beta; return; } ld mina = 0, maxa = M_PI/2; bool next_nan = true; ld c; for(int it=0; it<40; it++) { alpha = (mina + maxa) / 2; c = cos(2 * alpha); s = arootsin(c, sinh(r) / cos(alpha), 0); if(isnan(s)) { next_nan = true, maxa = alpha; continue; } ld got_phi = 2*sin(alpha)*s - atan(sin(alpha) * roottan(c, s)); if(got_phi > phi) next_nan = false, maxa = alpha; else mina = alpha; } if(next_nan) { mina = M_PI/4; for(int it=0; it<40; it++) { alpha = (mina + maxa) / 2; c = cos(2 * alpha); s = arootsin(c, sinh(r) / cos(alpha), 1); ld got_phi = 2*sin(alpha)*s - atan(sin(alpha) * roottan(c, s)) - M_PI; if(got_phi < phi) maxa = alpha; else mina = alpha; } beta = theta + atan(sin(alpha) * roottan(c, s)) + M_PI; } else beta = theta + atan(sin(alpha) * roottan(c, s)); } EX hyperpoint get_inverse_exp(hyperpoint h, ld index IS(0)) { if(sqhypot_d(2, h) < 1e-12) return point3(0, 0, atan2(h[2], h[3]) + index); ld r = asinh(hypot_d(2, h)); ld phi = atan2(h[2], h[3]) + index; ld theta = atan2(h[1], h[0]) + phi + index; ld alpha, s, beta; find_alpha(phi, r, theta, alpha, s, beta); return point3(s * cos(beta) * cos(alpha), s * sin(beta) * cos(alpha), s * sin(alpha)); } EX string slshader = "uniform mediump float uIndexSL;" "uniform mediump int uIterations;" "vec4 inverse_exp(vec4 h) {" "if(h[0]*h[0] + h[1] * h[1] < 1e-6) return vec4(0, 0, atan2(h[2], h[3]) + uIndexSL, 1);" "float r = asinh(sqrt(h[0] * h[0] + h[1] * h[1]));" "float phi = atan2(h[2], h[3]) + uIndexSL;" "float theta = atan2(h[1], h[0]) + phi + uIndexSL;" "float alpha;" "float s;" "float beta;" "float sgn = 1.;" "float bound = .999;" "if(phi < 0.) { phi = -phi; theta = -theta; sgn = -1.; }" "float c;" "s = sinh(r) / cos(PI/4.);" "float gphi = 2.*sin(PI/4.)*s - atan(sin(PI/4.) * s);" "float lo_gphi = gphi;" "float lo_s = s;" "float lo_alpha = PI/4.;" "float lx_gphi = gphi;" "float lx_s = s;" "float lx_alpha = PI/4.;" "float hi_gphi = gphi;" "float hi_s = s;" "float hi_alpha = PI/4.;" "if(gphi > phi) {" " float mina = 0.;" " float maxa = PI/4.;" " lo_gphi = 0.; lo_s = r; lo_alpha = 0.;" #if ISWEB " for(int it=0; it<50; it++) { if(it >= uIterations) break; " #else " for(int it=0; it phi) { maxa = alpha; hi_alpha = alpha; hi_s = s; hi_gphi = gphi; }" " else { mina = alpha; lo_alpha = alpha; lo_s = s; lo_gphi = gphi; }" " }" " }" "else {" " hi_gphi = phi; hi_s = phi; hi_alpha = 9.;" " int next_nan = 1;" " float mina = PI/4.;" " float maxa = PI/2.;" #if ISWEB " for(int it=0; it<50; it++) { if(it >= uIterations) break; " #else " for(int it=0; it bound * cos(alpha)) { next_nan = 1; maxa = alpha; continue; }" " s = asin(sinh(r) * c / cos(alpha)) / c;" " gphi = 2.*sin(alpha)*s - atan(sin(alpha) * tan(c*s) / c);" " if(gphi > phi) { next_nan = 0; maxa = alpha; hi_gphi = gphi; hi_s = s; hi_alpha = alpha; }" " else { mina = alpha; lx_gphi = lo_gphi; lx_s = lo_s; lx_alpha = lo_alpha; lo_gphi = gphi; lo_s = s; lo_alpha = alpha; }" " }" " if(next_nan != 0) {" " mina = PI/4.; " #if ISWEB " for(int it=0; it<50; it++) { if(it >= uIterations) break; " #else " for(int it=0; itbound) { maxa = alpha; next_nan = 1; continue; }" " float s1 = PI - asin(z);" " s = s1 / c;" " gphi = 2.*sin(alpha)*s - atan(sin(alpha) * tan(s1) / c) - PI;" " if(gphi < phi) { next_nan = 0; maxa = alpha; hi_gphi = gphi; hi_s = s; hi_alpha = alpha; }" " else { mina = alpha; lo_gphi = gphi; lo_s = s; lo_alpha = alpha; }" " }" " }" " }" "if(hi_alpha <= 9.) { hi_gphi = lx_gphi; hi_s = lx_s; hi_alpha = lx_alpha; } " "float fr = (phi-lo_gphi) / (hi_gphi-lo_gphi);" "alpha = lo_alpha + (hi_alpha-lo_alpha) * fr;" "s = lo_s + (hi_s-lo_s) * fr;" "beta = theta - phi + 2.*sin(alpha)*s;" "alpha = alpha * sgn; beta = beta * sgn;" "return vec4(s * cos(beta) * cos(alpha), s * sin(beta) * cos(alpha), s * sin(alpha), 1.);" "}"; EX } EX namespace rots { EX transmatrix uxpush(ld x) { if(sl2) return xpush(x); return cspin(1, 3, x) * cspin(0, 2, x); } EX transmatrix uypush(ld y) { if(sl2) return ypush(y); return cspin(0, 3, -y) * cspin(1, 2, y); } EX transmatrix uzpush(ld z) { if(sl2) return zpush(z); return cspin(3, 2, -z) * cspin(0, 1, -z); } EX transmatrix lift_matrix(const transmatrix& T) { hyperpoint d; ld alpha, beta, distance; transmatrix Spin; hybrid::in_underlying_geometry([&] { hyperpoint h = tC0(T); Spin = inverse(gpushxto0(h) * T); d = hr::inverse_exp(h); alpha = atan2(Spin[0][1], Spin[0][0]); distance = hdist0(h); beta = atan2(h[1], h[0]); }); for(int k=0; k<3; k++) Spin[3][k] = Spin[k][3] = 0; Spin[3][3] = 1; return spin(beta) * uxpush(distance/2) * spin(-beta+alpha); } struct hrmap_rotation_space : hybrid::hrmap_hybrid { std::unordered_map saved_matrices; transmatrix adj(cell *c1, int i) override { if(i == c1->type-2) return uzpush(-cgi.plevel) * spin(-2*cgi.plevel); if(i == c1->type-1) return uzpush(+cgi.plevel) * spin(+2*cgi.plevel); cell *c2 = c1->cmove(i); int id1 = hybrid::underlying == gArchimedean ? arcm::id_of(c1->master) + 20 * arcm::parent_index_of(c1->master) : shvid(c1); int id2 = hybrid::underlying == gArchimedean ? arcm::id_of(c2->master) + 20 * arcm::parent_index_of(c2->master) : shvid(c2); int j = c1->c.spin(i); int id = id1 + (id2 << 10) + (i << 20) + (j << 26); auto &M = saved_matrices[id]; if(M[3][3]) return M; cell *cw = where[c1].first; return M = lift_matrix(PIU(currentmap->adj(cw, i))); } virtual transmatrix relative_matrix(cell *c2, cell *c1, const hyperpoint& hint) override { if(c1 == c2) return Id; if(gmatrix0.count(c2) && gmatrix0.count(c1)) return inverse(gmatrix0[c1]) * gmatrix0[c2]; for(int i=0; itype; i++) if(c1->move(i) == c2) return adj(c1, i); return Id; // not implemented yet } }; /** reinterpret the given point of rotspace as a rotation matrix in the underlying geometry */ EX transmatrix qtm(hyperpoint h) { ld& x = h[0]; ld& y = h[1]; ld& z = h[2]; ld& w = h[3]; ld xx = x*x; ld yy = y*y; ld zz = z*z; ld ww = w*w; ld xy = x*y; ld xz = x*z; ld xw = x*w; ld yz = y*z; ld yw = y*w; ld zw = z*w; transmatrix M; M[0][0] = +xx - yy - zz + ww; M[1][1] = -xx + yy - zz + ww; M[2][2] = -xx - yy + zz + ww; M[0][1] = -2 * (xy + zw); M[1][0] = -2 * (xy - zw); M[0][2] = 2 * (xz - yw); M[2][0] = 2 * (xz + yw); M[1][2] = -2 * (yz + xw); M[2][1] = -2 * (yz - xw); return M; } EX ld underlying_scale = 0; EX void draw_underlying(bool cornermode) { if(underlying_scale <= 0) return; ld d = hybrid::get_where(centerover).second; d *= cgi.plevel; transmatrix T = rots::uzpush(-d) * spin(-2*d); if(det(T) < 0) T = centralsym * T; hyperpoint h = inverse(View * spin(master_to_c7_angle()) * T) * C0; auto g = std::move(gmatrix); auto g0 = std::move(gmatrix0); ld alpha = atan2(inverse(NLP) * point3(1, 0, 0)); bool inprod = prod; transmatrix pView = View; if(inprod) { pView = spin(alpha) * View; ld z = zlevel(tC0(View)); for(int a=0; a<3; a++) pView[a] *= exp(-z); } cell *co = hybrid::get_where(centerover).first; hybrid::in_underlying_geometry([&] { cgi.require_shapes(); dynamicval pcc(corner_centering, cornermode ? 1 : 2); dynamicval pf(playerfound, true); dynamicval m5(centerover, co); dynamicval m2(View, inprod ? pView : ypush(0) * qtm(h)); dynamicval m3(playerV, Id); dynamicval m4(actual_view_transform, Id); dynamicval pm(pmodel, mdDisk); dynamicval pss(vid.scale, (sphere ? 10 : 1) * underlying_scale); dynamicval psa(vid.alpha, sphere ? 10 : 1); dynamicval p(hybrid::pmap, NULL); dynamicval psr(sightrange_bonus, 0); calcparam(); reset_projection(); current_display->set_all(0); ptds.clear(); drawthemap(); drawqueue(); displaychr(current_display->xcenter, current_display->ycenter, 0, 24, '+', 0xFFFFFFFF); glflush(); }); gmatrix = std::move(g); gmatrix0 = std::move(g0); calcparam(); reset_projection(); current_display->set_all(0); } EX } EX namespace nisot { EX hyperpoint christoffel(const hyperpoint at, const hyperpoint velocity, const hyperpoint transported) { if(nil) return nilv::christoffel(at, velocity, transported); #if CAP_SOLV else if(sn::in()) return sn::christoffel(at, velocity, transported); #endif else if(sl2) return slr::christoffel(at, velocity, transported); else return point3(0, 0, 0); } EX bool in_table_range(hyperpoint h) { #if CAP_SOLV if(sol) return sn::in_table_range(h); #endif return true; } EX hyperpoint get_acceleration(const hyperpoint& at, const hyperpoint& vel) { return christoffel(at, vel, vel); } EX void geodesic_step(hyperpoint& at, hyperpoint& vel) { /* RK4 method */ auto acc1 = get_acceleration(at, vel); auto acc2 = get_acceleration(at + vel/2, vel + acc1/2); auto acc3 = get_acceleration(at + vel/2 + acc1/4, vel + acc2/2); auto acc4 = get_acceleration(at + vel + acc2/2, vel + acc3); at += vel + (acc1+acc2+acc3)/6; vel += (acc1+2*acc2+2*acc3+acc4)/6; } EX int rk_steps = 20; EX hyperpoint numerical_exp(hyperpoint v) { hyperpoint at = point31(0, 0, 0); v /= rk_steps; v[3] = 0; for(int i=0; i g(geometry, gSphere); hr::fixmatrix(gtl); } T = push * gtl; } EX transmatrix parallel_transport(const transmatrix Position, const hyperpoint direction) { auto P = Position; nisot::fixmatrix(P); if(!geodesic_movement) return inverse(eupush(Position * translate(-direction) * inverse(Position) * C0)) * Position; return parallel_transport_bare(P, direction); } EX transmatrix spin_towards(const transmatrix Position, const hyperpoint goal, flagtype prec IS(pNORMAL)) { hyperpoint at = tC0(Position); transmatrix push_back = inverse(translate(at)); hyperpoint back_goal = push_back * goal; back_goal = inverse_exp(back_goal, prec); transmatrix back_Position = push_back * Position; return rspintox(inverse(back_Position) * back_goal); } EX hrmap *new_map() { #if CAP_SOLV if(sn::in()) return new sn::hrmap_solnih; #endif if(nil) return new nilv::hrmap_nil; if(prod) return new product::hrmap_product; if(hybri) return new rots::hrmap_rotation_space; return NULL; } #if CAP_COMMANDLINE auto config = addHook(hooks_args, 0, [] () { using namespace arg; #if CAP_SOLV if(argis("-solrange")) { shift_arg_formula(sn::solrange_xy); shift_arg_formula(sn::solrange_z); return 0; } #endif if(argis("-slrange")) { shift_arg_formula(slr::range_xy); return 0; } #if CAP_SOLV else if(argis("-fsol")) { shift(); sn::solt.fname = args(); return 0; } else if(argis("-nihsol")) { shift(); sn::niht.fname = args(); return 0; } #endif else if(argis("-solgeo")) { geodesic_movement = true; pmodel = mdGeodesic; return 0; } else if(argis("-solnogeo")) { geodesic_movement = false; pmodel = mdPerspective; return 0; } else if(argis("-product")) { PHASEFROM(2); set_geometry(gProduct); return 0; } else if(argis("-s2xe")) { PHASEFROM(2); shift(); s2xe::qrings = argi(); return 0; } else if(argis("-rotspace")) { PHASEFROM(2); set_geometry(gRotSpace); return 0; } else if(argis("-rot_uscale")) { PHASEFROM(2); shift_arg_formula(rots::underlying_scale); return 0; } else if(argis("-nilperiod")) { PHASEFROM(2); if(nil) stop_game(); for(int a=0; a<3; a++) { shift(); nilv::nilperiod[a] = argi(); } nilv::set_flags(); return 0; } else if(argis("-nilwidth")) { PHASEFROM(2); shift_arg_formula(nilv::nilwidth); return 0; } else if(argis("-rk-steps")) { PHASEFROM(2); shift(); rk_steps = argi(); return 0; } else if(argis("-nilv")) { PHASEFROM(2); if(nil) stop_game(); shift(); ginf[gNil].sides = argi(); return 0; } else if(argis("-catperiod")) { PHASEFROM(2); if(sol) stop_game(); shift(); asonov::period_xy = argi(); shift(); asonov::period_z = argi(); asonov::set_flags(); return 0; } else if(argis("-prodperiod")) { PHASEFROM(2); if(prod) stop_game(); shift(); product::csteps = argi(); hybrid::reconfigure(); return 0; } else if(argis("-prodturn")) { PHASEFROM(2); if(prod) stop_game(); shift(); product::cspin = argi(); shift(); product::cmirror = argi(); return 0; } return 1; }); #endif } }