diff --git a/source/build/src/clip.cpp b/source/build/src/clip.cpp index d3fdefb22..ed38d121e 100644 --- a/source/build/src/clip.cpp +++ b/source/build/src/clip.cpp @@ -113,8 +113,8 @@ int clipinsidebox(vec2_t *vect, int wallnum, int walldist) auto const wal1 = (uwallptr_t)&wall[wallnum]; auto const wal2 = (uwallptr_t)wal1->point2Wall(); - vec2_t const v1 = { wal1->x + walldist - vect->X, wal1->y + walldist - vect->Y }; - vec2_t v2 = { wal2->x + walldist - vect->X, wal2->y + walldist - vect->Y }; + vec2_t const v1 = { wal1->pos.X + walldist - vect->X, wal1->y + walldist - vect->Y }; + vec2_t v2 = { wal2->pos.X + walldist - vect->X, wal2->y + walldist - vect->Y }; if (((v1.X < 0) && (v2.X < 0)) || ((v1.Y < 0) && (v2.Y < 0)) || ((v1.X >= r) && (v2.X >= r)) || ((v1.Y >= r) && (v2.Y >= r))) return 0; @@ -507,7 +507,7 @@ CollisionBase clipmove_(vec3_t * const pos, int * const sectnum, int32_t xvect, { auto const wal2 = (uwallptr_t)wal->point2Wall(); - if ((wal->x < clipMin.X && wal2->x < clipMin.X) || (wal->x > clipMax.X && wal2->x > clipMax.X) || + if ((wal->pos.X < clipMin.X && wal2->pos.X < clipMin.X) || (wal->pos.X > clipMax.X && wal2->pos.X > clipMax.X) || (wal->y < clipMin.Y && wal2->y < clipMin.Y) || (wal->y > clipMax.Y && wal2->y > clipMax.Y)) continue; @@ -968,9 +968,9 @@ int pushmove_(vec3_t *const vect, int *const sectnum, else { //Find closest point on wall (dax, day) to (vect->x, vect->y) - int32_t dax = wal->point2Wall()->x-wal->x; + int32_t dax = wal->point2Wall()->pos.X-wal->pos.X; int32_t day = wal->point2Wall()->y-wal->y; - int32_t daz = dax*((vect->X)-wal->x) + day*((vect->Y)-wal->y); + int32_t daz = dax*((vect->X)-wal->pos.X) + day*((vect->Y)-wal->y); int32_t t; if (daz <= 0) t = 0; @@ -979,7 +979,7 @@ int pushmove_(vec3_t *const vect, int *const sectnum, daz2 = dax*dax+day*day; if (daz >= daz2) t = (1<<30); else t = DivScale(daz, daz2, 30); } - dax = wal->x + MulScale(dax, t, 30); + dax = wal->pos.X + MulScale(dax, t, 30); day = wal->y + MulScale(day, t, 30); closest = { dax, day }; @@ -990,7 +990,7 @@ int pushmove_(vec3_t *const vect, int *const sectnum, if (j != 0) { - j = getangle(wal->point2Wall()->x-wal->x, wal->point2Wall()->y-wal->y); + j = getangle(wal->point2Wall()->pos.X-wal->pos.X, wal->point2Wall()->y-wal->y); int32_t dx = -bsin(j, -11); int32_t dy = bcos(j, -11); int bad2 = 16; @@ -1282,7 +1282,7 @@ static int32_t hitscan_trysector(const vec3_t *sv, sectortype* sec, HitInfoBase { auto const wal = (uwallptr_t)sec->firstWall(); auto const wal2 = (uwallptr_t)wal->point2Wall(); - int32_t j, dax=wal2->x-wal->x, day=wal2->y-wal->y; + int32_t j, dax=wal2->pos.X-wal->pos.X, day=wal2->y-wal->y; i = ksqrt(compat_maybe_truncate_to_int32(uhypsq(dax,day))); if (i == 0) return 1; //continue; i = DivScale(heinum,i, 15); @@ -1291,7 +1291,7 @@ static int32_t hitscan_trysector(const vec3_t *sv, sectortype* sec, HitInfoBase j = (vz<<8)-DMulScale(dax,vy,-day,vx, 15); if (j != 0) { - i = ((z - sv->Z)<<8)+DMulScale(dax,sv->Y-wal->y,-day,sv->X-wal->x, 15); + i = ((z - sv->Z)<<8)+DMulScale(dax,sv->Y-wal->y,-day,sv->X-wal->pos.X, 15); if (((i^j) >= 0) && ((abs(i)>>1) < abs(j))) { i = DivScale(i,j, 30); @@ -1366,7 +1366,7 @@ int hitscan(const vec3_t& start, const sectortype* startsect, const vec3_t& dire auto const nextsect = wal->nextSector(); if (curspr && !wal->twoSided()) continue; - x1 = wal->x; y1 = wal->y; x2 = wal2->x; y2 = wal2->y; + x1 = wal->pos.X; y1 = wal->y; x2 = wal2->pos.X; y2 = wal2->y; if (compat_maybe_truncate_to_int32((coord_t)(x1-sv->X)*(y2-sv->Y)) < compat_maybe_truncate_to_int32((coord_t)(x2-sv->X)*(y1-sv->Y))) continue; diff --git a/source/build/src/engine.cpp b/source/build/src/engine.cpp index fe753b733..d80f6758f 100644 --- a/source/build/src/engine.cpp +++ b/source/build/src/engine.cpp @@ -485,7 +485,7 @@ int cansee(int x1, int y1, int z1, sectortype* sect1, int x2, int y2, int z2, se for (cnt=sec->wallnum,wal=(uwallptr_t)sec->firstWall(); cnt>0; cnt--,wal++) { auto const wal2 = (uwallptr_t)wal->point2Wall(); - const int32_t x31 = wal->x-x1, x34 = wal->x-wal2->x; + const int32_t x31 = wal->pos.X-x1, x34 = wal->pos.X-wal2->pos.X; const int32_t y31 = wal->y-y1, y34 = wal->y-wal2->y; int32_t x, y, z, t, bot; @@ -554,7 +554,7 @@ void neartag(const vec3_t& sv, sectortype* sect, int ange, HitInfoBase& result, auto const wal2 = (uwallptr_t)wal->point2Wall(); const auto nextsect = wal->nextSector(); - const int32_t x1 = wal->x, y1 = wal->y, x2 = wal2->x, y2 = wal2->y; + const int32_t x1 = wal->pos.X, y1 = wal->y, x2 = wal2->pos.X, y2 = wal2->y; int32_t intx, inty, intz, good = 0; if (wal->twoSided()) diff --git a/source/build/src/polymost.cpp b/source/build/src/polymost.cpp index 216e3da80..633b162ba 100644 --- a/source/build/src/polymost.cpp +++ b/source/build/src/polymost.cpp @@ -1018,8 +1018,8 @@ static void polymost_internal_nonparallaxed(FVector2 n0, FVector2 n1, float ryp0 FVector2 const fxy = { xy.X*r, xy.Y*r }; - ft[0] = ((float)(globalposx - sec->firstWall()->x)) * fxy.X + ((float)(globalposy - sec->firstWall()->y)) * fxy.Y; - ft[1] = ((float)(globalposy - sec->firstWall()->y)) * fxy.X - ((float)(globalposx - sec->firstWall()->x)) * fxy.Y; + ft[0] = ((float)(globalposx - sec->firstWall()->pos.X)) * fxy.X + ((float)(globalposy - sec->firstWall()->y)) * fxy.Y; + ft[1] = ((float)(globalposy - sec->firstWall()->y)) * fxy.X - ((float)(globalposx - sec->firstWall()->pos.X)) * fxy.Y; ft[2] = fcosglobalang * fxy.X + fsinglobalang * fxy.Y; ft[3] = fsinglobalang * fxy.X - fcosglobalang * fxy.Y; @@ -1218,8 +1218,8 @@ static inline int32_t testvisiblemost(float const x0, float const x1) static inline int polymost_getclosestpointonwall(vec2_t const * const pos, int32_t dawall, vec2_t * const n) { - vec2_t const w = { wall[dawall].x, wall[dawall].y }; - vec2_t const d = { POINT2(dawall).x - w.X, POINT2(dawall).y - w.Y }; + vec2_t const w = { wall[dawall].pos.X, wall[dawall].y }; + vec2_t const d = { POINT2(dawall).pos.X - w.X, POINT2(dawall).y - w.Y }; int64_t i = d.X * ((int64_t)pos->X - w.X) + d.Y * ((int64_t)pos->Y - w.Y); if (d.X == 0 && d.Y == 0) @@ -1483,12 +1483,12 @@ static void polymost_drawalls(int32_t const bunch) auto const nextsec = nextsectnum>=0 ? (usectorptr_t)§or[nextsectnum] : NULL; //Offset&Rotate 3D coordinates to screen 3D space - FVector2 walpos = { (float)(wal->x-globalposx), (float)(wal->y-globalposy) }; + FVector2 walpos = { (float)(wal->pos.X-globalposx), (float)(wal->y-globalposy) }; FVector2 p0 = { walpos.Y * gcosang - walpos.X * gsinang, walpos.X * gcosang2 + walpos.Y * gsinang2 }; FVector2 const op0 = p0; - walpos = { (float)(wal2->x - globalposx), + walpos = { (float)(wal2->pos.X - globalposx), (float)(wal2->y - globalposy) }; FVector2 p1 = { walpos.Y * gcosang - walpos.X * gsinang, walpos.X * gcosang2 + walpos.Y * gsinang2 }; @@ -1503,26 +1503,26 @@ static void polymost_drawalls(int32_t const bunch) if (p1.Y < SCISDIST) continue; t0 = (SCISDIST-p0.Y)/(p1.Y-p0.Y); p0 = { (p1.X-p0.X)*t0+p0.X, SCISDIST }; - n0 = { (wal2->x-wal->x)*t0+wal->x, + n0 = { (wal2->pos.X-wal->pos.X)*t0+wal->pos.X, (wal2->y-wal->y)*t0+wal->y }; } else { t0 = 0.f; - n0 = { (float)wal->x, (float)wal->y }; + n0 = { (float)wal->pos.X, (float)wal->y }; } if (p1.Y < SCISDIST) { t1 = (SCISDIST-op0.Y)/(p1.Y-op0.Y); p1 = { (p1.X-op0.X)*t1+op0.X, SCISDIST }; - n1 = { (wal2->x-wal->x)*t1+wal->x, + n1 = { (wal2->pos.X-wal->pos.X)*t1+wal->pos.X, (wal2->y-wal->y)*t1+wal->y }; } else { t1 = 1.f; - n1 = { (float)wal2->x, (float)wal2->y }; + n1 = { (float)wal2->pos.X, (float)wal2->y }; } float ryp0 = 1.f/p0.Y, ryp1 = 1.f/p1.Y; @@ -1913,8 +1913,8 @@ void polymost_scansector(int32_t sectnum) { auto const wal2 = (uwallptr_t)wal->point2Wall(); - DVector2 const fp1 = { double(wal->x - globalposx), double(wal->y - globalposy) }; - DVector2 const fp2 = { double(wal2->x - globalposx), double(wal2->y - globalposy) }; + DVector2 const fp1 = { double(wal->pos.X - globalposx), double(wal->y - globalposy) }; + DVector2 const fp2 = { double(wal2->pos.X - globalposx), double(wal2->y - globalposy) }; int const nextsectnum = wal->nextsector; //Scan close sectors @@ -2315,10 +2315,10 @@ static void polymost_drawmaskwallinternal(int32_t wallIndex) globalshade = (int32_t)wal->shade; globalfloorpal = globalpal = (int32_t)((uint8_t)wal->pal); - FVector2 s0 = { (float)(wal->x-globalposx), (float)(wal->y-globalposy) }; + FVector2 s0 = { (float)(wal->pos.X-globalposx), (float)(wal->y-globalposy) }; FVector2 p0 = { s0.Y*gcosang - s0.X*gsinang, s0.X*gcosang2 + s0.Y*gsinang2 }; - FVector2 s1 = { (float)(wal2->x-globalposx), (float)(wal2->y-globalposy) }; + FVector2 s1 = { (float)(wal2->pos.X-globalposx), (float)(wal2->y-globalposy) }; FVector2 p1 = { s1.Y*gcosang - s1.X*gsinang, s1.X*gcosang2 + s1.Y*gsinang2 }; if ((p0.Y < SCISDIST) && (p1.Y < SCISDIST)) return; @@ -2342,12 +2342,12 @@ static void polymost_drawmaskwallinternal(int32_t wallIndex) p1 = { (p1.X - op0.X) * t1 + op0.X, SCISDIST }; } - int32_t m0 = (int32_t)((wal2->x - wal->x) * t0 + wal->x); + int32_t m0 = (int32_t)((wal2->pos.X - wal->pos.X) * t0 + wal->pos.X); int32_t m1 = (int32_t)((wal2->y - wal->y) * t0 + wal->y); int32_t cz[4], fz[4]; getzsofslopeptr(sec, m0, m1, &cz[0], &fz[0]); getzsofslopeptr(wal->nextSector(), m0, m1, &cz[1], &fz[1]); - m0 = (int32_t)((wal2->x - wal->x) * t1 + wal->x); + m0 = (int32_t)((wal2->pos.X - wal->pos.X) * t1 + wal->pos.X); m1 = (int32_t)((wal2->y - wal->y) * t1 + wal->y); getzsofslopeptr(sec, m0, m1, &cz[2], &fz[2]); getzsofslopeptr(wal->nextSector(), m0, m1, &cz[3], &fz[3]); @@ -2889,12 +2889,12 @@ void polymost_drawsprite(int32_t snum) { vec2_t v = { /*Blrintf(vf.x)*/(int)vf.X, /*Blrintf(vf.y)*/(int)vf.Y }; - if (walldist <= 2 || ((pos.X - v.X) + (pos.X + v.X)) == (wall[w].x + POINT2(w).x) || + if (walldist <= 2 || ((pos.X - v.X) + (pos.X + v.X)) == (wall[w].pos.X + POINT2(w).pos.X) || ((pos.Y - v.Y) + (pos.Y + v.Y)) == (wall[w].y + POINT2(w).y) || - polymost_lintersect(pos.X - v.X, pos.Y - v.Y, pos.X + v.X, pos.Y + v.Y, wall[w].x, wall[w].y, - POINT2(w).x, POINT2(w).y)) + polymost_lintersect(pos.X - v.X, pos.Y - v.Y, pos.X + v.X, pos.Y + v.Y, wall[w].pos.X, wall[w].y, + POINT2(w).pos.X, POINT2(w).y)) { - int32_t const ang = getangle(wall[w].x - POINT2(w).x, wall[w].y - POINT2(w).y); + int32_t const ang = getangle(wall[w].pos.X - POINT2(w).pos.X, wall[w].y - POINT2(w).y); float const foffs = TSPR_OFFSET(tspr); DVector2 const offs = { -bsinf(ang, -6) * foffs, bcosf(ang, -6) * foffs }; @@ -3259,7 +3259,7 @@ static_assert((int)RS_YFLIP == (int)HUDFLAG_FLIPPED); void renderPrepareMirror(int32_t dax, int32_t day, int32_t daz, fixed_t daang, fixed_t dahoriz, int16_t dawall, int32_t* tposx, int32_t* tposy, fixed_t* tang) { - const int32_t x = wall[dawall].x, dx = wall[dawall].point2Wall()->x - x; + const int32_t x = wall[dawall].pos.X, dx = wall[dawall].point2Wall()->pos.X - x; const int32_t y = wall[dawall].y, dy = wall[dawall].point2Wall()->y - y; const int32_t j = dx * dx + dy * dy; @@ -3639,8 +3639,8 @@ void renderDrawMasks(void) maskwallcnt--; - FVector2 dot = { (float)wall[w].x, (float)wall[w].y }; - FVector2 dot2 = { (float)wall[w].point2Wall()->x, (float)wall[w].point2Wall()->y }; + FVector2 dot = { (float)wall[w].pos.X, (float)wall[w].y }; + FVector2 dot2 = { (float)wall[w].point2Wall()->pos.X, (float)wall[w].point2Wall()->y }; FVector2 middle = { (dot.X + dot2.X) * .5f, (dot.Y + dot2.Y) * .5f }; _equation maskeq = equation(dot.X, dot.Y, dot2.X, dot2.Y); diff --git a/source/core/automap.cpp b/source/core/automap.cpp index 0c5f27a74..21554eedd 100644 --- a/source/core/automap.cpp +++ b/source/core/automap.cpp @@ -170,9 +170,9 @@ static void CalcMapBounds() for(auto& wal : wall) { // get map min and max coordinates - if (wal.x < x_min_bound) x_min_bound = wal.x; + if (wal.pos.X < x_min_bound) x_min_bound = wal.pos.X; if (wal.y < y_min_bound) y_min_bound = wal.y; - if (wal.x > x_max_bound) x_max_bound = wal.x; + if (wal.pos.X > x_max_bound) x_max_bound = wal.pos.X; if (wal.y > y_max_bound) y_max_bound = wal.y; } } @@ -434,13 +434,13 @@ void drawredlines(int cposx, int cposy, int czoom, int cang) if (ShowRedLine(wallnum(&wal), i)) { - int ox = wal.x - cposx; + int ox = wal.pos.X - cposx; int oy = wal.y - cposy; int x1 = DMulScale(ox, xvect, -oy, yvect, 16) + (width << 11); int y1 = DMulScale(oy, xvect, ox, yvect, 16) + (height << 11); auto wal2 = wal.point2Wall(); - ox = wal2->x - cposx; + ox = wal2->pos.X - cposx; oy = wal2->y - cposy; int x2 = DMulScale(ox, xvect, -oy, yvect, 16) + (width << 11); int y2 = DMulScale(oy, xvect, ox, yvect, 16) + (height << 11); @@ -476,14 +476,14 @@ static void drawwhitelines(int cposx, int cposy, int czoom, int cang) if (isSWALL() && !gFullMap && !show2dwall[wallnum(&wal)]) continue; - int ox = wal.x - cposx; + int ox = wal.pos.X - cposx; int oy = wal.y - cposy; int x1 = DMulScale(ox, xvect, -oy, yvect, 16) + (width << 11); int y1 = DMulScale(oy, xvect, ox, yvect, 16) + (height << 11); int k = wal.point2; auto wal2 = &wall[k]; - ox = wal2->x - cposx; + ox = wal2->pos.X - cposx; oy = wal2->y - cposy; int x2 = DMulScale(ox, xvect, -oy, yvect, 16) + (width << 11); int y2 = DMulScale(oy, xvect, ox, yvect, 16) + (height << 11); diff --git a/source/core/gamefuncs.cpp b/source/core/gamefuncs.cpp index a041b24ca..2664ac4f2 100644 --- a/source/core/gamefuncs.cpp +++ b/source/core/gamefuncs.cpp @@ -66,7 +66,7 @@ bool calcChaseCamPos(int* px, int* py, int* pz, spritetype* pspr, sectortype** p { // Push you a little bit off the wall *psect = hitinfo.hitSector; - daang = bvectangbam(hitinfo.hitWall->point2Wall()->x - hitinfo.hitWall->x, + daang = bvectangbam(hitinfo.hitWall->point2Wall()->pos.X - hitinfo.hitWall->pos.X, hitinfo.hitWall->point2Wall()->y - hitinfo.hitWall->y); newdist = nx * daang.bsin() + ny * -daang.bcos(); @@ -169,7 +169,7 @@ void calcSlope(const sectortype* sec, float xpos, float ypos, float* pceilz, flo int len = wal->Length(); if (len != 0) { - float fac = (wal->deltax() * (float(ypos - wal->y)) - wal->deltay() * (float(xpos - wal->x))) * (1.f / 256.f) / len; + float fac = (wal->deltax() * (float(ypos - wal->y)) - wal->deltay() * (float(xpos - wal->pos.X))) * (1.f / 256.f) / len; if (pceilz && sec->ceilingstat & CSTAT_SECTOR_SLOPE) *pceilz += (sec->ceilingheinum * fac); if (pflorz && sec->floorstat & CSTAT_SECTOR_SLOPE) *pflorz += (sec->floorheinum * fac); } @@ -227,7 +227,7 @@ int getslopeval(sectortype* sect, int x, int y, int z, int basez) { auto wal = sect->firstWall(); auto delta = wal->delta(); - int i = (y - wal->y) * delta.X - (x - wal->x) * delta.Y; + int i = (y - wal->y) * delta.X - (x - wal->pos.X) * delta.Y; return i == 0? 0 : Scale((z - basez) << 8, wal->Length(), i); } diff --git a/source/core/gamefuncs.h b/source/core/gamefuncs.h index 50931f94d..ef5ef2ccd 100644 --- a/source/core/gamefuncs.h +++ b/source/core/gamefuncs.h @@ -146,7 +146,7 @@ inline double RenderY(int y) inline double WallStartX(int wallnum) { - return wall[wallnum].x * (1 / 16.); + return wall[wallnum].pos.X * (1 / 16.); } inline double WallStartY(int wallnum) @@ -156,7 +156,7 @@ inline double WallStartY(int wallnum) inline double WallEndX(int wallnum) { - return wall[wallnum].point2Wall()->x * (1 / 16.); + return wall[wallnum].point2Wall()->pos.X * (1 / 16.); } inline double WallEndY(int wallnum) @@ -166,7 +166,7 @@ inline double WallEndY(int wallnum) inline double WallStartX(const walltype* wallnum) { - return wallnum->x * (1 / 16.); + return wallnum->pos.X * (1 / 16.); } inline double WallStartY(const walltype* wallnum) @@ -181,7 +181,7 @@ inline DVector2 WallStart(const walltype* wallnum) inline double WallEndX(const walltype* wallnum) { - return wallnum->point2Wall()->x * (1 / 16.); + return wallnum->point2Wall()->pos.X * (1 / 16.); } inline double WallEndY(const walltype* wallnum) @@ -289,7 +289,7 @@ inline int I_GetBuildTime() inline int32_t getangle(walltype* wal) { return getangle( - wal->point2Wall()->x - wal->x, + wal->point2Wall()->pos.X - wal->pos.X, wal->point2Wall()->y - wal->y); } @@ -323,9 +323,9 @@ inline double SquareDist(double lx1, double ly1, double lx2, double ly2) inline double SquareDistToWall(double px, double py, const walltype* wal) { - double lx1 = wal->x; + double lx1 = wal->pos.X; double ly1 = wal->y; - double lx2 = wal->point2Wall()->x; + double lx2 = wal->point2Wall()->pos.X; double ly2 = wal->point2Wall()->y; double wall_length = SquareDist(lx1, ly1, lx2, ly2); diff --git a/source/core/interpolate.cpp b/source/core/interpolate.cpp index aeb1394a9..bb35e786e 100644 --- a/source/core/interpolate.cpp +++ b/source/core/interpolate.cpp @@ -49,7 +49,7 @@ double Get(int index, int type) case Interp_Sect_CeilingPanX: return sector[index].ceilingxpan_; case Interp_Sect_CeilingPanY: return sector[index].ceilingypan_; - case Interp_Wall_X: return wall[index].x; + case Interp_Wall_X: return wall[index].pos.X; case Interp_Wall_Y: return wall[index].y; case Interp_Wall_PanX: return wall[index].xpan_; case Interp_Wall_PanY: return wall[index].ypan_; @@ -72,7 +72,7 @@ void Set(int index, int type, double val) case Interp_Sect_CeilingPanX: sector[index].ceilingxpan_ = float(val); break; case Interp_Sect_CeilingPanY: sector[index].ceilingypan_ = float(val); break; - case Interp_Wall_X: old = wall[index].x; wall[index].x = xs_CRoundToInt(val); if (wall[index].x != old) wall[index].moved(); break; + case Interp_Wall_X: old = wall[index].pos.X; wall[index].pos.X = xs_CRoundToInt(val); if (wall[index].pos.X != old) wall[index].moved(); break; case Interp_Wall_Y: old = wall[index].y; wall[index].y = xs_CRoundToInt(val); if (wall[index].y != old) wall[index].moved(); break; case Interp_Wall_PanX: wall[index].xpan_ = float(val); break; case Interp_Wall_PanY: wall[index].ypan_ = float(val); break; diff --git a/source/core/maptypes.h b/source/core/maptypes.h index d1dc01964..4847b1f0c 100644 --- a/source/core/maptypes.h +++ b/source/core/maptypes.h @@ -313,7 +313,7 @@ struct walltype { // todo: get rid of the single variables! union { - struct { int32_t x, y; }; + struct { int32_t BLAHBLAHX, y; }; vec2_t pos; }; @@ -363,7 +363,7 @@ struct walltype walltype* point2Wall() const; vec2_t delta() const { return point2Wall()->pos - pos; } vec2_t center() const { return(point2Wall()->pos + pos) / 2; } - int deltax() const { return point2Wall()->x - x; } + int deltax() const { return point2Wall()->pos.X - pos.X; } int deltay() const { return point2Wall()->y - y; } bool twoSided() const { return nextsector >= 0; } int Length(); diff --git a/source/core/rendering/hw_sections.cpp b/source/core/rendering/hw_sections.cpp index 8b59f7a86..77a2e2b59 100644 --- a/source/core/rendering/hw_sections.cpp +++ b/source/core/rendering/hw_sections.cpp @@ -244,7 +244,7 @@ static void CollectLoops(TArray& sectors) { // quick check for the only known cause of this in proper maps: // RRRA E1L3 and SW $yamato have a wall duplicate where the duplicate's index is the original's + 1. These can just be deleted here and be ignored. - if (ww > 1 && wall[ww-1].x == wall[ww-2].x && wall[ww-1].y == wall[ww-2].y && wall[ww-1].point2 == wall[ww-2].point2 && wall[ww - 1].point2 == ww) + if (ww > 1 && wall[ww-1].pos.X == wall[ww-2].pos.X && wall[ww-1].y == wall[ww-2].y && wall[ww-1].point2 == wall[ww-2].point2 && wall[ww - 1].point2 == ww) { thisloop.Clear(); break; diff --git a/source/core/rendering/scene/hw_bunchdrawer.cpp b/source/core/rendering/scene/hw_bunchdrawer.cpp index f4e5c5aa7..ce3cb405c 100644 --- a/source/core/rendering/scene/hw_bunchdrawer.cpp +++ b/source/core/rendering/scene/hw_bunchdrawer.cpp @@ -167,11 +167,11 @@ bool BunchDrawer::CheckClip(walltype* wal, float* topclip, float* bottomclip) // Mirrors and horizons always block the view //if (linedef->special==Line_Mirror || linedef->special==Line_Horizon) return true; - PlanesAtPoint(frontsector, wal->x, wal->y, &fs_ceilingheight1, &fs_floorheight1); - PlanesAtPoint(frontsector, pt2->x, pt2->y, &fs_ceilingheight2, &fs_floorheight2); + PlanesAtPoint(frontsector, wal->pos.X, wal->y, &fs_ceilingheight1, &fs_floorheight1); + PlanesAtPoint(frontsector, pt2->pos.X, pt2->y, &fs_ceilingheight2, &fs_floorheight2); - PlanesAtPoint(backsector, wal->x, wal->y, &bs_ceilingheight1, &bs_floorheight1); - PlanesAtPoint(backsector, pt2->x, pt2->y, &bs_ceilingheight2, &bs_floorheight2); + PlanesAtPoint(backsector, wal->pos.X, wal->y, &bs_ceilingheight1, &bs_floorheight1); + PlanesAtPoint(backsector, pt2->pos.X, pt2->y, &bs_ceilingheight2, &bs_floorheight2); *bottomclip = max(max(bs_floorheight1, bs_floorheight2), max(fs_floorheight1, fs_floorheight2)); diff --git a/source/core/rendering/scene/hw_drawinfo.cpp b/source/core/rendering/scene/hw_drawinfo.cpp index b1e0efe3c..1f41f3c39 100644 --- a/source/core/rendering/scene/hw_drawinfo.cpp +++ b/source/core/rendering/scene/hw_drawinfo.cpp @@ -414,7 +414,7 @@ void HWDrawInfo::CreateScene(bool portal) for (auto w = 0; w < sect->wallnum; w++) { auto wal = sect->firstWall() + w; - wal->x += eff.geox[i]; + wal->pos.X += eff.geox[i]; wal->y += eff.geoy[i]; } sect->dirty = EDirty::AllDirty; @@ -433,7 +433,7 @@ void HWDrawInfo::CreateScene(bool portal) for (auto w = 0; w < sect->wallnum; w++) { auto wal = sect->firstWall() + w; - wal->x -= eff.geox[i]; + wal->pos.X -= eff.geox[i]; wal->y -= eff.geoy[i]; } } @@ -446,7 +446,7 @@ void HWDrawInfo::CreateScene(bool portal) for (auto w = 0; w < sect->wallnum; w++) { auto wal = sect->firstWall() + w; - wal->x += eff.geox2[i]; + wal->pos.X += eff.geox2[i]; wal->y += eff.geoy2[i]; } sect->dirty = EDirty::AllDirty; @@ -464,7 +464,7 @@ void HWDrawInfo::CreateScene(bool portal) for (auto w = 0; w < sect->wallnum; w++) { auto wal = sect->firstWall() + w; - wal->x -= eff.geox2[i]; + wal->pos.X -= eff.geox2[i]; wal->y -= eff.geoy2[i]; } } diff --git a/source/core/rendering/scene/hw_portal.cpp b/source/core/rendering/scene/hw_portal.cpp index ec6b5a16a..854cd028b 100644 --- a/source/core/rendering/scene/hw_portal.cpp +++ b/source/core/rendering/scene/hw_portal.cpp @@ -524,9 +524,9 @@ bool HWMirrorPortal::Setup(HWDrawInfo *di, FRenderState &rstate, Clipper *clippe di->mClipPortal = this; - int x = line->x; + int x = line->pos.X; int y = line->y; - int dx = line->point2Wall()->x - x; + int dx = line->point2Wall()->pos.X - x; int dy = line->point2Wall()->y - y; // this can overflow so use 64 bit math. @@ -564,8 +564,8 @@ bool HWMirrorPortal::Setup(HWDrawInfo *di, FRenderState &rstate, Clipper *clippe ClearClipper(di, clipper); - auto startan = bvectangbam(line->x - newx, line->y - newy); - auto endan = bvectangbam(line->point2Wall()->x - newx, line->point2Wall()->y - newy); + auto startan = bvectangbam(line->pos.X - newx, line->y - newy); + auto endan = bvectangbam(line->point2Wall()->pos.X - newx, line->point2Wall()->y - newy); clipper->RestrictVisibleRange(endan, startan); // we check the line from the backside so angles are reversed. return true; } @@ -634,8 +634,8 @@ bool HWLineToLinePortal::Setup(HWDrawInfo *di, FRenderState &rstate, Clipper *cl ClearClipper(di, clipper); - auto startan = bvectangbam(origin->x - origx, origin->y - origy); - auto endan = bvectangbam(origin->point2Wall()->x - origx, origin->point2Wall()->y - origy); + auto startan = bvectangbam(origin->pos.X - origx, origin->y - origy); + auto endan = bvectangbam(origin->point2Wall()->pos.X - origx, origin->point2Wall()->y - origy); clipper->RestrictVisibleRange(startan, endan); return true; } @@ -686,8 +686,8 @@ bool HWLineToSpritePortal::Setup(HWDrawInfo* di, FRenderState& rstate, Clipper* ClearClipper(di, clipper); - auto startan = bvectangbam(origin->x - origx, origin->y - origy); - auto endan = bvectangbam(origin->point2Wall()->x - origx, origin->point2Wall()->y - origy); + auto startan = bvectangbam(origin->pos.X - origx, origin->y - origy); + auto endan = bvectangbam(origin->point2Wall()->pos.X - origx, origin->point2Wall()->y - origy); clipper->RestrictVisibleRange(startan, endan); return true; } diff --git a/source/core/rendering/scene/hw_walls.cpp b/source/core/rendering/scene/hw_walls.cpp index 95c85e199..23812b89a 100644 --- a/source/core/rendering/scene/hw_walls.cpp +++ b/source/core/rendering/scene/hw_walls.cpp @@ -964,8 +964,8 @@ void HWWall::Process(HWDrawInfo* di, walltype* wal, sectortype* frontsector, sec FVector2 v1(WallStartX(wal), WallStartY(wal)); FVector2 v2(WallEndX(wal), WallEndY(wal)); - PlanesAtPoint(frontsector, wal->x, wal->y, &fch1, &ffh1); - PlanesAtPoint(frontsector, p2wall->x, p2wall->y, &fch2, &ffh2); + PlanesAtPoint(frontsector, wal->pos.X, wal->y, &fch1, &ffh1); + PlanesAtPoint(frontsector, p2wall->pos.X, p2wall->y, &fch2, &ffh2); #ifdef _DEBUG @@ -1050,8 +1050,8 @@ void HWWall::Process(HWDrawInfo* di, walltype* wal, sectortype* frontsector, sec float bfh2; float bch1; float bch2; - PlanesAtPoint(backsector, wal->x, wal->y, &bch1, &bfh1); - PlanesAtPoint(backsector, p2wall->x, p2wall->y, &bch2, &bfh2); + PlanesAtPoint(backsector, wal->pos.X, wal->y, &bch1, &bfh1); + PlanesAtPoint(backsector, p2wall->pos.X, p2wall->y, &bch2, &bfh2); SkyTop(di, wal, frontsector, backsector, v1, v2, fch1, fch2); SkyBottom(di, wal, frontsector, backsector, v1, v2, ffh1, ffh2); diff --git a/source/core/savegamehelp.cpp b/source/core/savegamehelp.cpp index 876fa79ab..55230a1e6 100644 --- a/source/core/savegamehelp.cpp +++ b/source/core/savegamehelp.cpp @@ -605,7 +605,7 @@ FSerializer &Serialize(FSerializer &arc, const char *key, walltype &c, walltype { if (arc.BeginObject(key)) { - arc("x", c.x, def->x) + arc("x", c.pos.X, def->pos.X) ("y", c.y, def->y) ("point2", c.point2, def->point2) ("nextwall", c.nextwall, def->nextwall) diff --git a/source/core/sectorgeometry.cpp b/source/core/sectorgeometry.cpp index 82dd7e32d..a876ce7c8 100644 --- a/source/core/sectorgeometry.cpp +++ b/source/core/sectorgeometry.cpp @@ -60,8 +60,8 @@ static FVector3 CalcNormal(sectortype* sector, int plane) pt[0] = { (float)WallStartX(wal), (float)WallStartY(wal), 0 }; pt[1] = { (float)WallEndX(wal), (float)WallEndY(wal), 0 }; - PlanesAtPoint(sector, wal->x, wal->y, plane ? &pt[0].Z : nullptr, plane? nullptr : &pt[0].Z); - PlanesAtPoint(sector, wal2->x, wal2->y, plane ? &pt[1].Z : nullptr, plane ? nullptr : &pt[1].Z); + PlanesAtPoint(sector, wal->pos.X, wal->y, plane ? &pt[0].Z : nullptr, plane? nullptr : &pt[0].Z); + PlanesAtPoint(sector, wal2->pos.X, wal2->y, plane ? &pt[1].Z : nullptr, plane ? nullptr : &pt[1].Z); if (pt[0].X == pt[1].X) { @@ -116,9 +116,9 @@ public: offset = off; auto firstwall = sec->firstWall(); - ix1 = firstwall->x; + ix1 = firstwall->pos.X; iy1 = firstwall->y; - ix2 = firstwall->point2Wall()->x; + ix2 = firstwall->point2Wall()->pos.X; iy2 = firstwall->point2Wall()->y; if (plane == 0) diff --git a/source/games/blood/src/_polymost.cpp b/source/games/blood/src/_polymost.cpp index 1f160dd37..3bf00729c 100644 --- a/source/games/blood/src/_polymost.cpp +++ b/source/games/blood/src/_polymost.cpp @@ -221,20 +221,20 @@ void DrawMirrors(int x, int y, int z, fixed_t a, fixed_t horiz, int smooth, int pWall->nextsector = mirrorsector; wallarr[mirrorwall[0]].nextwall = nWall; wallarr[mirrorwall[0]].nextsector = nSector; - wallarr[mirrorwall[0]].x = pWall->point2Wall()->x; + wallarr[mirrorwall[0]].pos.X = pWall->point2Wall()->pos.X; wallarr[mirrorwall[0]].y = pWall->point2Wall()->y; - wallarr[mirrorwall[1]].x = pWall->x; + wallarr[mirrorwall[1]].pos.X = pWall->pos.X; wallarr[mirrorwall[1]].y = pWall->y; - wallarr[mirrorwall[2]].x = wallarr[mirrorwall[1]].x + (wallarr[mirrorwall[1]].x - wallarr[mirrorwall[0]].x) * 16; + wallarr[mirrorwall[2]].pos.X = wallarr[mirrorwall[1]].pos.X + (wallarr[mirrorwall[1]].pos.X - wallarr[mirrorwall[0]].pos.X) * 16; wallarr[mirrorwall[2]].y = wallarr[mirrorwall[1]].y + (wallarr[mirrorwall[1]].y - wallarr[mirrorwall[0]].y) * 16; - wallarr[mirrorwall[3]].x = wallarr[mirrorwall[0]].x + (wallarr[mirrorwall[0]].x - wallarr[mirrorwall[1]].x) * 16; + wallarr[mirrorwall[3]].pos.X = wallarr[mirrorwall[0]].pos.X + (wallarr[mirrorwall[0]].pos.X - wallarr[mirrorwall[1]].pos.X) * 16; wallarr[mirrorwall[3]].y = wallarr[mirrorwall[0]].y + (wallarr[mirrorwall[0]].y - wallarr[mirrorwall[1]].y) * 16; sector.Data()[mirrorsector].floorz = sector[nSector].floorz; sector.Data()[mirrorsector].ceilingz = sector[nSector].ceilingz; int cx, cy, ca; if (pWall->type == kWallStack) { - cx = x - (wall[pWall->hitag].x - pWall->point2Wall()->x); + cx = x - (wall[pWall->hitag].pos.X - pWall->point2Wall()->pos.X); cy = y - (wall[pWall->hitag].y - pWall->point2Wall()->y); ca = a; } diff --git a/source/games/blood/src/actor.cpp b/source/games/blood/src/actor.cpp index 6f4bcc6f4..167a68457 100644 --- a/source/games/blood/src/actor.cpp +++ b/source/games/blood/src/actor.cpp @@ -2624,7 +2624,7 @@ int actFloorBounceVector(int* x, int* y, int* z, sectortype* pSector, int a5) } walltype* pWall = pSector->firstWall(); walltype* pWall2 = pWall->point2Wall(); - int angle = getangle(pWall2->x - pWall->x, pWall2->y - pWall->y) + 512; + int angle = getangle(pWall2->pos.X - pWall->pos.X, pWall2->y - pWall->y) + 512; int t2 = pSector->floorheinum << 4; int t3 = approxDist(-0x10000, t2); int t4 = DivScale(-0x10000, t3, 16); diff --git a/source/games/blood/src/db.cpp b/source/games/blood/src/db.cpp index c920c037b..80b5e9fce 100644 --- a/source/games/blood/src/db.cpp +++ b/source/games/blood/src/db.cpp @@ -438,7 +438,7 @@ void dbLoadMap(const char* pPath, int* pX, int* pY, int* pZ, short* pAngle, sect { dbCrypt((char*)&load, sizeof(walltypedisk), (gMapRev * sizeof(sectortypedisk)) | 0x7474614d); } - pWall->x = LittleLong(load.x); + pWall->pos.X = LittleLong(load.x); pWall->y = LittleLong(load.y); pWall->point2 = LittleShort(load.point2); pWall->nextwall = LittleShort(load.nextwall); diff --git a/source/games/blood/src/gameutil.cpp b/source/games/blood/src/gameutil.cpp index 8feb54548..e17332a6e 100644 --- a/source/games/blood/src/gameutil.cpp +++ b/source/games/blood/src/gameutil.cpp @@ -148,9 +148,9 @@ bool CheckProximityPoint(int nX1, int nY1, int nZ1, int nX2, int nY2, int nZ2, i bool CheckProximityWall(walltype* pWall, int x, int y, int nDist) { - int x1 = pWall->x; + int x1 = pWall->pos.X; int y1 = pWall->y; - int x2 = pWall->point2Wall()->x; + int x2 = pWall->point2Wall()->pos.X; int y2 = pWall->point2Wall()->y; nDist <<= 4; if (x1 < x2) @@ -489,12 +489,12 @@ int VectorScan(DBloodActor *actor, int nOffset, int nZOffset, int dx, int dy, in nOffset = (nOffset*pWall->yrepeat) / 8; nOffset += int((nSizY*pWall->ypan_) / 256); - int nLength = approxDist(pWall->x - pWall->point2Wall()->x, pWall->y - pWall->point2Wall()->y); + int nLength = approxDist(pWall->pos.X - pWall->point2Wall()->pos.X, pWall->y - pWall->point2Wall()->y); int nHOffset; if (pWall->cstat & CSTAT_WALL_XFLIP) - nHOffset = approxDist(gHitInfo.hitpos.X - pWall->point2Wall()->x, gHitInfo.hitpos.Y - pWall->point2Wall()->y); + nHOffset = approxDist(gHitInfo.hitpos.X - pWall->point2Wall()->pos.X, gHitInfo.hitpos.Y - pWall->point2Wall()->y); else - nHOffset = approxDist(gHitInfo.hitpos.X - pWall->x, gHitInfo.hitpos.Y - pWall->y); + nHOffset = approxDist(gHitInfo.hitpos.X - pWall->pos.X, gHitInfo.hitpos.Y - pWall->y); nHOffset = pWall->xpan() + ((nHOffset*pWall->xrepeat) << 3) / nLength; nHOffset %= nSizX; diff --git a/source/games/blood/src/gib.cpp b/source/games/blood/src/gib.cpp index 4b1d39da0..574b8b315 100644 --- a/source/games/blood/src/gib.cpp +++ b/source/games/blood/src/gib.cpp @@ -436,7 +436,7 @@ void GibFX(walltype* pWall, GIBFX * pGFX, int a3, int a4, int a5, int a6, CGibVe int r1 = Random(a6); int r2 = Random(a5); int r3 = Random(a4); - auto pGib = gFX.fxSpawnActor(pGFX->fxId, pSector, pWall->x+r3, pWall->y+r2, a3+r1, 0); + auto pGib = gFX.fxSpawnActor(pGFX->fxId, pSector, pWall->pos.X+r3, pWall->y+r2, a3+r1, 0); if (pGib) { if (pGFX->at1 < 0) @@ -463,7 +463,7 @@ void GibWall(walltype* pWall, GIBTYPE nGibType, CGibVelocity *pVel) assert(nGibType >= 0 && nGibType < kGibMax); int cx, cy, cz, wx, wy, wz; - cx = (pWall->x+pWall->point2Wall()->x)>>1; + cx = (pWall->pos.X+pWall->point2Wall()->pos.X)>>1; cy = (pWall->y+pWall->point2Wall()->y)>>1; auto pSector = pWall->sectorp(); int32_t ceilZ, floorZ; @@ -474,7 +474,7 @@ void GibWall(walltype* pWall, GIBTYPE nGibType, CGibVelocity *pVel) ceilZ = ClipLow(ceilZ, ceilZ2); floorZ = ClipHigh(floorZ, floorZ2); wz = floorZ-ceilZ; - wx = pWall->point2Wall()->x-pWall->x; + wx = pWall->point2Wall()->pos.X-pWall->pos.X; wy = pWall->point2Wall()->y-pWall->y; cz = (ceilZ+floorZ)>>1; diff --git a/source/games/blood/src/nnexts.cpp b/source/games/blood/src/nnexts.cpp index 43e092606..d000e8072 100644 --- a/source/games/blood/src/nnexts.cpp +++ b/source/games/blood/src/nnexts.cpp @@ -3555,7 +3555,7 @@ void useSeqSpawnerGen(DBloodActor* sourceactor, int objType, sectortype* pSector if (pXSource->data4 > 0) { int cx, cy, cz; - cx = (pWall->x + pWall->point2Wall()->x) >> 1; + cx = (pWall->pos.X + pWall->point2Wall()->pos.X) >> 1; cy = (pWall->y + pWall->point2Wall()->y) >> 1; auto pMySector = pWall->sectorp(); int32_t ceilZ, floorZ; diff --git a/source/games/blood/src/triggers.cpp b/source/games/blood/src/triggers.cpp index c0ff304d5..482bbbc5d 100644 --- a/source/games/blood/src/triggers.cpp +++ b/source/games/blood/src/triggers.cpp @@ -1902,7 +1902,7 @@ void AlignSlopes(void) { auto pNextSector = pWall->nextSector(); - int x = (pWall->x+pWall2->x)/2; + int x = (pWall->pos.X+pWall2->pos.X)/2; int y = (pWall->y+pWall2->y)/2; viewInterpolateSector(§); alignflorslope(§, x, y, getflorzofslopeptr(pNextSector, x, y)); @@ -1966,7 +1966,7 @@ void trInit(TArray& actors) gBusy.Clear(); for(auto& wal : wall) { - wal.baseWall.X = wal.x; + wal.baseWall.X = wal.pos.X; wal.baseWall.Y = wal.y; } for(auto actor : actors) @@ -2019,7 +2019,7 @@ void trInit(TArray& actors) TranslateSector(pSector, 0, -65536, pSprite1->x, pSprite1->y, pSprite1->x, pSprite1->y, pSprite1->ang, pSprite2->x, pSprite2->y, pSprite2->ang, pSector->type == kSectorSlide); for(auto& wal : wallsofsector(pSector)) { - wal.baseWall.X = wal.x; + wal.baseWall.X = wal.pos.X; wal.baseWall.Y = wal.y; } BloodSectIterator it(pSector); @@ -2038,7 +2038,7 @@ void trInit(TArray& actors) TranslateSector(pSector, 0, -65536, pSprite1->x, pSprite1->y, pSprite1->x, pSprite1->y, 0, pSprite1->x, pSprite1->y, pSprite1->ang, pSector->type == kSectorRotate); for (auto& wal : wallsofsector(pSector)) { - wal.baseWall.X = wal.x; + wal.baseWall.X = wal.pos.X; wal.baseWall.Y = wal.y; } BloodSectIterator it(pSector); diff --git a/source/games/duke/src/_polymost.cpp b/source/games/duke/src/_polymost.cpp index 070d3aeff..dda1797ec 100644 --- a/source/games/duke/src/_polymost.cpp +++ b/source/games/duke/src/_polymost.cpp @@ -164,7 +164,7 @@ void renderMirror(int cposx, int cposy, int cposz, binangle cang, fixedhoriz cho int dst = 0x7fffffff, i = 0; for (int k = 0; k < mirrorcnt; k++) { - int j = abs(mirrorwall[k]->x - cposx) + abs(mirrorwall[k]->y - cposy); + int j = abs(mirrorwall[k]->pos.X - cposx) + abs(mirrorwall[k]->y - cposy); if (j < dst) dst = j, i = k; } diff --git a/source/games/duke/src/actors.cpp b/source/games/duke/src/actors.cpp index b10c382c0..3f7158b5e 100644 --- a/source/games/duke/src/actors.cpp +++ b/source/games/duke/src/actors.cpp @@ -4205,8 +4205,8 @@ void handle_se20(DDukeActor* actor) } auto& wal = actor->temp_walls; - dragpoint(wal[0], wal[0]->x + x, wal[0]->y + l); - dragpoint(wal[1], wal[1]->x + x, wal[1]->y + l); + dragpoint(wal[0], wal[0]->pos.X + x, wal[0]->y + l); + dragpoint(wal[1], wal[1]->pos.X + x, wal[1]->y + l); for (int p = connecthead; p >= 0; p = connectpoint2[p]) if (ps[p].cursector == actor->spr.sector() && ps[p].on_ground) diff --git a/source/games/duke/src/actors_d.cpp b/source/games/duke/src/actors_d.cpp index bbe50f30f..633755353 100644 --- a/source/games/duke/src/actors_d.cpp +++ b/source/games/duke/src/actors_d.cpp @@ -270,13 +270,13 @@ void hitradius_d(DDukeActor* actor, int r, int hp1, int hp2, int hp3, int h if (((dasectp->ceilingz - actor->spr.z) >> 8) < r) { auto wal = dasectp->firstWall(); - int d = abs(wal->x - actor->spr.x) + abs(wal->y - actor->spr.y); + int d = abs(wal->pos.X - actor->spr.x) + abs(wal->y - actor->spr.y); if (d < r) fi.checkhitceiling(dasectp); else { auto thirdpoint = wal->point2Wall()->point2Wall(); - d = abs(thirdpoint->x - actor->spr.x) + abs(thirdpoint->y - actor->spr.y); + d = abs(thirdpoint->pos.X - actor->spr.x) + abs(thirdpoint->y - actor->spr.y); if (d < r) fi.checkhitceiling(dasectp); } @@ -284,18 +284,18 @@ void hitradius_d(DDukeActor* actor, int r, int hp1, int hp2, int hp3, int h for (auto& wal : wallsofsector(dasectp)) { - if ((abs(wal.x - actor->spr.x) + abs(wal.y - actor->spr.y)) < r) + if ((abs(wal.pos.X - actor->spr.x) + abs(wal.y - actor->spr.y)) < r) { if (wal.twoSided()) { search.Add(wal.nextSector()); } - int x1 = (((wal.x + wal.point2Wall()->x) >> 1) + actor->spr.x) >> 1; + int x1 = (((wal.pos.X + wal.point2Wall()->pos.X) >> 1) + actor->spr.x) >> 1; int y1 = (((wal.y + wal.point2Wall()->y) >> 1) + actor->spr.y) >> 1; sectortype* sect = wal.sectorp(); updatesector(x1, y1, §); if (sect && cansee(x1, y1, actor->spr.z, sect, actor->spr.x, actor->spr.y, actor->spr.z, actor->spr.sector())) - fi.checkhitwall(actor, &wal, wal.x, wal.y, actor->spr.z, actor->spr.picnum); + fi.checkhitwall(actor, &wal, wal.pos.X, wal.y, actor->spr.z, actor->spr.picnum); } } } @@ -3656,7 +3656,7 @@ void moveeffectors_d(void) //STATNUM 3 auto sc = act->sector(); if (sc->wallnum != 4) continue; auto wal = sc->firstWall() + 2; - alignflorslope(act->spr.sector(), wal->x, wal->y, wal->nextSector()->floorz); + alignflorslope(act->spr.sector(), wal->pos.X, wal->y, wal->nextSector()->floorz); } } diff --git a/source/games/duke/src/actors_lava.cpp b/source/games/duke/src/actors_lava.cpp index 2e9b98a13..b0091ec53 100644 --- a/source/games/duke/src/actors_lava.cpp +++ b/source/games/duke/src/actors_lava.cpp @@ -284,7 +284,7 @@ void dojaildoor(void) { for (auto& wal : wallsofsector(sectp)) { - int x = wal.x; + int x = wal.pos.X; int y = wal.y; switch (jaildoordir[i]) { @@ -336,23 +336,23 @@ void dojaildoor(void) switch (jaildoordir[i]) { default: // make case of bad parameters well defined. - x = wal.x; + x = wal.pos.X; y = wal.y; break; case 10: - x = wal.x; + x = wal.pos.X; y = wal.y + speed; break; case 20: - x = wal.x - speed; + x = wal.pos.X - speed; y = wal.y; break; case 30: - x = wal.x; + x = wal.pos.X; y = wal.y - speed; break; case 40: - x = wal.x + speed; + x = wal.pos.X + speed; y = wal.y; break; } @@ -418,23 +418,23 @@ void moveminecart(void) switch (minecartdir[i]) { default: // make case of bad parameters well defined. - x = wal.x; + x = wal.pos.X; y = wal.y; break; case 10: - x = wal.x; + x = wal.pos.X; y = wal.y + speed; break; case 20: - x = wal.x - speed; + x = wal.pos.X - speed; y = wal.y; break; case 30: - x = wal.x; + x = wal.pos.X; y = wal.y - speed; break; case 40: - x = wal.x + speed; + x = wal.pos.X + speed; y = wal.y; break; } @@ -472,23 +472,23 @@ void moveminecart(void) switch (minecartdir[i]) { default: // make case of bad parameters well defined. - x = wal.x; + x = wal.pos.X; y = wal.y; break; case 10: - x = wal.x; + x = wal.pos.X; y = wal.y + speed; break; case 20: - x = wal.x - speed; + x = wal.pos.X - speed; y = wal.y; break; case 30: - x = wal.x; + x = wal.pos.X; y = wal.y - speed; break; case 40: - x = wal.x + speed; + x = wal.pos.X + speed; y = wal.y; break; } @@ -501,7 +501,7 @@ void moveminecart(void) min_x = min_y = 0x20000; for (auto& wal : wallsofsector(csect)) { - x = wal.x; + x = wal.pos.X; y = wal.y; if (x > max_x) max_x = x; diff --git a/source/games/duke/src/actors_r.cpp b/source/games/duke/src/actors_r.cpp index df8dca7f6..b65ab5789 100644 --- a/source/games/duke/src/actors_r.cpp +++ b/source/games/duke/src/actors_r.cpp @@ -228,13 +228,13 @@ void hitradius_r(DDukeActor* actor, int r, int hp1, int hp2, int hp3, int h if (((dasectp->ceilingz - actor->spr.z) >> 8) < r) { auto wal = dasectp->firstWall(); - int d = abs(wal->x - actor->spr.x) + abs(wal->y - actor->spr.y); + int d = abs(wal->pos.X - actor->spr.x) + abs(wal->y - actor->spr.y); if (d < r) fi.checkhitceiling(dasectp); else { auto thirdpoint = wal->point2Wall()->point2Wall(); - d = abs(thirdpoint->x - actor->spr.x) + abs(thirdpoint->y - actor->spr.y); + d = abs(thirdpoint->pos.X - actor->spr.x) + abs(thirdpoint->y - actor->spr.y); if (d < r) fi.checkhitceiling(dasectp); } @@ -242,18 +242,18 @@ void hitradius_r(DDukeActor* actor, int r, int hp1, int hp2, int hp3, int h for (auto& wal : wallsofsector(dasectp)) { - if ((abs(wal.x - actor->spr.x) + abs(wal.y - actor->spr.y)) < r) + if ((abs(wal.pos.X - actor->spr.x) + abs(wal.y - actor->spr.y)) < r) { if (wal.twoSided()) { search.Add(wal.nextSector()); } - int x1 = (((wal.x + wal.point2Wall()->x) >> 1) + actor->spr.x) >> 1; + int x1 = (((wal.pos.X + wal.point2Wall()->pos.X) >> 1) + actor->spr.x) >> 1; int y1 = (((wal.y + wal.point2Wall()->y) >> 1) + actor->spr.y) >> 1; auto sect = wal.sectorp(); updatesector(x1, y1, §); if (sect != nullptr && cansee(x1, y1, actor->spr.z, sect, actor->spr.x, actor->spr.y, actor->spr.z, actor->spr.sector())) - fi.checkhitwall(actor, &wal, wal.x, wal.y, actor->spr.z, actor->spr.picnum); + fi.checkhitwall(actor, &wal, wal.pos.X, wal.y, actor->spr.z, actor->spr.picnum); } } } @@ -3615,7 +3615,7 @@ void moveeffectors_r(void) //STATNUM 3 auto sc = act->sector(); if (sc->wallnum != 4) continue; auto wal = sc->firstWall() + 2; - alignflorslope(act->sector(), wal->x, wal->y, wal->nextSector()->floorz); + alignflorslope(act->sector(), wal->pos.X, wal->y, wal->nextSector()->floorz); } } diff --git a/source/games/duke/src/gameexec.cpp b/source/games/duke/src/gameexec.cpp index 0fdd211c1..d4b692a69 100644 --- a/source/games/duke/src/gameexec.cpp +++ b/source/games/duke/src/gameexec.cpp @@ -964,7 +964,7 @@ void DoWall(bool bSet, int lVar1, int lLabelID, int lVar2, DDukeActor* sActor, i switch (lLabelID) { case WALL_X: - if (!bSet) SetGameVarID(lVar2, wallp->x, sActor, sPlayer); + if (!bSet) SetGameVarID(lVar2, wallp->pos.X, sActor, sPlayer); break; case WALL_Y: if (bSet) SetGameVarID(lVar2, wallp->y, sActor, sPlayer); diff --git a/source/games/duke/src/premap.cpp b/source/games/duke/src/premap.cpp index 343c9a710..15be35fe5 100644 --- a/source/games/duke/src/premap.cpp +++ b/source/games/duke/src/premap.cpp @@ -716,7 +716,7 @@ void prelevel_common(int g) if (sectp->lotag == -1) { - ps[0].exitx = sectp->firstWall()->x; + ps[0].exitx = sectp->firstWall()->pos.X; ps[0].exity = sectp->firstWall()->y; continue; } diff --git a/source/games/duke/src/sectors.cpp b/source/games/duke/src/sectors.cpp index cad6fdc2a..30070d6a7 100644 --- a/source/games/duke/src/sectors.cpp +++ b/source/games/duke/src/sectors.cpp @@ -288,7 +288,7 @@ int* animateptr(int type, int index, bool write) return §or[index].ceilingz; case anim_vertexx: if (write) wall[index].moved(); - return &wall[index].x; + return &wall[index].pos.X; case anim_vertexy: if (write) wall[index].moved(); return &wall[index].y; @@ -506,7 +506,7 @@ static void handle_st09(sectortype* sptr, DDukeActor* actor) dax = 0L, day = 0L; for (auto& wal : wallsofsector(sptr)) { - dax += wal.x; + dax += wal.pos.X; day += wal.y; } dax /= sptr->wallnum; @@ -517,7 +517,7 @@ static void handle_st09(sectortype* sptr, DDukeActor* actor) wallfind[0] = nullptr; wallfind[1] = nullptr; for (auto& wal : wallsofsector(sptr)) - if ((wal.x == dax) || (wal.y == day)) + if ((wal.pos.X == dax) || (wal.y == day)) { if (wallfind[0] == nullptr) wallfind[0] = &wal; @@ -533,17 +533,17 @@ static void handle_st09(sectortype* sptr, DDukeActor* actor) auto prevwall = wal - 1; if (prevwall < sptr->firstWall()) prevwall += sptr->wallnum; - if ((wal->x == dax) && (wal->y == day)) + if ((wal->pos.X == dax) && (wal->y == day)) { - dax2 = ((prevwall->x + wal->point2Wall()->x) >> 1) - wal->x; + dax2 = ((prevwall->pos.X + wal->point2Wall()->pos.X) >> 1) - wal->pos.X; day2 = ((prevwall->y + wal->point2Wall()->y) >> 1) - wal->y; if (dax2 != 0) { - dax2 = wal->point2Wall()->point2Wall()->x; - dax2 -= wal->point2Wall()->x; - setanimation(sptr, anim_vertexx, wal, wal->x + dax2, sp); - setanimation(sptr, anim_vertexx, prevwall, prevwall->x + dax2, sp); - setanimation(sptr, anim_vertexx, wal->point2Wall(), wal->point2Wall()->x + dax2, sp); + dax2 = wal->point2Wall()->point2Wall()->pos.X; + dax2 -= wal->point2Wall()->pos.X; + setanimation(sptr, anim_vertexx, wal, wal->pos.X + dax2, sp); + setanimation(sptr, anim_vertexx, prevwall, prevwall->pos.X + dax2, sp); + setanimation(sptr, anim_vertexx, wal->point2Wall(), wal->point2Wall()->pos.X + dax2, sp); callsound(sptr, actor); } else if (day2 != 0) @@ -558,7 +558,7 @@ static void handle_st09(sectortype* sptr, DDukeActor* actor) } else { - dax2 = ((prevwall->x + wal->point2Wall()->x) >> 1) - wal->x; + dax2 = ((prevwall->pos.X + wal->point2Wall()->pos.X) >> 1) - wal->pos.X; day2 = ((prevwall->y + wal->point2Wall()->y) >> 1) - wal->y; if (dax2 != 0) { @@ -974,8 +974,8 @@ void operatesectors(sectortype* sptr, DDukeActor *actor) if (!isRR()) break; for (auto& wal : wallsofsector(sptr)) { - setanimation(sptr, anim_vertexx, &wal, wal.x + 1024, 4); - if (wal.twoSided()) setanimation(sptr, anim_vertexx, wal.nextWall(), wal.nextWall()->x + 1024, 4); + setanimation(sptr, anim_vertexx, &wal, wal.pos.X + 1024, 4); + if (wal.twoSided()) setanimation(sptr, anim_vertexx, wal.nextWall(), wal.nextWall()->pos.X + 1024, 4); } break; diff --git a/source/games/duke/src/sectors_d.cpp b/source/games/duke/src/sectors_d.cpp index 9685bce9f..c466a7094 100644 --- a/source/games/duke/src/sectors_d.cpp +++ b/source/games/duke/src/sectors_d.cpp @@ -250,7 +250,7 @@ bool checkhitswitch_d(int snum, walltype* wwal, DDukeActor *act) lotag = wwal->lotag; if (lotag == 0) return 0; hitag = wwal->hitag; - sx = wwal->x; + sx = wwal->pos.X; sy = wwal->y; picnum = wwal->picnum; switchpal = wwal->pal; diff --git a/source/games/duke/src/sectors_r.cpp b/source/games/duke/src/sectors_r.cpp index 865a6d1f7..9a74b1afa 100644 --- a/source/games/duke/src/sectors_r.cpp +++ b/source/games/duke/src/sectors_r.cpp @@ -369,7 +369,7 @@ bool checkhitswitch_r(int snum, walltype* wwal, DDukeActor* act) lotag = wwal->lotag; if (lotag == 0) return 0; hitag = wwal->hitag; - sx = wwal->x; + sx = wwal->pos.X; sy = wwal->y; picnum = wwal->picnum; switchpal = wwal->pal; @@ -946,7 +946,7 @@ static void lotsofpopcorn(DDukeActor *actor, walltype* wal, int n) j = n + 1; - int x1 = wal->x; + int x1 = wal->pos.X; int y1 = wal->y; auto delta = wal->delta(); @@ -2817,7 +2817,7 @@ void dofurniture(walltype* wlwal, sectortype* sectp, int snum) var_cx = 4; for(auto& wal : wallsofsector(nextsect)) { - x = wal.x; + x = wal.pos.X; y = wal.y; if (x > max_x) max_x = x; @@ -2850,7 +2850,7 @@ void dofurniture(walltype* wlwal, sectortype* sectp, int snum) S_PlayActorSound(389, ps[snum].GetActor()); for(auto& wal : wallsofsector(nextsect)) { - x = wal.x; + x = wal.pos.X; y = wal.y; switch (wlwal->lotag) { @@ -2859,7 +2859,7 @@ void dofurniture(walltype* wlwal, sectortype* sectp, int snum) dragpoint(&wal, x, y); break; case 41: - x = wal.x - var_cx; + x = wal.pos.X - var_cx; dragpoint(&wal, x, y); break; case 40: @@ -2867,7 +2867,7 @@ void dofurniture(walltype* wlwal, sectortype* sectp, int snum) dragpoint(&wal, x, y); break; case 43: - x = wal.x + var_cx; + x = wal.pos.X + var_cx; dragpoint(&wal, x, y); break; } @@ -2877,7 +2877,7 @@ void dofurniture(walltype* wlwal, sectortype* sectp, int snum) { for(auto& wal : wallsofsector(nextsect)) { - x = wal.x; + x = wal.pos.X; y = wal.y; switch (wlwal->lotag) { @@ -2886,7 +2886,7 @@ void dofurniture(walltype* wlwal, sectortype* sectp, int snum) dragpoint(&wal, x, y); break; case 41: - x = wal.x + (var_cx - 2); + x = wal.pos.X + (var_cx - 2); dragpoint(&wal, x, y); break; case 40: @@ -2894,7 +2894,7 @@ void dofurniture(walltype* wlwal, sectortype* sectp, int snum) dragpoint(&wal, x, y); break; case 43: - x = wal.x - (var_cx - 2); + x = wal.pos.X - (var_cx - 2); dragpoint(&wal, x, y); break; } diff --git a/source/games/duke/src/spawn.cpp b/source/games/duke/src/spawn.cpp index 54c19eb9a..9e2d421ea 100644 --- a/source/games/duke/src/spawn.cpp +++ b/source/games/duke/src/spawn.cpp @@ -788,7 +788,7 @@ void spawneffector(DDukeActor* actor, TArray* actors) for (auto& wal : wallsofsector(sectp)) { - d = FindDistance2D(actor->spr.x - wal.x, actor->spr.y - wal.y); + d = FindDistance2D(actor->spr.x - wal.pos.X, actor->spr.y - wal.y); if (d < q) { q = d; @@ -802,7 +802,7 @@ void spawneffector(DDukeActor* actor, TArray* actors) for (auto& wal : wallsofsector(sectp)) { - d = FindDistance2D(actor->spr.x - wal.x, actor->spr.y - wal.y); + d = FindDistance2D(actor->spr.x - wal.pos.X, actor->spr.y - wal.y); if (d < q && &wal != actor->temp_walls[0]) { q = d; @@ -962,12 +962,12 @@ void spawneffector(DDukeActor* actor, TArray* actors) t[1] = tempwallptr; for (auto& wal : wallsofsector(sectp)) { - msx[tempwallptr] = wal.x - actor->spr.x; + msx[tempwallptr] = wal.pos.X - actor->spr.x; msy[tempwallptr] = wal.y - actor->spr.y; tempwallptr++; if (tempwallptr > 2047) { - I_Error("Too many moving sectors at (%d,%d).\n", wal.x, wal.y); + I_Error("Too many moving sectors at (%d,%d).\n", wal.pos.X, wal.y); } } if (actor->spr.lotag == SE_30_TWO_WAY_TRAIN || actor->spr.lotag == SE_6_SUBWAY || actor->spr.lotag == SE_14_SUBWAY_CAR || actor->spr.lotag == SE_5_BOSS) @@ -1087,7 +1087,7 @@ void lotsofglass(DDukeActor *actor, walltype* wal, int n) return; } - int x1 = wal->x; + int x1 = wal->pos.X; int y1 = wal->y; auto delta = wal->delta() / (n + 1); @@ -1142,7 +1142,7 @@ void ceilingglass(DDukeActor* actor, sectortype* sectp, int n) for (auto& wal : wallsofsector(sectp)) { - int x1 = wal.x; + int x1 = wal.pos.X; int y1 = wal.y; auto delta = wal.delta() / (n + 1); @@ -1181,7 +1181,7 @@ void lotsofcolourglass(DDukeActor* actor, walltype* wal, int n) return; } - int x1 = wal->x; + int x1 = wal->pos.X; int y1 = wal->y; auto delta = wal->delta() / (n + 1); diff --git a/source/games/exhumed/src/init.cpp b/source/games/exhumed/src/init.cpp index 7797bf94f..5b96fd2a4 100644 --- a/source/games/exhumed/src/init.cpp +++ b/source/games/exhumed/src/init.cpp @@ -227,14 +227,14 @@ void SnapSectors(sectortype* pSectorA, sectortype* pSectorB, int b) int bestx = 0x7FFFFFF; int besty = bestx; - int x = wal1.x; + int x = wal1.pos.X; int y = wal1.y; walltype* bestwall = nullptr; for(auto& wal2 : wallsofsector(pSectorB)) { - int thisx = x - wal2.x; + int thisx = x - wal2.pos.X; int thisy = y - wal2.y; int thisdist = abs(thisx) + abs(thisy); int bestdist = abs(bestx) + abs(besty); @@ -247,7 +247,7 @@ void SnapSectors(sectortype* pSectorA, sectortype* pSectorB, int b) } } - dragpoint(bestwall, bestwall->x + bestx, bestwall->y + besty); + dragpoint(bestwall, bestwall->pos.X + bestx, bestwall->y + besty); } if (b) { diff --git a/source/games/exhumed/src/move.cpp b/source/games/exhumed/src/move.cpp index 8d462fe60..ed4d4be04 100644 --- a/source/games/exhumed/src/move.cpp +++ b/source/games/exhumed/src/move.cpp @@ -822,7 +822,7 @@ void CreatePushBlock(sectortype* pSector) for (auto& wal : wallsofsector(pSector)) { - xSum += wal.x; + xSum += wal.pos.X; ySum += wal.y; } @@ -846,7 +846,7 @@ void CreatePushBlock(sectortype* pSector) for (auto& wal : wallsofsector(pSector)) { - uint32_t xDiff = abs(xAvg - wal.x); + uint32_t xDiff = abs(xAvg - wal.pos.X); uint32_t yDiff = abs(yAvg - wal.y); uint32_t sqrtNum = xDiff * xDiff + yDiff * yDiff; @@ -1058,7 +1058,7 @@ void MoveSector(sectortype* pSector, int nAngle, int *nXVel, int *nYVel) for(auto& wal : wallsofsector(pSector)) { - dragpoint(&wal, xvect + wal.x, yvect + wal.y); + dragpoint(&wal, xvect + wal.pos.X, yvect + wal.y); } pBlockInfo->x += xvect; diff --git a/source/games/exhumed/src/object.cpp b/source/games/exhumed/src/object.cpp index 022132825..33a6c56df 100644 --- a/source/games/exhumed/src/object.cpp +++ b/source/games/exhumed/src/object.cpp @@ -412,12 +412,12 @@ DExhumedActor* FindWallSprites(sectortype* pSector) for (auto& wal : wallsofsector(pSector)) { - if (wal.x < var_24) { - var_24 = wal.x; + if (wal.pos.X < var_24) { + var_24 = wal.pos.X; } - if (esi < wal.x) { - esi = wal.x; + if (esi < wal.pos.X) { + esi = wal.pos.X; } if (ecx > wal.y) { @@ -992,22 +992,22 @@ int BuildSlide(int nChannel, walltype* pStartWall, walltype* pWall1, walltype* p SlideData[nSlide].pWall2 = pWall2; SlideData[nSlide].pWall3 = pWall3; - SlideData[nSlide].x1 = pStartWall->x; + SlideData[nSlide].x1 = pStartWall->pos.X; SlideData[nSlide].y1 = pStartWall->y; - SlideData[nSlide].x2 = pWall2->x; + SlideData[nSlide].x2 = pWall2->pos.X; SlideData[nSlide].y2 = pWall2->y; - SlideData[nSlide].x3 = pWall1->x; + SlideData[nSlide].x3 = pWall1->pos.X; SlideData[nSlide].y3 = pWall1->y; - SlideData[nSlide].x4 = pWall3->x; + SlideData[nSlide].x4 = pWall3->pos.X; SlideData[nSlide].y4 = pWall3->y; - SlideData[nSlide].x5 = p2ndLastWall->x; + SlideData[nSlide].x5 = p2ndLastWall->pos.X; SlideData[nSlide].y5 = p2ndLastWall->y; - SlideData[nSlide].x6 = pWall4->x; + SlideData[nSlide].x6 = pWall4->pos.X; SlideData[nSlide].y6 = pWall4->y; StartInterpolation(pStartWall, Interp_Wall_X); @@ -1028,7 +1028,7 @@ int BuildSlide(int nChannel, walltype* pStartWall, walltype* pWall1, walltype* p SlideData[nSlide].pActor = pActor; pSprite->cstat = CSTAT_SPRITE_INVISIBLE; - pSprite->x = pStartWall->x; + pSprite->x = pStartWall->pos.X; pSprite->y = pStartWall->y; pSprite->z = pSector->floorz; pSprite->backuppos(); @@ -1081,7 +1081,7 @@ void AISlide::Tick(RunListEvent* ev) if (cx == 1) { auto pWall = SlideData[nSlide].pWall1; - int x = pWall->x; + int x = pWall->pos.X; int y = pWall->y; int nSeekA = LongSeek(&x, SlideData[nSlide].x5, 20, 20); @@ -1106,13 +1106,13 @@ void AISlide::Tick(RunListEvent* ev) pWall = SlideData[nSlide].pStartWall; y = pWall->y + var_24; - x = pWall->x + var_20; + x = pWall->pos.X + var_20; dragpoint(SlideData[nSlide].pStartWall, x, y); pWall = SlideData[nSlide].pWall3; - x = pWall->x; + x = pWall->pos.X; y = pWall->y; int nSeekC = LongSeek(&x, SlideData[nSlide].x6, 20, 20); @@ -1131,7 +1131,7 @@ void AISlide::Tick(RunListEvent* ev) pWall = SlideData[nSlide].pWall2; - x = pWall->x + var_20; + x = pWall->pos.X + var_20; y = pWall->y + var_24; dragpoint(SlideData[nSlide].pWall2, x, y); @@ -1139,7 +1139,7 @@ void AISlide::Tick(RunListEvent* ev) else if (cx == 0) // right branch { auto pWall = SlideData[nSlide].pStartWall; - int x = pWall->x; + int x = pWall->pos.X; int y = pWall->y; int nSeekA = LongSeek(&x, SlideData[nSlide].x1, 20, 20); @@ -1159,13 +1159,13 @@ void AISlide::Tick(RunListEvent* ev) pWall = SlideData[nSlide].pWall1; y = pWall->y + var_28; - x = pWall->x + var_1C; + x = pWall->pos.X + var_1C; dragpoint(SlideData[nSlide].pWall1, x, y); pWall = SlideData[nSlide].pWall2; - x = pWall->x; + x = pWall->pos.X; y = pWall->y; int nSeekC = LongSeek(&x, SlideData[nSlide].x2, 20, 20); @@ -1185,7 +1185,7 @@ void AISlide::Tick(RunListEvent* ev) pWall = SlideData[nSlide].pWall3; y = pWall->y + var_28; - x = pWall->x + var_1C; + x = pWall->pos.X + var_1C; dragpoint(SlideData[nSlide].pWall3, x, y); } @@ -1578,7 +1578,7 @@ DExhumedActor* BuildEnergyBlock(sectortype* pSector) for(auto& wal : wallsofsector(pSector)) { - x += wal.x; + x += wal.pos.X; y += wal.y; wal.picnum = kClockSymbol16; @@ -2544,7 +2544,7 @@ void PostProcess() if (§ != §j && sectj.Speed && !(sect.Flag & kSectLava)) { - int xVal = abs(sect.firstWall()->x - sectj.firstWall()->x); + int xVal = abs(sect.firstWall()->pos.X - sectj.firstWall()->pos.X); int yVal = abs(sect.firstWall()->y - sectj.firstWall()->y); if (xVal < 15000 && yVal < 15000 && (xVal + yVal < var_20)) diff --git a/source/games/exhumed/src/sound.cpp b/source/games/exhumed/src/sound.cpp index 94ec116c7..53bc2ad17 100644 --- a/source/games/exhumed/src/sound.cpp +++ b/source/games/exhumed/src/sound.cpp @@ -673,7 +673,7 @@ void CheckAmbience(sectortype* sect) walltype* pWall = pSector2->firstWall(); if (!soundEngine->IsSourcePlayingSomething(SOURCE_Ambient, &amb, 0)) { - vec3_t v = { pWall->x, pWall->y, pSector2->floorz }; + vec3_t v = { pWall->pos.X, pWall->y, pSector2->floorz }; amb = GetSoundPos(&v); soundEngine->StartSound(SOURCE_Ambient, &amb, nullptr, CHAN_BODY, CHANF_TRANSIENT, sect->Sound + 1, 1.f, ATTN_NORM); return; @@ -688,7 +688,7 @@ void CheckAmbience(sectortype* sect) } else { - vec3_t v = { pWall->x, pWall->y, pSector2->floorz }; + vec3_t v = { pWall->pos.X, pWall->y, pSector2->floorz }; amb = GetSoundPos(&v); } return 1; diff --git a/source/games/exhumed/src/switch.cpp b/source/games/exhumed/src/switch.cpp index 5c8760438..58fcb38cc 100644 --- a/source/games/exhumed/src/switch.cpp +++ b/source/games/exhumed/src/switch.cpp @@ -290,7 +290,7 @@ void AISWStepOn::TouchFloor(RunListEvent* ev) if (var_14 != sRunChannels[nChannel].c) { auto pWall = pSector->firstWall(); - PlayFXAtXYZ(StaticSound[nSwitchSound], pWall->x, pWall->y, pSector->floorz); + PlayFXAtXYZ(StaticSound[nSwitchSound], pWall->pos.X, pWall->y, pSector->floorz); assert(sRunChannels[nChannel].c < 8); @@ -510,7 +510,7 @@ void AISWPressWall::Use(RunListEvent* ev) auto pWall = SwitchData[nSwitch].pWall; auto pSector = SwitchData[nSwitch].pSector; - PlayFXAtXYZ(StaticSound[nSwitchSound], pWall->x, pWall->y, 0, CHANF_LISTENERZ); + PlayFXAtXYZ(StaticSound[nSwitchSound], pWall->pos.X, pWall->y, 0, CHANF_LISTENERZ); } END_PS_NS diff --git a/source/games/sw/src/_polymost.cpp b/source/games/sw/src/_polymost.cpp index ec53063f6..721c6b7ac 100644 --- a/source/games/sw/src/_polymost.cpp +++ b/source/games/sw/src/_polymost.cpp @@ -209,7 +209,7 @@ void JS_DrawMirrors(PLAYERp pp, int tx, int ty, int tz, fixed_t tpq16ang, fixed if (bIsWallMirror) { - j = abs(mirror[cnt].mirrorWall->x - tx); + j = abs(mirror[cnt].mirrorWall->pos.X - tx); j += abs(mirror[cnt].mirrorWall->y - ty); if (j < dist) dist = j; @@ -242,7 +242,7 @@ void JS_DrawMirrors(PLAYERp pp, int tx, int ty, int tz, fixed_t tpq16ang, fixed auto wal = mirror[cnt].mirrorWall; // Get wall midpoint for offset in mirror view - midx = (wal->x + wal->point2Wall()->x) / 2; + midx = (wal->pos.X + wal->point2Wall()->pos.X) / 2; midy = (wal->y + wal->point2Wall()->y) / 2; // Finish finding offsets diff --git a/source/games/sw/src/break.cpp b/source/games/sw/src/break.cpp index 05090dee6..d0f6334d9 100644 --- a/source/games/sw/src/break.cpp +++ b/source/games/sw/src/break.cpp @@ -740,7 +740,7 @@ int WallBreakPosition(walltype* wp, sectortype** sectp, int *x, int *y, int *z, ASSERT(*sectp); // midpoint of wall - *x = (wp->x + wp->x) >> 1; + *x = (wp->pos.X + wp->pos.X) >> 1; *y = (wp->y + wp->y) >> 1; if (!wp->twoSided()) diff --git a/source/games/sw/src/interpso.cpp b/source/games/sw/src/interpso.cpp index 2be220f01..144c78f4d 100644 --- a/source/games/sw/src/interpso.cpp +++ b/source/games/sw/src/interpso.cpp @@ -97,7 +97,7 @@ static int &getvalue(so_interp::interp_data& element, bool write) { case soi_wallx: if (write) wall[index].moved(); - return wall[index].x; + return wall[index].pos.X; case soi_wally: if (write) wall[index].moved(); return wall[index].y; diff --git a/source/games/sw/src/jsector.cpp b/source/games/sw/src/jsector.cpp index 64cf28703..f54eec583 100644 --- a/source/games/sw/src/jsector.cpp +++ b/source/games/sw/src/jsector.cpp @@ -343,7 +343,7 @@ void JS_InitMirrors(void) if (!Found_Cam) { Printf("Cound not find the camera view sprite for match %d\n", wal.hitag); - Printf("Map Coordinates: x = %d, y = %d\n", wal.x, wal.y); + Printf("Map Coordinates: x = %d, y = %d\n", wal.pos.X, wal.y); break; } @@ -373,7 +373,7 @@ void JS_InitMirrors(void) { Printf("Did not find drawtotile for camera number %d\n", mirrorcnt); Printf("wall(%d).hitag == %d\n", wallnum(&wal), wal.hitag); - Printf("Map Coordinates: x = %d, y = %d\n", wal.x, wal.y); + Printf("Map Coordinates: x = %d, y = %d\n", wal.pos.X, wal.y); RESET_BOOL1(&mirror[mirrorcnt].cameraActor->s()); } } @@ -525,7 +525,7 @@ void JS_DrawCameras(PLAYERp pp, int tx, int ty, int tz, double smoothratio) if (bIsWallMirror) { - j = abs(mirror[cnt].mirrorWall->x - tx); + j = abs(mirror[cnt].mirrorWall->pos.X - tx); j += abs(mirror[cnt].mirrorWall->y - ty); if (j < dist) dist = j; @@ -555,7 +555,7 @@ void JS_DrawCameras(PLAYERp pp, int tx, int ty, int tz, double smoothratio) auto wal = mirror[cnt].mirrorWall; // Get wall midpoint for offset in mirror view - midx = (wal->x + wal->point2Wall()->x) / 2; + midx = (wal->pos.X + wal->point2Wall()->pos.X) / 2; midy = (wal->y + wal->point2Wall()->y) / 2; // Finish finding offsets diff --git a/source/games/sw/src/player.cpp b/source/games/sw/src/player.cpp index 293615f23..8fd60ff44 100644 --- a/source/games/sw/src/player.cpp +++ b/source/games/sw/src/player.cpp @@ -2628,7 +2628,7 @@ void DoPlayerMoveVehicle(PLAYERp pp) { if (wal.extra && TEST(wal.extra, WALLFX_LOOP_OUTER|WALLFX_LOOP_OUTER_SECONDARY) == WALLFX_LOOP_OUTER) { - x[count] = wal.x; + x[count] = wal.pos.X; y[count] = wal.y; ox[count] = sop->xmid - sop->xorig[wallcount]; diff --git a/source/games/sw/src/sector.cpp b/source/games/sw/src/sector.cpp index 093e7d3ca..7302baa76 100644 --- a/source/games/sw/src/sector.cpp +++ b/source/games/sw/src/sector.cpp @@ -128,7 +128,7 @@ void WallSetupDontMove(void) { for(auto& wal : wall) { - if (wal.x < spl->x && wal.x > spu->x && wal.y < spl->y && wal.y > spu->y) + if (wal.pos.X < spl->x && wal.pos.X > spu->x && wal.y < spl->y && wal.y > spu->y) { SET(wal.extra, WALLFX_DONT_MOVE); } @@ -306,7 +306,7 @@ void WallSetup(void) if (!sw->type) sw->orig_xy = wall_num->y - (sw->range >> 2); else - sw->orig_xy = wall_num->x - (sw->range >> 2); + sw->orig_xy = wall_num->pos.X - (sw->range >> 2); sw->sintable_ndx = cnt * (2048 / num_points); } @@ -597,7 +597,7 @@ void SectorMidPoint(sectortype* sectp, int *xmid, int *ymid, int *zmid) for(auto& wal : wallsofsector(sectp)) { - xsum += wal.x; + xsum += wal.pos.X; ysum += wal.y; } @@ -2477,7 +2477,7 @@ void DoSineWaveFloor(void) wal = sect->firstWall() + 2; //Pass (Sector, x, y, z) - alignflorslope(sect,wal->x,wal->y, wal->nextSector()->floorz); + alignflorslope(sect,wal->pos.X,wal->y, wal->nextSector()->floorz); } } } @@ -2502,7 +2502,7 @@ void DoSineWaveWall(void) if (!sw->type) { New = sw->orig_xy + MulScale(sw->range, bsin(sw->sintable_ndx), 14); - dragpoint(wal, wal->x, New); + dragpoint(wal, wal->pos.X, New); } else { diff --git a/source/games/sw/src/slidor.cpp b/source/games/sw/src/slidor.cpp index e00e7c9d7..b821598b5 100644 --- a/source/games/sw/src/slidor.cpp +++ b/source/games/sw/src/slidor.cpp @@ -297,17 +297,17 @@ int DoSlidorMoveWalls(DSWActor* actor, int amt) if (!wal->twoSided()) { // white wall - move 4 points - wal->move(wal->x - amt, wal->y); - pwal->move(pwal->x - amt, pwal->y); - wal->point2Wall()->move(wal->point2Wall()->x - amt, wal->point2Wall()->y); + wal->move(wal->pos.X - amt, wal->y); + pwal->move(pwal->pos.X - amt, pwal->y); + wal->point2Wall()->move(wal->point2Wall()->pos.X - amt, wal->point2Wall()->y); auto pwal2 = wal->point2Wall()->point2Wall(); - pwal2->move(pwal2->x - amt, pwal2->y); + pwal2->move(pwal2->pos.X - amt, pwal2->y); } else { // red wall - move 2 points - dragpoint(wal, wal->x - amt, wal->y); - dragpoint(wal->point2Wall(), wal->point2Wall()->x - amt, wal->point2Wall()->y); + dragpoint(wal, wal->pos.X - amt, wal->y); + dragpoint(wal->point2Wall(), wal->point2Wall()->pos.X - amt, wal->point2Wall()->y); } break; @@ -322,17 +322,17 @@ int DoSlidorMoveWalls(DSWActor* actor, int amt) if (!wal->twoSided()) { // white wall - move 4 points - wal->move(wal->x + amt, wal->y); - pwal->move(pwal->x + amt, pwal->y); - wal->point2Wall()->move(wal->point2Wall()->x + amt, wal->point2Wall()->y); + wal->move(wal->pos.X + amt, wal->y); + pwal->move(pwal->pos.X + amt, pwal->y); + wal->point2Wall()->move(wal->point2Wall()->pos.X + amt, wal->point2Wall()->y); auto pwal2 = wal->point2Wall()->point2Wall(); - pwal2->move(pwal2->x + amt, pwal2->y); + pwal2->move(pwal2->pos.X + amt, pwal2->y); } else { // red wall - move 2 points - dragpoint(wal, wal->x + amt, wal->y); - dragpoint(wal->point2Wall(), wal->point2Wall()->x + amt, wal->point2Wall()->y); + dragpoint(wal, wal->pos.X + amt, wal->y); + dragpoint(wal->point2Wall(), wal->point2Wall()->pos.X + amt, wal->point2Wall()->y); } break; @@ -346,16 +346,16 @@ int DoSlidorMoveWalls(DSWActor* actor, int amt) if (!wal->twoSided()) { - wal->move(wal->x, wal->y - amt); - pwal->move(pwal->x, pwal->y - amt); - wal->point2Wall()->move(wal->point2Wall()->x, wal->point2Wall()->y - amt); + wal->move(wal->pos.X, wal->y - amt); + pwal->move(pwal->pos.X, pwal->y - amt); + wal->point2Wall()->move(wal->point2Wall()->pos.X, wal->point2Wall()->y - amt); auto pwal2 = wal->point2Wall()->point2Wall(); - pwal2->move(pwal2->x, pwal2->y - amt); + pwal2->move(pwal2->pos.X, pwal2->y - amt); } else { - dragpoint(wal, wal->x, wal->y - amt); - dragpoint(wal->point2Wall(), wal->point2Wall()->x, wal->point2Wall()->y - amt); + dragpoint(wal, wal->pos.X, wal->y - amt); + dragpoint(wal->point2Wall(), wal->point2Wall()->pos.X, wal->point2Wall()->y - amt); } break; @@ -369,16 +369,16 @@ int DoSlidorMoveWalls(DSWActor* actor, int amt) if (!wal->twoSided()) { - wal->move(wal->x, wal->y + amt); - pwal->move(pwal->x, pwal->y + amt); - wal->point2Wall()->move(wal->point2Wall()->x, wal->point2Wall()->y + amt); + wal->move(wal->pos.X, wal->y + amt); + pwal->move(pwal->pos.X, pwal->y + amt); + wal->point2Wall()->move(wal->point2Wall()->pos.X, wal->point2Wall()->y + amt); auto pwal2 = wal->point2Wall()->point2Wall(); - pwal2->move(pwal2->x, pwal2->y + amt); + pwal2->move(pwal2->pos.X, pwal2->y + amt); } else { - dragpoint(wal, wal->x, wal->y + amt); - dragpoint(wal->point2Wall(), wal->point2Wall()->x, wal->point2Wall()->y + amt); + dragpoint(wal, wal->pos.X, wal->y + amt); + dragpoint(wal->point2Wall(), wal->point2Wall()->pos.X, wal->point2Wall()->y + amt); } @@ -406,12 +406,12 @@ int DoSlidorInstantClose(DSWActor* actor) switch (wal->lotag) { case TAG_WALL_SLIDOR_LEFT: - diff = wal->x - sp->x; + diff = wal->pos.X - sp->x; DoSlidorMoveWalls(actor, diff); break; case TAG_WALL_SLIDOR_RIGHT: - diff = wal->x - sp->x; + diff = wal->pos.X - sp->x; DoSlidorMoveWalls(actor, -diff); break; diff --git a/source/games/sw/src/sprite.cpp b/source/games/sw/src/sprite.cpp index 2e11a4299..62616c618 100644 --- a/source/games/sw/src/sprite.cpp +++ b/source/games/sw/src/sprite.cpp @@ -1513,7 +1513,7 @@ void PreMapCombineFloors(void) for (auto& wal : wallsofsector(dasect)) { - wal.move(wal.x + dx, wal.y + dy); + wal.move(wal.pos.X + dx, wal.y + dy); if (wal.twoSided()) search.Add(wal.nextSector()); @@ -2195,7 +2195,7 @@ void SpriteSetup(void) wallcount = 0; for(auto& wal : wallsofsector(sp->sector())) { - u->rotator->origX[wallcount] = wal.x; + u->rotator->origX[wallcount] = wal.pos.X; u->rotator->origY[wallcount] = wal.y; wallcount++; } diff --git a/source/games/sw/src/track.cpp b/source/games/sw/src/track.cpp index c08e54c18..e4618d184 100644 --- a/source/games/sw/src/track.cpp +++ b/source/games/sw/src/track.cpp @@ -790,7 +790,7 @@ void SectorObjectSetupBounds(SECTOR_OBJECTp sop) for(auto& wal : wallsofsector(sect)) { // all walls have to be in bounds to be in sector object - if (!(wal.x > xlow && wal.x < xhigh && wal.y > ylow && wal.y < yhigh)) + if (!(wal.pos.X > xlow && wal.pos.X < xhigh && wal.y > ylow && wal.y < yhigh)) { SectorInBounds = false; break; @@ -1458,7 +1458,7 @@ void PlaceSectorObjectsOnTracks(void) // move all walls in sectors for (auto& wal : wallsofsector(sop->sectp[j])) { - sop->xorig[sop->num_walls] = sop->xmid - wal.x; + sop->xorig[sop->num_walls] = sop->xmid - wal.pos.X; sop->yorig[sop->num_walls] = sop->ymid - wal.y; sop->num_walls++; } @@ -1688,11 +1688,11 @@ void MovePoints(SECTOR_OBJECTp sop, short delta_ang, int nx, int ny) if (wal.extra && TEST(wal.extra, WALLFX_LOOP_OUTER)) { - dragpoint(&wal, wal.x + nx, wal.y + ny); + dragpoint(&wal, wal.pos.X + nx, wal.y + ny); } else { - wal.move(wal.x + nx, wal.y + ny); + wal.move(wal.pos.X + nx, wal.y + ny); } rot_ang = delta_ang; diff --git a/source/games/sw/src/wallmove.cpp b/source/games/sw/src/wallmove.cpp index 70d777ba3..cd608bc24 100644 --- a/source/games/sw/src/wallmove.cpp +++ b/source/games/sw/src/wallmove.cpp @@ -104,7 +104,7 @@ int DoWallMove(DSWActor* actor) for(auto& wal : wall) { - if (wal.x == sp->x && wal.y == sp->y) + if (wal.pos.X == sp->x && wal.y == sp->y) { found = true; diff --git a/source/games/sw/src/weapon.cpp b/source/games/sw/src/weapon.cpp index f76509d77..d5c187e99 100644 --- a/source/games/sw/src/weapon.cpp +++ b/source/games/sw/src/weapon.cpp @@ -7315,7 +7315,7 @@ void TraverseBreakableWalls(sectortype* start_sect, int x, int y, int z, short a if (wal.lotag == TAG_WALL_BREAK) { // find midpoint - xmid = (wal.x + wal.point2Wall()->x) >> 1; + xmid = (wal.pos.X + wal.point2Wall()->pos.X) >> 1; ymid = (wal.y + wal.point2Wall()->y) >> 1; // don't need to go further if wall is too far out