/** * Cesium - https://github.com/CesiumGS/cesium * * Copyright 2011-2020 Cesium Contributors * * Licensed under the Apache License, Version 2.0 (the "License"); * you may not use this file except in compliance with the License. * You may obtain a copy of the License at * * http://www.apache.org/licenses/LICENSE-2.0 * * Unless required by applicable law or agreed to in writing, software * distributed under the License is distributed on an "AS IS" BASIS, * WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. * See the License for the specific language governing permissions and * limitations under the License. * * Columbus View (Pat. Pend.) * * Portions licensed separately. * See https://github.com/CesiumGS/cesium/blob/main/LICENSE.md for full licensing details. */ define(['exports', './ArcType-fc72c06c', './arrayRemoveDuplicates-65de6756', './Matrix2-265d9610', './ComponentDatatype-aad54330', './when-4bbc8319', './EllipsoidRhumbLine-d09d563f', './GeometryAttribute-4bcb785f', './GeometryAttributes-7827a6c2', './GeometryPipeline-e93f6439', './IndexDatatype-6739e544', './PolygonPipeline-5fd67ae2', './Transforms-8b90e17c'], (function (exports, ArcType, arrayRemoveDuplicates, Matrix2, ComponentDatatype, when, EllipsoidRhumbLine, GeometryAttribute, GeometryAttributes, GeometryPipeline, IndexDatatype, PolygonPipeline, Transforms) { 'use strict'; /** * A queue that can enqueue items at the end, and dequeue items from the front. * * @alias Queue * @constructor */ function Queue() { this._array = []; this._offset = 0; this._length = 0; } Object.defineProperties(Queue.prototype, { /** * The length of the queue. * * @memberof Queue.prototype * * @type {Number} * @readonly */ length: { get: function () { return this._length; }, }, }); /** * Enqueues the specified item. * * @param {*} item The item to enqueue. */ Queue.prototype.enqueue = function (item) { this._array.push(item); this._length++; }; /** * Dequeues an item. Returns undefined if the queue is empty. * * @returns {*} The the dequeued item. */ Queue.prototype.dequeue = function () { if (this._length === 0) { return undefined; } const array = this._array; let offset = this._offset; const item = array[offset]; array[offset] = undefined; offset++; if (offset > 10 && offset * 2 > array.length) { //compact array this._array = array.slice(offset); offset = 0; } this._offset = offset; this._length--; return item; }; /** * Returns the item at the front of the queue. Returns undefined if the queue is empty. * * @returns {*} The item at the front of the queue. */ Queue.prototype.peek = function () { if (this._length === 0) { return undefined; } return this._array[this._offset]; }; /** * Check whether this queue contains the specified item. * * @param {*} item The item to search for. */ Queue.prototype.contains = function (item) { return this._array.indexOf(item) !== -1; }; /** * Remove all items from the queue. */ Queue.prototype.clear = function () { this._array.length = this._offset = this._length = 0; }; /** * Sort the items in the queue in-place. * * @param {Queue.Comparator} compareFunction A function that defines the sort order. */ Queue.prototype.sort = function (compareFunction) { if (this._offset > 0) { //compact array this._array = this._array.slice(this._offset); this._offset = 0; } this._array.sort(compareFunction); }; /** * @private */ const PolygonGeometryLibrary = {}; PolygonGeometryLibrary.computeHierarchyPackedLength = function ( polygonHierarchy ) { let numComponents = 0; const stack = [polygonHierarchy]; while (stack.length > 0) { const hierarchy = stack.pop(); if (!when.defined(hierarchy)) { continue; } numComponents += 2; const positions = hierarchy.positions; const holes = hierarchy.holes; if (when.defined(positions)) { numComponents += positions.length * Matrix2.Cartesian3.packedLength; } if (when.defined(holes)) { const length = holes.length; for (let i = 0; i < length; ++i) { stack.push(holes[i]); } } } return numComponents; }; PolygonGeometryLibrary.packPolygonHierarchy = function ( polygonHierarchy, array, startingIndex ) { const stack = [polygonHierarchy]; while (stack.length > 0) { const hierarchy = stack.pop(); if (!when.defined(hierarchy)) { continue; } const positions = hierarchy.positions; const holes = hierarchy.holes; array[startingIndex++] = when.defined(positions) ? positions.length : 0; array[startingIndex++] = when.defined(holes) ? holes.length : 0; if (when.defined(positions)) { const positionsLength = positions.length; for (let i = 0; i < positionsLength; ++i, startingIndex += 3) { Matrix2.Cartesian3.pack(positions[i], array, startingIndex); } } if (when.defined(holes)) { const holesLength = holes.length; for (let j = 0; j < holesLength; ++j) { stack.push(holes[j]); } } } return startingIndex; }; PolygonGeometryLibrary.unpackPolygonHierarchy = function ( array, startingIndex ) { const positionsLength = array[startingIndex++]; const holesLength = array[startingIndex++]; const positions = new Array(positionsLength); const holes = holesLength > 0 ? new Array(holesLength) : undefined; for ( let i = 0; i < positionsLength; ++i, startingIndex += Matrix2.Cartesian3.packedLength ) { positions[i] = Matrix2.Cartesian3.unpack(array, startingIndex); } for (let j = 0; j < holesLength; ++j) { holes[j] = PolygonGeometryLibrary.unpackPolygonHierarchy( array, startingIndex ); startingIndex = holes[j].startingIndex; delete holes[j].startingIndex; } return { positions: positions, holes: holes, startingIndex: startingIndex, }; }; const distanceScratch = new Matrix2.Cartesian3(); function getPointAtDistance(p0, p1, distance, length) { Matrix2.Cartesian3.subtract(p1, p0, distanceScratch); Matrix2.Cartesian3.multiplyByScalar( distanceScratch, distance / length, distanceScratch ); Matrix2.Cartesian3.add(p0, distanceScratch, distanceScratch); return [distanceScratch.x, distanceScratch.y, distanceScratch.z]; } PolygonGeometryLibrary.subdivideLineCount = function (p0, p1, minDistance) { const distance = Matrix2.Cartesian3.distance(p0, p1); const n = distance / minDistance; const countDivide = Math.max(0, Math.ceil(ComponentDatatype.CesiumMath.log2(n))); return Math.pow(2, countDivide); }; const scratchCartographic0 = new Matrix2.Cartographic(); const scratchCartographic1 = new Matrix2.Cartographic(); const scratchCartographic2 = new Matrix2.Cartographic(); const scratchCartesian0 = new Matrix2.Cartesian3(); PolygonGeometryLibrary.subdivideRhumbLineCount = function ( ellipsoid, p0, p1, minDistance ) { const c0 = ellipsoid.cartesianToCartographic(p0, scratchCartographic0); const c1 = ellipsoid.cartesianToCartographic(p1, scratchCartographic1); const rhumb = new EllipsoidRhumbLine.EllipsoidRhumbLine(c0, c1, ellipsoid); const n = rhumb.surfaceDistance / minDistance; const countDivide = Math.max(0, Math.ceil(ComponentDatatype.CesiumMath.log2(n))); return Math.pow(2, countDivide); }; PolygonGeometryLibrary.subdivideLine = function (p0, p1, minDistance, result) { const numVertices = PolygonGeometryLibrary.subdivideLineCount( p0, p1, minDistance ); const length = Matrix2.Cartesian3.distance(p0, p1); const distanceBetweenVertices = length / numVertices; if (!when.defined(result)) { result = []; } const positions = result; positions.length = numVertices * 3; let index = 0; for (let i = 0; i < numVertices; i++) { const p = getPointAtDistance(p0, p1, i * distanceBetweenVertices, length); positions[index++] = p[0]; positions[index++] = p[1]; positions[index++] = p[2]; } return positions; }; PolygonGeometryLibrary.subdivideRhumbLine = function ( ellipsoid, p0, p1, minDistance, result ) { const c0 = ellipsoid.cartesianToCartographic(p0, scratchCartographic0); const c1 = ellipsoid.cartesianToCartographic(p1, scratchCartographic1); const rhumb = new EllipsoidRhumbLine.EllipsoidRhumbLine(c0, c1, ellipsoid); const n = rhumb.surfaceDistance / minDistance; const countDivide = Math.max(0, Math.ceil(ComponentDatatype.CesiumMath.log2(n))); const numVertices = Math.pow(2, countDivide); const distanceBetweenVertices = rhumb.surfaceDistance / numVertices; if (!when.defined(result)) { result = []; } const positions = result; positions.length = numVertices * 3; let index = 0; for (let i = 0; i < numVertices; i++) { const c = rhumb.interpolateUsingSurfaceDistance( i * distanceBetweenVertices, scratchCartographic2 ); const p = ellipsoid.cartographicToCartesian(c, scratchCartesian0); positions[index++] = p.x; positions[index++] = p.y; positions[index++] = p.z; } return positions; }; const scaleToGeodeticHeightN1 = new Matrix2.Cartesian3(); const scaleToGeodeticHeightN2 = new Matrix2.Cartesian3(); const scaleToGeodeticHeightP1 = new Matrix2.Cartesian3(); const scaleToGeodeticHeightP2 = new Matrix2.Cartesian3(); PolygonGeometryLibrary.scaleToGeodeticHeightExtruded = function ( geometry, maxHeight, minHeight, ellipsoid, perPositionHeight ) { ellipsoid = when.defaultValue(ellipsoid, Matrix2.Ellipsoid.WGS84); const n1 = scaleToGeodeticHeightN1; let n2 = scaleToGeodeticHeightN2; const p = scaleToGeodeticHeightP1; let p2 = scaleToGeodeticHeightP2; if ( when.defined(geometry) && when.defined(geometry.attributes) && when.defined(geometry.attributes.position) ) { const positions = geometry.attributes.position.values; const length = positions.length / 2; for (let i = 0; i < length; i += 3) { Matrix2.Cartesian3.fromArray(positions, i, p); ellipsoid.geodeticSurfaceNormal(p, n1); p2 = ellipsoid.scaleToGeodeticSurface(p, p2); n2 = Matrix2.Cartesian3.multiplyByScalar(n1, minHeight, n2); n2 = Matrix2.Cartesian3.add(p2, n2, n2); positions[i + length] = n2.x; positions[i + 1 + length] = n2.y; positions[i + 2 + length] = n2.z; if (perPositionHeight) { p2 = Matrix2.Cartesian3.clone(p, p2); } n2 = Matrix2.Cartesian3.multiplyByScalar(n1, maxHeight, n2); n2 = Matrix2.Cartesian3.add(p2, n2, n2); positions[i] = n2.x; positions[i + 1] = n2.y; positions[i + 2] = n2.z; } } return geometry; }; PolygonGeometryLibrary.polygonOutlinesFromHierarchy = function ( polygonHierarchy, scaleToEllipsoidSurface, ellipsoid ) { // create from a polygon hierarchy // Algorithm adapted from http://www.geometrictools.com/Documentation/TriangulationByEarClipping.pdf const polygons = []; const queue = new Queue(); queue.enqueue(polygonHierarchy); let i; let j; let length; while (queue.length !== 0) { const outerNode = queue.dequeue(); let outerRing = outerNode.positions; if (scaleToEllipsoidSurface) { length = outerRing.length; for (i = 0; i < length; i++) { ellipsoid.scaleToGeodeticSurface(outerRing[i], outerRing[i]); } } outerRing = arrayRemoveDuplicates.arrayRemoveDuplicates( outerRing, Matrix2.Cartesian3.equalsEpsilon, true ); if (outerRing.length < 3) { continue; } const numChildren = outerNode.holes ? outerNode.holes.length : 0; // The outer polygon contains inner polygons for (i = 0; i < numChildren; i++) { const hole = outerNode.holes[i]; let holePositions = hole.positions; if (scaleToEllipsoidSurface) { length = holePositions.length; for (j = 0; j < length; ++j) { ellipsoid.scaleToGeodeticSurface(holePositions[j], holePositions[j]); } } holePositions = arrayRemoveDuplicates.arrayRemoveDuplicates( holePositions, Matrix2.Cartesian3.equalsEpsilon, true ); if (holePositions.length < 3) { continue; } polygons.push(holePositions); let numGrandchildren = 0; if (when.defined(hole.holes)) { numGrandchildren = hole.holes.length; } for (j = 0; j < numGrandchildren; j++) { queue.enqueue(hole.holes[j]); } } polygons.push(outerRing); } return polygons; }; PolygonGeometryLibrary.polygonsFromHierarchy = function ( polygonHierarchy, projectPointsTo2D, scaleToEllipsoidSurface, ellipsoid ) { // create from a polygon hierarchy // Algorithm adapted from http://www.geometrictools.com/Documentation/TriangulationByEarClipping.pdf const hierarchy = []; const polygons = []; const queue = new Queue(); queue.enqueue(polygonHierarchy); while (queue.length !== 0) { const outerNode = queue.dequeue(); let outerRing = outerNode.positions; const holes = outerNode.holes; let i; let length; if (scaleToEllipsoidSurface) { length = outerRing.length; for (i = 0; i < length; i++) { ellipsoid.scaleToGeodeticSurface(outerRing[i], outerRing[i]); } } outerRing = arrayRemoveDuplicates.arrayRemoveDuplicates( outerRing, Matrix2.Cartesian3.equalsEpsilon, true ); if (outerRing.length < 3) { continue; } let positions2D = projectPointsTo2D(outerRing); if (!when.defined(positions2D)) { continue; } const holeIndices = []; let originalWindingOrder = PolygonPipeline.PolygonPipeline.computeWindingOrder2D( positions2D ); if (originalWindingOrder === PolygonPipeline.WindingOrder.CLOCKWISE) { positions2D.reverse(); outerRing = outerRing.slice().reverse(); } let positions = outerRing.slice(); const numChildren = when.defined(holes) ? holes.length : 0; const polygonHoles = []; let j; for (i = 0; i < numChildren; i++) { const hole = holes[i]; let holePositions = hole.positions; if (scaleToEllipsoidSurface) { length = holePositions.length; for (j = 0; j < length; ++j) { ellipsoid.scaleToGeodeticSurface(holePositions[j], holePositions[j]); } } holePositions = arrayRemoveDuplicates.arrayRemoveDuplicates( holePositions, Matrix2.Cartesian3.equalsEpsilon, true ); if (holePositions.length < 3) { continue; } const holePositions2D = projectPointsTo2D(holePositions); if (!when.defined(holePositions2D)) { continue; } originalWindingOrder = PolygonPipeline.PolygonPipeline.computeWindingOrder2D( holePositions2D ); if (originalWindingOrder === PolygonPipeline.WindingOrder.CLOCKWISE) { holePositions2D.reverse(); holePositions = holePositions.slice().reverse(); } polygonHoles.push(holePositions); holeIndices.push(positions.length); positions = positions.concat(holePositions); positions2D = positions2D.concat(holePositions2D); let numGrandchildren = 0; if (when.defined(hole.holes)) { numGrandchildren = hole.holes.length; } for (j = 0; j < numGrandchildren; j++) { queue.enqueue(hole.holes[j]); } } hierarchy.push({ outerRing: outerRing, holes: polygonHoles, }); polygons.push({ positions: positions, positions2D: positions2D, holes: holeIndices, }); } return { hierarchy: hierarchy, polygons: polygons, }; }; const computeBoundingRectangleCartesian2 = new Matrix2.Cartesian2(); const computeBoundingRectangleCartesian3 = new Matrix2.Cartesian3(); const computeBoundingRectangleQuaternion = new Transforms.Quaternion(); const computeBoundingRectangleMatrix3 = new Matrix2.Matrix3(); PolygonGeometryLibrary.computeBoundingRectangle = function ( planeNormal, projectPointTo2D, positions, angle, result ) { const rotation = Transforms.Quaternion.fromAxisAngle( planeNormal, angle, computeBoundingRectangleQuaternion ); const textureMatrix = Matrix2.Matrix3.fromQuaternion( rotation, computeBoundingRectangleMatrix3 ); let minX = Number.POSITIVE_INFINITY; let maxX = Number.NEGATIVE_INFINITY; let minY = Number.POSITIVE_INFINITY; let maxY = Number.NEGATIVE_INFINITY; const length = positions.length; for (let i = 0; i < length; ++i) { const p = Matrix2.Cartesian3.clone( positions[i], computeBoundingRectangleCartesian3 ); Matrix2.Matrix3.multiplyByVector(textureMatrix, p, p); const st = projectPointTo2D(p, computeBoundingRectangleCartesian2); if (when.defined(st)) { minX = Math.min(minX, st.x); maxX = Math.max(maxX, st.x); minY = Math.min(minY, st.y); maxY = Math.max(maxY, st.y); } } result.x = minX; result.y = minY; result.width = maxX - minX; result.height = maxY - minY; return result; }; PolygonGeometryLibrary.createGeometryFromPositions = function ( ellipsoid, polygon, granularity, perPositionHeight, vertexFormat, arcType ) { let indices = PolygonPipeline.PolygonPipeline.triangulate(polygon.positions2D, polygon.holes); /* If polygon is completely unrenderable, just use the first three vertices */ if (indices.length < 3) { indices = [0, 1, 2]; } const positions = polygon.positions; if (perPositionHeight) { const length = positions.length; const flattenedPositions = new Array(length * 3); let index = 0; for (let i = 0; i < length; i++) { const p = positions[i]; flattenedPositions[index++] = p.x; flattenedPositions[index++] = p.y; flattenedPositions[index++] = p.z; } const geometry = new GeometryAttribute.Geometry({ attributes: { position: new GeometryAttribute.GeometryAttribute({ componentDatatype: ComponentDatatype.ComponentDatatype.DOUBLE, componentsPerAttribute: 3, values: flattenedPositions, }), }, indices: indices, primitiveType: GeometryAttribute.PrimitiveType.TRIANGLES, }); if (vertexFormat.normal) { return GeometryPipeline.GeometryPipeline.computeNormal(geometry); } return geometry; } if (arcType === ArcType.ArcType.GEODESIC) { return PolygonPipeline.PolygonPipeline.computeSubdivision( ellipsoid, positions, indices, granularity ); } else if (arcType === ArcType.ArcType.RHUMB) { return PolygonPipeline.PolygonPipeline.computeRhumbLineSubdivision( ellipsoid, positions, indices, granularity ); } }; const computeWallIndicesSubdivided = []; const p1Scratch = new Matrix2.Cartesian3(); const p2Scratch = new Matrix2.Cartesian3(); PolygonGeometryLibrary.computeWallGeometry = function ( positions, ellipsoid, granularity, perPositionHeight, arcType ) { let edgePositions; let topEdgeLength; let i; let p1; let p2; let length = positions.length; let index = 0; if (!perPositionHeight) { const minDistance = ComponentDatatype.CesiumMath.chordLength( granularity, ellipsoid.maximumRadius ); let numVertices = 0; if (arcType === ArcType.ArcType.GEODESIC) { for (i = 0; i < length; i++) { numVertices += PolygonGeometryLibrary.subdivideLineCount( positions[i], positions[(i + 1) % length], minDistance ); } } else if (arcType === ArcType.ArcType.RHUMB) { for (i = 0; i < length; i++) { numVertices += PolygonGeometryLibrary.subdivideRhumbLineCount( ellipsoid, positions[i], positions[(i + 1) % length], minDistance ); } } topEdgeLength = (numVertices + length) * 3; edgePositions = new Array(topEdgeLength * 2); for (i = 0; i < length; i++) { p1 = positions[i]; p2 = positions[(i + 1) % length]; let tempPositions; if (arcType === ArcType.ArcType.GEODESIC) { tempPositions = PolygonGeometryLibrary.subdivideLine( p1, p2, minDistance, computeWallIndicesSubdivided ); } else if (arcType === ArcType.ArcType.RHUMB) { tempPositions = PolygonGeometryLibrary.subdivideRhumbLine( ellipsoid, p1, p2, minDistance, computeWallIndicesSubdivided ); } const tempPositionsLength = tempPositions.length; for (let j = 0; j < tempPositionsLength; ++j, ++index) { edgePositions[index] = tempPositions[j]; edgePositions[index + topEdgeLength] = tempPositions[j]; } edgePositions[index] = p2.x; edgePositions[index + topEdgeLength] = p2.x; ++index; edgePositions[index] = p2.y; edgePositions[index + topEdgeLength] = p2.y; ++index; edgePositions[index] = p2.z; edgePositions[index + topEdgeLength] = p2.z; ++index; } } else { topEdgeLength = length * 3 * 2; edgePositions = new Array(topEdgeLength * 2); for (i = 0; i < length; i++) { p1 = positions[i]; p2 = positions[(i + 1) % length]; edgePositions[index] = edgePositions[index + topEdgeLength] = p1.x; ++index; edgePositions[index] = edgePositions[index + topEdgeLength] = p1.y; ++index; edgePositions[index] = edgePositions[index + topEdgeLength] = p1.z; ++index; edgePositions[index] = edgePositions[index + topEdgeLength] = p2.x; ++index; edgePositions[index] = edgePositions[index + topEdgeLength] = p2.y; ++index; edgePositions[index] = edgePositions[index + topEdgeLength] = p2.z; ++index; } } length = edgePositions.length; const indices = IndexDatatype.IndexDatatype.createTypedArray( length / 3, length - positions.length * 6 ); let edgeIndex = 0; length /= 6; for (i = 0; i < length; i++) { const UL = i; const UR = UL + 1; const LL = UL + length; const LR = LL + 1; p1 = Matrix2.Cartesian3.fromArray(edgePositions, UL * 3, p1Scratch); p2 = Matrix2.Cartesian3.fromArray(edgePositions, UR * 3, p2Scratch); if ( Matrix2.Cartesian3.equalsEpsilon( p1, p2, ComponentDatatype.CesiumMath.EPSILON10, ComponentDatatype.CesiumMath.EPSILON10 ) ) { //skip corner continue; } indices[edgeIndex++] = UL; indices[edgeIndex++] = LL; indices[edgeIndex++] = UR; indices[edgeIndex++] = UR; indices[edgeIndex++] = LL; indices[edgeIndex++] = LR; } return new GeometryAttribute.Geometry({ attributes: new GeometryAttributes.GeometryAttributes({ position: new GeometryAttribute.GeometryAttribute({ componentDatatype: ComponentDatatype.ComponentDatatype.DOUBLE, componentsPerAttribute: 3, values: edgePositions, }), }), indices: indices, primitiveType: GeometryAttribute.PrimitiveType.TRIANGLES, }); }; exports.PolygonGeometryLibrary = PolygonGeometryLibrary; })); //# sourceMappingURL=PolygonGeometryLibrary-e329b948.js.map