mirror of
				https://github.com/zenorogue/hyperrogue.git
				synced 2025-10-25 19:07:40 +00:00 
			
		
		
		
	stretched spherical geometry
This commit is contained in:
		| @@ -1979,6 +1979,13 @@ EX void reverse_transparent_walls() { | ||||
| EX void draw_main() { | ||||
|   DEBBI(DF_GRAPH, ("draw_main")); | ||||
|   if(sphere && GDIM == 3 && pmodel == mdPerspective) { | ||||
|  | ||||
|     if(ray::in_use && !ray::comparison_mode) { | ||||
|       ray::cast(); | ||||
|       reset_projection(); | ||||
|       return; | ||||
|       } | ||||
|  | ||||
|     for(int p: {1, 0, 2, 3}) { | ||||
|       if(elliptic && p < 2) continue; | ||||
|       glhr::set_depthwrite(true); | ||||
|   | ||||
| @@ -2149,7 +2149,7 @@ EX void rotate_view(transmatrix T) { | ||||
|  | ||||
| /** shift the view according to the given tangent vector */ | ||||
| EX transmatrix get_shift_view_of(const hyperpoint H, const transmatrix V) { | ||||
|   if(!nonisotropic) { | ||||
|   if(!nonisotropic && !rots_twist::in()) { | ||||
|     return rgpushxto0(direct_exp(lp_iapply(H))) * V; | ||||
|     } | ||||
|   else if(!nisot::geodesic_movement) { | ||||
| @@ -2169,7 +2169,7 @@ EX void shift_view(hyperpoint H) { | ||||
|   auto oView = View; | ||||
|   View = get_shift_view_of(H, View); | ||||
|   auto& wc = current_display->which_copy; | ||||
|   if(nonisotropic) { | ||||
|   if(nonisotropic || rots_twist::in()) { | ||||
|     transmatrix ioldv = eupush(tC0(inverse(oView))); | ||||
|     transmatrix newv = inverse(eupush(tC0(inverse(View)))); | ||||
|     wc = newv * ioldv * wc; | ||||
|   | ||||
							
								
								
									
										136
									
								
								nonisotropic.cpp
									
									
									
									
									
								
							
							
						
						
									
										136
									
								
								nonisotropic.cpp
									
									
									
									
									
								
							| @@ -1081,6 +1081,7 @@ EX namespace hybrid { | ||||
|         }); | ||||
|       return T; | ||||
|       } | ||||
|     if(rotspace) return inverse(rots::ray_adj(c, i)); | ||||
|     return currentmap->iadj(c, i); | ||||
|     } | ||||
|    | ||||
| @@ -1838,6 +1839,8 @@ EX } | ||||
|  | ||||
| EX namespace rots { | ||||
|  | ||||
|   EX ld stretch_factor; | ||||
|    | ||||
|   EX transmatrix uxpush(ld x) {  | ||||
|     if(sl2) return xpush(x); | ||||
|     return cspin(1, 3, x) * cspin(0, 2, x); | ||||
| @@ -1869,6 +1872,34 @@ EX namespace rots { | ||||
|     return spin(beta) * uxpush(distance/2) * spin(-beta+alpha); | ||||
|     } | ||||
|    | ||||
|   std::unordered_map<int, transmatrix> saved_matrices_ray; | ||||
|  | ||||
|   EX transmatrix ray_adj(cell *c1, int i) { | ||||
|     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_ray[id]; | ||||
|     if(M[3][3]) return M; | ||||
|      | ||||
|     cell *cw = hybrid::get_where(c1).first; | ||||
|      | ||||
|     transmatrix T; | ||||
|     hybrid::in_underlying_geometry([&] { | ||||
|       hyperpoint h0 = get_corner_position(cw, i); | ||||
|       hyperpoint h1 = get_corner_position(cw, (i+1)); | ||||
|       hyperpoint hm = mid(h0, h1); | ||||
|       ld d = hdist0(hm); | ||||
|       d *= 2; | ||||
|       T = rspintox(hm) * xpush(d); | ||||
|       }); | ||||
|  | ||||
|     return M = lift_matrix(T); | ||||
|     } | ||||
|  | ||||
|   struct hrmap_rotation_space : hybrid::hrmap_hybrid { | ||||
|  | ||||
|     std::unordered_map<int, transmatrix> saved_matrices; | ||||
| @@ -1968,6 +1999,7 @@ EX namespace rots { | ||||
|       dynamicval<bool> pf(playerfound, true); | ||||
|       dynamicval<cell*> m5(centerover, co); | ||||
|       dynamicval<transmatrix> m2(View, inprod ? pView : ypush(0) * qtm(h)); | ||||
|       if(PURE) View = View * pispin; | ||||
|       dynamicval<transmatrix> m3(playerV, Id); | ||||
|       dynamicval<transmatrix> m4(actual_view_transform, Id); | ||||
|       dynamicval<eModel> pm(pmodel, mdDisk); | ||||
| @@ -1991,6 +2023,64 @@ EX namespace rots { | ||||
|  | ||||
| EX } | ||||
|  | ||||
| /** twisted S2xE */ | ||||
| EX namespace rots_twist { | ||||
|  | ||||
|   EX bool applicable() { | ||||
|     return among(geometry, gCell120, gECell120, gCell24, gECell24, gCell8, gECell8); | ||||
|     } | ||||
|  | ||||
|   EX bool in() { return rots::stretch_factor && sphere && (rotspace || applicable()); } | ||||
|  | ||||
|   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 transmatrix itranslate(hyperpoint h) { | ||||
|     h[0] = -h[0]; | ||||
|     h[1] = -h[1]; | ||||
|     h[2] = -h[2]; | ||||
|     return translate(h); | ||||
|     } | ||||
|  | ||||
|   hyperpoint mulz(const hyperpoint at, const hyperpoint velocity, ld factor) { | ||||
|     auto vel = itranslate(at) * velocity; | ||||
|     vel[2] *= factor; | ||||
|     return translate(at) * vel; | ||||
|     } | ||||
|    | ||||
|   hyperpoint isometric_to_actual(const hyperpoint at, const hyperpoint velocity) { | ||||
|     return mulz(at, velocity, 1/sqrt(1+rots::stretch_factor)); | ||||
|     } | ||||
|    | ||||
|   hyperpoint actual_to_isometric(const hyperpoint at, const hyperpoint velocity) { | ||||
|     return mulz(at, velocity, sqrt(1+rots::stretch_factor)); | ||||
|     } | ||||
|    | ||||
|   hyperpoint christoffel(const hyperpoint at, const hyperpoint velocity, const hyperpoint transported) { | ||||
|    | ||||
|     auto vel = itranslate(at) * velocity; | ||||
|     auto tra = itranslate(at) * transported;   | ||||
|      | ||||
|     hyperpoint c; | ||||
|      | ||||
|     auto K = rots::stretch_factor; | ||||
|      | ||||
|     c[0] = -K * (vel[1] * tra[2] + vel[2] * tra[1]); | ||||
|     c[1] =  K * (vel[0] * tra[2] + vel[2] * tra[0]); | ||||
|     c[2] = 0; | ||||
|     c[3] = 0; | ||||
|      | ||||
|     return translate(at) * c; | ||||
|     }   | ||||
|    | ||||
| EX } | ||||
|  | ||||
| EX namespace nisot { | ||||
|  | ||||
|   EX hyperpoint christoffel(const hyperpoint at, const hyperpoint velocity, const hyperpoint transported) { | ||||
| @@ -1999,6 +2089,7 @@ EX namespace nisot { | ||||
|     else if(sn::in()) return sn::christoffel(at, velocity, transported); | ||||
|     #endif | ||||
|     else if(sl2) return slr::christoffel(at, velocity, transported); | ||||
|     else if(rots_twist::in()) return rots_twist::christoffel(at, velocity, transported); | ||||
|     else return point3(0, 0, 0); | ||||
|     } | ||||
|  | ||||
| @@ -2036,7 +2127,9 @@ EX namespace nisot { | ||||
|  | ||||
|   EX transmatrix parallel_transport_bare(transmatrix Pos, hyperpoint h) { | ||||
|    | ||||
|     h[3] = 0; | ||||
|     bool stretch = rots_twist::in(); | ||||
|      | ||||
|     if(!stretch) h[3] = 0; | ||||
|    | ||||
|     auto tPos = transpose(Pos); | ||||
|      | ||||
| @@ -2057,6 +2150,18 @@ EX namespace nisot { | ||||
|     auto& at = tPos[3]; | ||||
|     auto& vel = h; | ||||
|      | ||||
|     array<ld, 4> ms; | ||||
|  | ||||
|     if(stretch) { | ||||
|       for(int i=0; i<3; i++) { | ||||
|         ms[i] = sqhypot_d(4, tPos[i]); | ||||
|         tPos[i] = rots_twist::isometric_to_actual(at, tPos[i]); | ||||
|         } | ||||
|       ms[3] = sqhypot_d(4, vel); | ||||
|       if(!ms[3]) return Pos; | ||||
|       vel = rots_twist::isometric_to_actual(at, vel); | ||||
|       } | ||||
|  | ||||
|     for(int i=0; i<steps; i++) { | ||||
|       auto acc1 = get_acceleration(at, vel); | ||||
|       auto at1 = at + vel/2; auto vel1 = vel + acc1/2; | ||||
| @@ -2079,6 +2184,29 @@ EX namespace nisot { | ||||
|  | ||||
|       at += vel + (acc1+acc2+acc3)/6; | ||||
|       vel += (acc1+2*acc2+2*acc3+acc4)/6; | ||||
|        | ||||
|       if(stretch) { | ||||
|         at = normalize(at); | ||||
|          | ||||
|         auto fix = [&] (hyperpoint& h, ld& m) { | ||||
|           h = rots_twist::itranslate(at) * h; | ||||
|           h[3] = 0; | ||||
|           ld m1 = h[0] * h[0] + h[1] * h[1] + h[2] * h[2] * (1+rots::stretch_factor); | ||||
|           h /= sqrt(m1/m); | ||||
|           h = rots_twist::translate(at) * h; | ||||
|           }; | ||||
|  | ||||
|         if(i == 0) println(hlog, vel); | ||||
|         fix(vel, ms[3]);  | ||||
|         if(i == 0) println(hlog, vel); | ||||
|         for(int i=0; i<3; i++) fix(tPos[i], ms[i]); | ||||
|         } | ||||
|  | ||||
|       } | ||||
|  | ||||
|     if(stretch) { | ||||
|       vel = rots_twist::actual_to_isometric(at, vel); | ||||
|       for(int i=0; i<3; i++) tPos[i] = rots_twist::actual_to_isometric(at, tPos[i]); | ||||
|       } | ||||
|                                                                                    | ||||
|     if(sl2) { | ||||
| @@ -2092,6 +2220,7 @@ EX namespace nisot { | ||||
|     } | ||||
|  | ||||
|   EX void fixmatrix(transmatrix& T) { | ||||
|     if(sphere) return hr::fixmatrix(T); | ||||
|     transmatrix push = eupush( tC0(T) ); | ||||
|     transmatrix push_back = inverse(push); | ||||
|     transmatrix gtl = push_back * T; | ||||
| @@ -2221,6 +2350,11 @@ EX namespace nisot { | ||||
|       hybrid::reconfigure(); | ||||
|       return 0; | ||||
|       } | ||||
|     else if(argis("-rot-stretch")) { | ||||
|       PHASEFROM(2); | ||||
|       shift_arg_formula(rots::stretch_factor, ray::reset_raycaster); | ||||
|       return 0; | ||||
|       } | ||||
|     else if(argis("-prodturn")) { | ||||
|       PHASEFROM(2); | ||||
|       if(prod) stop_game(); | ||||
|   | ||||
							
								
								
									
										156
									
								
								raycaster.cpp
									
									
									
									
									
								
							
							
						
						
									
										156
									
								
								raycaster.cpp
									
									
									
									
									
								
							| @@ -45,12 +45,12 @@ EX ld& exp_decay_current() { | ||||
|   } | ||||
|  | ||||
| EX int& max_iter_current() { | ||||
|   if(nonisotropic) return max_iter_sol; | ||||
|   if(nonisotropic || rots_twist::in()) return max_iter_sol; | ||||
|   else return max_iter_iso; | ||||
|   } | ||||
|  | ||||
| ld& maxstep_current() { | ||||
|   if(sn::in()) return maxstep_sol; | ||||
|   if(sn::in() || rots_twist::in()) return maxstep_sol; | ||||
|   else return maxstep_nil; | ||||
|   } | ||||
|  | ||||
| @@ -65,13 +65,17 @@ EX bool available() { | ||||
|   if(WDIM == 2) return false; | ||||
|   if(hyperbolic && pmodel == mdPerspective && !kite::in()) | ||||
|     return true; | ||||
|   if(sphere && pmodel == mdPerspective && !rotspace) | ||||
|     return true; | ||||
|   if(nil && S7 == 8) | ||||
|     return false; | ||||
|   if((sn::in() || nil) && pmodel == mdGeodesic) | ||||
|     return true; | ||||
|   if(euclid && pmodel == mdPerspective && !bt::in()) | ||||
|     return true; | ||||
|   if(prod && PURE) | ||||
|   if(prod && (PURE || BITRUNCATED)) | ||||
|     return true; | ||||
|   if(sphere && pmodel == mdPerspective && rots_twist::in()) | ||||
|     return true; | ||||
|   return false; | ||||
|   } | ||||
| @@ -79,6 +83,7 @@ EX bool available() { | ||||
| /** do we want to use the raycaster? */ | ||||
| EX bool requested() { | ||||
|   if(cgflags & qRAYONLY) return true; | ||||
|   if(rots_twist::in()) return true; | ||||
|   if(!want_use) return false; | ||||
|   #if CAP_TEXTURE | ||||
|   if(texture::config.tstate == texture::tsActive) return false; | ||||
| @@ -251,7 +256,7 @@ void enable_raycaster() { | ||||
|       flat2 -= bt::dirs_inner(); | ||||
|       } | ||||
|      | ||||
|     if(IN_ODS || hyperbolic) fsh +=  | ||||
|     if(hyperbolic) fsh +=  | ||||
|  | ||||
|     "mediump mat4 xpush(float x) { return mat4(" | ||||
|          "cosh(x), 0., 0., sinh(x),\n" | ||||
| @@ -260,6 +265,15 @@ void enable_raycaster() { | ||||
|          "sinh(x), 0., 0., cosh(x)" | ||||
|          ");}\n"; | ||||
|  | ||||
|     if(sphere) fsh +=  | ||||
|  | ||||
|     "mediump mat4 xpush(float x) { return mat4(" | ||||
|          "cos(x), 0., 0., sin(x),\n" | ||||
|          "0., 1., 0., 0.,\n" | ||||
|          "0., 0., 1., 0.,\n" | ||||
|          "-sin(x), 0., 0., cos(x)" | ||||
|          ");}\n"; | ||||
|          | ||||
|     if(IN_ODS) fsh +=  | ||||
|  | ||||
|     "mediump mat4 xzspin(float x) { return mat4(" | ||||
| @@ -276,13 +290,22 @@ void enable_raycaster() { | ||||
|          "0., 0., 0., 1." | ||||
|          ");}\n";     | ||||
|      | ||||
|    if(bi) { | ||||
|      fsh += "int walloffset, sides;\n"; | ||||
|      } | ||||
|    else { | ||||
|      fsh += "const int walloffset = 0;\n" | ||||
|        "const int sides = " + its(centerover->type) + ";\n"; | ||||
|      } | ||||
|       | ||||
|      | ||||
|    fsh +=  | ||||
|      "mediump vec2 map_texture(mediump vec4 pos, int which) {\n"; | ||||
|    if(nil) fsh += "if(which == 2 || which == 5) pos.z = 0.;\n"; | ||||
|    else if(hyperbolic && bt::in()) fsh +=  | ||||
|        "pos = vec4(-log(pos.w-pos.x), pos.y, pos.z, 1);\n" | ||||
|        "pos.yz *= exp(pos.x);\n"; | ||||
|    else if(hyperbolic) fsh +=  | ||||
|    else if(hyperbolic || sphere) fsh +=  | ||||
|        "pos /= pos.w;\n"; | ||||
|    else if(prod) fsh += | ||||
|      "pos = vec4(pos.x/pos.z, pos.y/pos.z, pos.w, 0);\n"; | ||||
| @@ -298,6 +321,8 @@ void enable_raycaster() { | ||||
|        "return vec2(1, 1);\n" | ||||
|        "}\n"; | ||||
|     | ||||
|    bool stepbased = nonisotropic || rots_twist::in(); | ||||
|      | ||||
|    string fmain = "void main() {\n"; | ||||
|     | ||||
|    if(use_reflect) fmain += "  bool depthtoset = true;\n"; | ||||
| @@ -321,9 +346,12 @@ void enable_raycaster() { | ||||
|     "  at0.xyz = at0.xyz / length(at0.xyz);\n"; | ||||
|        | ||||
|     if(hyperbolic) fsh += "  mediump float len(mediump vec4 x) { return x[3]; }\n"; | ||||
|     else if(sphere && rotspace) fsh += "  mediump float len(mediump vec4 x) { return 1.+x.x*x.x+x.y*x.y-x.z*x.z-x.w*x.w; }\n"; | ||||
|     else if(sphere) fsh += "  mediump float len(mediump vec4 x) { return 1.-x[3]; }\n"; | ||||
|  | ||||
|     else fsh += "  mediump float len(mediump vec4 x) { return length(x.xyz); }\n"; | ||||
|      | ||||
|     if(nonisotropic) fmain +=  | ||||
|     if(stepbased) fmain +=  | ||||
|       "  const mediump float maxstep = " + fts(maxstep_current()) + ";\n" | ||||
|       "  const mediump float minstep = " + fts(minstep) + ";\n" | ||||
|       "  mediump float next = maxstep;\n"; | ||||
| @@ -347,6 +375,14 @@ void enable_raycaster() { | ||||
|       "  mediump vec4 position = vw * vec4(0., 0., 0., 1.);\n" | ||||
|       "  mediump vec4 tangent = vw * at0;\n"; | ||||
|        | ||||
|     if(rots_twist::in()) { | ||||
|       fmain +=  | ||||
|         "tangent = s_itranslate(position) * tangent;\n" | ||||
|         "tangent[2] /= sqrt(1.+stretch);\n" | ||||
|         "tangent = s_translate(position) * tangent;\n"; | ||||
|         ; | ||||
|       } | ||||
|      | ||||
|     if(bi) fmain += "  walloffset = uWallOffset; sides = uSides;\n"; | ||||
|      | ||||
|     fmain +=      | ||||
| @@ -371,7 +407,7 @@ void enable_raycaster() { | ||||
|       "      }\n" | ||||
|       "    }\n"; | ||||
|      | ||||
|     if(!nonisotropic) { | ||||
|     if(!stepbased) { | ||||
|      | ||||
|       fmain += | ||||
|         "  if(which == -1) {\n"; | ||||
| @@ -405,6 +441,11 @@ void enable_raycaster() { | ||||
|           "    mediump float d = atanh(v);\n" | ||||
|           "    mediump vec4 next_tangent = position * sinh(d) + tangent * cosh(d);\n" | ||||
|           "    if(next_tangent[3] < (uM[i] * next_tangent)[3]) continue;\n"; | ||||
|       else if(sphere) fmain += | ||||
|           "    mediump float v = ((position - uM[i] * position)[3] / (uM[i] * tangent - tangent)[3]);\n" | ||||
|           "    mediump float d = atan(v);\n" | ||||
|           "    mediump vec4 next_tangent = -position * sin(d) + tangent * cos(d);\n" | ||||
|           "    if(next_tangent[3] > (uM[i] * next_tangent)[3]) continue;\n"; | ||||
|       else fmain +=  | ||||
|           "    mediump float deno = dot(position, tangent) - dot(uM[i]*position, uM[i]*tangent);\n" | ||||
|           "    if(deno < 1e-6  && deno > -1e-6) continue;\n" | ||||
| @@ -455,6 +496,8 @@ void enable_raycaster() { | ||||
|         "  if(which == -1 && dist == 0.) return;";     | ||||
|       } | ||||
|        | ||||
|     fsh += "const mediump float stretch = float(" + fts(rots::stretch_factor) + ");\n"; | ||||
|  | ||||
|     // shift d units | ||||
|     if(use_reflect) fmain +=  | ||||
|       "bool reflect = false;\n"; | ||||
| @@ -474,12 +517,19 @@ void enable_raycaster() { | ||||
|     else if(in_e2xe()) fmain += | ||||
|       "  position = position + tangent * dist * xspeed;\n" | ||||
|       "  zpos += dist * zspeed;\n"; | ||||
|     else if(hyperbolic) fmain +=  | ||||
|     else if(hyperbolic && !stepbased) fmain +=  | ||||
|       "  mediump float ch = cosh(dist); mediump float sh = sinh(dist);\n" | ||||
|       "  mediump vec4 v = position * ch + tangent * sh;\n" | ||||
|       "  tangent = tangent * ch + position * sh;\n" | ||||
|       "  position = v;\n"; | ||||
|     else if(nonisotropic) { | ||||
|     else if(sphere && !stepbased) fmain +=  | ||||
|       "  mediump float ch = cos(dist); mediump float sh = sin(dist);\n" | ||||
|       "  mediump vec4 v = position * ch + tangent * sh;\n" | ||||
|       "  tangent = tangent * ch - position * sh;\n" | ||||
|       "  position = v;\n"; | ||||
|     else if(stepbased) { | ||||
|      | ||||
|       bool use_christoffel = true; | ||||
|      | ||||
|       if(sol && nih) fsh +=  | ||||
|         "mediump vec4 christoffel(mediump vec4 pos, mediump vec4 vel, mediump vec4 tra) {\n" | ||||
| @@ -493,14 +543,31 @@ void enable_raycaster() { | ||||
|         "mediump vec4 christoffel(mediump vec4 pos, mediump vec4 vel, mediump vec4 tra) {\n" | ||||
|         "  return vec4(-vel.z*tra.x - vel.x*tra.z, vel.z*tra.y + vel.y * tra.z, vel.x*tra.x * exp(2.*pos.z) - vel.y * tra.y * exp(-2.*pos.z), 0.);\n" | ||||
|         "  }\n"; | ||||
|       else fsh += | ||||
|       else if(nil && false) fsh += | ||||
|         "mediump vec4 christoffel(mediump vec4 pos, mediump vec4 vel, mediump vec4 tra) {\n" | ||||
|         "  mediump float x = pos.x;\n" | ||||
|         "  return vec4(x*vel.y*tra.y - 0.5*dot(vel.yz,tra.zy), -.5*x*dot(vel.yx,tra.xy) + .5 * dot(vel.zx,tra.xz), -.5*(x*x-1.)*dot(vel.yx,tra.xy)+.5*x*dot(vel.zx,tra.xz), 0.);\n" | ||||
| //        "  return vec4(0.,0.,0.,0.);\n" | ||||
|         "  }\n"; | ||||
|       else if(rots_twist::in()) { | ||||
|         fsh += "mediump mat4 s_translate(vec4 h) {\n" | ||||
|           "return mat4(h.w,h.z,-h.y,-h.x,-h.z,h.w,h.x,-h.y,h.y,-h.x,h.w,-h.z,h.x,h.y,h.z,h.w);\n" | ||||
|           "}\n"; | ||||
|         fsh += "mediump mat4 s_itranslate(vec4 h) {\n" | ||||
|           "h.xyz = -h.xyz; return s_translate(h);\n" | ||||
|           "}\n"; | ||||
|         fsh += "mediump vec4 christoffel(mediump vec4 pos, mediump vec4 vel, mediump vec4 tra) {\n" | ||||
|           "vel = s_itranslate(pos) * vel;\n" | ||||
|           "tra = s_itranslate(pos) * tra;\n" | ||||
|           "return s_translate(pos) * vec4(\n" | ||||
|           "  (vel.y*tra.z+vel.z*tra.y) * -stretch, " | ||||
|           "  (vel.x*tra.z+vel.z*tra.x) * stretch, " | ||||
|           "  0, 0);\n" | ||||
|           "}\n"; | ||||
|         } | ||||
|       else use_christoffel = false; | ||||
|  | ||||
|       fsh += "mediump vec4 get_acc(mediump vec4 pos, mediump vec4 vel) {\n" | ||||
|       if(use_christoffel) fsh += "mediump vec4 get_acc(mediump vec4 pos, mediump vec4 vel) {\n" | ||||
|         "  return christoffel(pos, vel, vel);\n" | ||||
|         "  }\n"; | ||||
|        | ||||
| @@ -525,7 +592,7 @@ void enable_raycaster() { | ||||
|                  | ||||
|       if(nil) fmain += "tangent = translate(position, itranslate(position, tangent));\n"; | ||||
|        | ||||
|       if(sn::in()) fmain += | ||||
|       if(use_christoffel) fmain += | ||||
|         "mediump vec4 vel = tangent * dist;\n" | ||||
|         "mediump vec4 acc1 = get_acc(position, vel);\n" | ||||
|         "mediump vec4 acc2 = get_acc(position + vel / 2., vel + acc1/2.);\n" | ||||
| @@ -533,6 +600,9 @@ void enable_raycaster() { | ||||
|         "mediump vec4 acc4 = get_acc(position + vel + acc2/2., vel + acc3/2.);\n" | ||||
|         "mediump vec4 nposition = position + vel + (acc1+acc2+acc3)/6.;\n"; | ||||
|        | ||||
|       if(rots_twist::in()) fmain +=  | ||||
|         "nposition = nposition / sqrt(dot(nposition, nposition));\n"; | ||||
|  | ||||
|       if(nil) { | ||||
|         fmain += | ||||
|           "mediump vec4 xp, xt;\n" | ||||
| @@ -576,10 +646,48 @@ void enable_raycaster() { | ||||
|         fmain += "mediump vec4 sp = uStraighten * nposition;\n"; | ||||
|         } | ||||
|        | ||||
|       if(hyperbolic) { | ||||
|         fmain +=  | ||||
|         "  mediump float ch = cosh(dist); mediump float sh = sinh(dist);\n" | ||||
|         "  mediump vec4 v = position * ch + tangent * sh;\n" | ||||
|         "  mediump vec4 ntangent = tangent * ch + position * sh;\n" | ||||
|         "  mediump vec4 nposition = v;\n"; | ||||
|         } | ||||
|  | ||||
|       if(sphere && !use_christoffel) { | ||||
|         fmain +=  | ||||
|         "  mediump float ch = cos(dist); mediump float sh = sin(dist);\n" | ||||
|         "  mediump vec4 v = position * ch + tangent * sh;\n" | ||||
|         "  mediump vec4 ntangent = tangent * ch - position * sh;\n" | ||||
|         "  mediump vec4 nposition = v;\n"; | ||||
|         } | ||||
|  | ||||
|       bool reg = hyperbolic || sphere || euclid; | ||||
|  | ||||
|       if(reg) { | ||||
|         fsh += "mediump float len_h(vec4 h) { return 1. - h[3]; }\n"; | ||||
|         string s = rotspace ? "-2" : ""; | ||||
|         fmain += | ||||
|       "    mediump float best = len(nposition);\n" | ||||
|       "    for(int i=0; i<sides"+s+"; i++) {\n" | ||||
|       "      mediump float cand = len(uM[walloffset+i] * nposition);\n" | ||||
|       "      if(cand < best) { best = cand; which = i; }\n" | ||||
|       "      }\n"; | ||||
|         if(rotspace) fmain += | ||||
|       "   if(which == -1) {\n" | ||||
|       "     best = len_h(nposition);\n" | ||||
|       "     mediump float cand1 = len_h(uM[walloffset+sides-2]*nposition);\n" | ||||
|       "     if(cand1 < best) { best = cand1; which = sides-2; }\n" | ||||
|       "     mediump float cand2 = len_h(uM[walloffset+sides-1]*nposition);\n" | ||||
|       "     if(cand2 < best) { best = cand2; which = sides-1; }\n" | ||||
|       "     }\n"; | ||||
|         } | ||||
|          | ||||
|       fmain += | ||||
|         "if(next >= minstep) {\n"; | ||||
|        | ||||
|       if(asonov) fmain += | ||||
|       if(reg) fmain += "if(which != -1) {\n"; | ||||
|       else if(asonov) fmain += | ||||
|           "if(abs(sp.x) > 1. || abs(sp.y) > 1. || abs(sp.z) > 1.) {\n";       | ||||
|       else if(nih) fmain += | ||||
|           "if(abs(nposition.x) > uBinaryWidth || abs(nposition.y) > uBinaryWidth || abs(nposition.z) > .5) {\n"; | ||||
| @@ -635,7 +743,7 @@ void enable_raycaster() { | ||||
|           "if(nposition.z > log(2.)/2.) which = nposition.x > 0. ? 3 : 2;\n" | ||||
|           "if(nposition.z <-log(2.)/2.) which = nposition.y > 0. ? 7 : 6;\n"; | ||||
|         } | ||||
|       else fmain += | ||||
|       else if(nil) fmain += | ||||
|           "if(nposition.x > .5) which = 3;\n" | ||||
|           "if(nposition.x <-.5) which = 0;\n" | ||||
|           "if(nposition.y > .5) which = 4;\n" | ||||
| @@ -647,14 +755,24 @@ void enable_raycaster() { | ||||
|           "next = maxstep;\n" | ||||
|           "}\n"; | ||||
|        | ||||
|       if(nil) fmain += | ||||
|         "tangent = translatev(position, xt);\n"; | ||||
|  | ||||
|       fmain += | ||||
|         "position = nposition;\n"; | ||||
|        | ||||
|       if(!nil) fmain += | ||||
|       if(use_christoffel) fmain += | ||||
|         "tangent = tangent + (acc1+2.*acc2+2.*acc3+acc4)/(6.*dist);\n"; | ||||
|       else if(nil) fmain += | ||||
|         "tangent = translatev(position, xt);\n"; | ||||
|       else fmain += | ||||
|         "tangent = ntangent;\n"; | ||||
|        | ||||
|       if(rots_twist::in()) { | ||||
|         fmain +=  | ||||
|           "tangent = s_itranslate(position) * tangent;\n" | ||||
|           "tangent[3] = 0.;\n" | ||||
|           "float nvelsquared = dot(tangent.xy, tangent.xy) + (1.+stretch) * tangent.z * tangent.z;\n" | ||||
|           "tangent /= sqrt(nvelsquared);\n" | ||||
|           "tangent = s_translate(position) * tangent;\n"; | ||||
|         } | ||||
|       } | ||||
|     else fmain +=  | ||||
|       "position = position + tangent * dist;\n"; | ||||
| @@ -1188,7 +1306,7 @@ EX void configure() { | ||||
|       }); | ||||
|     } | ||||
|  | ||||
|   if(nonisotropic) { | ||||
|   if(nonisotropic || rots_twist::in()) { | ||||
|     dialog::addSelItem(XLAT("max step"), fts(maxstep_current()), 'x'); | ||||
|     dialog::add_action([] { | ||||
|       dialog::editNumber(maxstep_current(), 1e-6, 1, 0.1, sol ? 0.05 : 0.1, XLAT("max step"), "affects the precision of solving the geodesic equation in Solv"); | ||||
|   | ||||
							
								
								
									
										28
									
								
								reg3.cpp
									
									
									
									
									
								
							
							
						
						
									
										28
									
								
								reg3.cpp
									
									
									
									
									
								
							| @@ -187,6 +187,13 @@ EX namespace reg3 { | ||||
|     if(loop == 4) cgi.strafedist = adjcheck; | ||||
|     else cgi.strafedist = hdist(cgi.adjmoves[0] * C0, cgi.adjmoves[1] * C0); | ||||
|      | ||||
|     if(rots_twist::applicable()) { | ||||
|       transmatrix T = cspin(0, 2, 90 * degree); | ||||
|       transmatrix iT = inverse(T); | ||||
|       for(auto& v: cgi.adjmoves) v = T * v * iT; | ||||
|       for(auto& v: cellshape) v = T * v; | ||||
|       } | ||||
|  | ||||
|     vertices_only.clear(); | ||||
|     for(hyperpoint h: cellshape) { | ||||
|       bool found = false; | ||||
| @@ -695,6 +702,11 @@ EX namespace reg3 { | ||||
|       fixmatrix(T); | ||||
|       auto hT = tC0(T); | ||||
|        | ||||
|       bool hopf = rots_twist::applicable(); | ||||
|  | ||||
|       if(hopf) | ||||
|         T = rots_twist::translate(hT);       | ||||
|        | ||||
|       if(DEB) println(hlog, "searching at ", alt, ":", hT); | ||||
|  | ||||
|       if(DEB) for(auto& p2: altmap[alt]) println(hlog, "for ", tC0(p2.second), " intval is ", intval(tC0(p2.second), hT)); | ||||
| @@ -706,7 +718,8 @@ EX namespace reg3 { | ||||
|         // println(hlog, "YES found in ", isize(altmap[alt])); | ||||
|         if(DEB) println(hlog, "-> found ", p2.first); | ||||
|         int fb = 0; | ||||
|         hyperpoint old = T * (inverse(T1) * tC0(p1.second)); | ||||
|         hyperpoint old = tC0(p1.second);; | ||||
|         if(!hopf) T * (inverse(T1) * old); | ||||
|         #if CAP_FIELD | ||||
|         if(quotient_map) { | ||||
|           p2.first->c.connect(counterpart(parent)->c.spin(d), parent, d, false); | ||||
| @@ -745,6 +758,19 @@ EX namespace reg3 { | ||||
|         fv = cp->c.move(d)->fieldval; | ||||
|         } | ||||
|       #endif | ||||
|       if(hopf) { | ||||
|         hyperpoint old = tC0(p1.second); | ||||
|         for(d2=0; d2<S7; d2++) { | ||||
|           hyperpoint back = T * tC0(cgi.adjmoves[d2]); | ||||
|           if((err = intval(back, old)) < 1e-3)  | ||||
|             break; | ||||
|           } | ||||
|         if(d2 == S7) {  | ||||
|           d2 = 0;  | ||||
|           println(hlog, "Hopf connection failed");  | ||||
|           } | ||||
|         println(hlog, "found d2 = ", d2); | ||||
|         } | ||||
|       heptagon *created = tailored_alloc<heptagon> (S7); | ||||
|       created->c7 = newCell(S7, created); | ||||
|       if(sphere) spherecells.push_back(created->c7); | ||||
|   | ||||
		Reference in New Issue
	
	Block a user
	 Zeno Rogue
					Zeno Rogue