/** * plotly.js v1.6.3 * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * Licensed under the MIT license */ (function(f){if(typeof exports==="object"&&typeof module!=="undefined"){module.exports=f()}else if(typeof define==="function"&&define.amd){define([],f)}else{var g;if(typeof window!=="undefined"){g=window}else if(typeof global!=="undefined"){g=global}else if(typeof self!=="undefined"){g=self}else{g=this}g.Plotly = f()}})(function(){var define,module,exports;return (function e(t,n,r){function s(o,u){if(!n[o]){if(!t[o]){var a=typeof require=="function"&&require;if(!u&&a)return a(o,!0);if(i)return i(o,!0);var f=new Error("Cannot find module '"+o+"'");throw f.code="MODULE_NOT_FOUND",f}var l=n[o]={exports:{}};t[o][0].call(l.exports,function(e){var n=t[o][1][e];return s(n?n:e)},l,l.exports,e,t,n,r)}return n[o].exports}var i=typeof require=="function"&&require;for(var o=0;o= n-1) { var ptr = state.length-1 var tf = t - time[n-1] for(var i=0; i= n-1) { var ptr = state.length-1 var tf = t - time[n-1] for(var i=0; i=0; --i) { if(velocity[--ptr]) { return false } } return true } proto.jump = function(t) { var t0 = this.lastT() var d = this.dimension if(t < t0 || arguments.length !== d+1) { return } var state = this._state var velocity = this._velocity var ptr = state.length-this.dimension var bounds = this.bounds var lo = bounds[0] var hi = bounds[1] this._time.push(t0, t) for(var j=0; j<2; ++j) { for(var i=0; i0; --i) { state.push(clamp(lo[i-1], hi[i-1], arguments[i])) velocity.push(0) } } proto.push = function(t) { var t0 = this.lastT() var d = this.dimension if(t < t0 || arguments.length !== d+1) { return } var state = this._state var velocity = this._velocity var ptr = state.length-this.dimension var dt = t - t0 var bounds = this.bounds var lo = bounds[0] var hi = bounds[1] var sf = (dt > 1e-6) ? 1/dt : 0 this._time.push(t) for(var i=d; i>0; --i) { var xc = clamp(lo[i-1], hi[i-1], arguments[i]) state.push(xc) velocity.push((xc - state[ptr++]) * sf) } } proto.set = function(t) { var d = this.dimension if(t < this.lastT() || arguments.length !== d+1) { return } var state = this._state var velocity = this._velocity var bounds = this.bounds var lo = bounds[0] var hi = bounds[1] this._time.push(t) for(var i=d; i>0; --i) { state.push(clamp(lo[i-1], hi[i-1], arguments[i])) velocity.push(0) } } proto.move = function(t) { var t0 = this.lastT() var d = this.dimension if(t <= t0 || arguments.length !== d+1) { return } var state = this._state var velocity = this._velocity var statePtr = state.length - this.dimension var bounds = this.bounds var lo = bounds[0] var hi = bounds[1] var dt = t - t0 var sf = (dt > 1e-6) ? 1/dt : 0.0 this._time.push(t) for(var i=d; i>0; --i) { var dx = arguments[i] state.push(clamp(lo[i-1], hi[i-1], state[statePtr++] + dx)) velocity.push(dx * sf) } } proto.idle = function(t) { var t0 = this.lastT() if(t < t0) { return } var d = this.dimension var state = this._state var velocity = this._velocity var statePtr = state.length-d var bounds = this.bounds var lo = bounds[0] var hi = bounds[1] var dt = t - t0 this._time.push(t) for(var i=d-1; i>=0; --i) { state.push(clamp(lo[i], hi[i], state[statePtr] + dt * velocity[statePtr])) velocity.push(0) statePtr += 1 } } function getZero(d) { var result = new Array(d) for(var i=0; i>>1,x=a", useNdarray ? ".get(m)" : "[m]"] if(earlyOut) { if(predicate.indexOf("c") < 0) { code.push(";if(x===y){return m}else if(x<=y){") } else { code.push(";var p=c(x,y);if(p===0){return m}else if(p<=0){") } } else { code.push(";if(", predicate, "){i=m;") } if(reversed) { code.push("l=m+1}else{h=m-1}") } else { code.push("h=m-1}else{l=m+1}") } code.push("}") if(earlyOut) { code.push("return -1};") } else { code.push("return i};") } return code.join("") } function compileBoundsSearch(predicate, reversed, suffix, earlyOut) { var result = new Function([ compileSearch("A", "x" + predicate + "y", reversed, ["y"], false, earlyOut), compileSearch("B", "x" + predicate + "y", reversed, ["y"], true, earlyOut), compileSearch("P", "c(x,y)" + predicate + "0", reversed, ["y", "c"], false, earlyOut), compileSearch("Q", "c(x,y)" + predicate + "0", reversed, ["y", "c"], true, earlyOut), "function dispatchBsearch", suffix, "(a,y,c,l,h){\ if(a.shape){\ if(typeof(c)==='function'){\ return Q(a,(l===undefined)?0:l|0,(h===undefined)?a.shape[0]-1:h|0,y,c)\ }else{\ return B(a,(c===undefined)?0:c|0,(l===undefined)?a.shape[0]-1:l|0,y)\ }}else{\ if(typeof(c)==='function'){\ return P(a,(l===undefined)?0:l|0,(h===undefined)?a.length-1:h|0,y,c)\ }else{\ return A(a,(c===undefined)?0:c|0,(l===undefined)?a.length-1:l|0,y)\ }}}\ return dispatchBsearch", suffix].join("")) return result() } module.exports = { ge: compileBoundsSearch(">=", false, "GE"), gt: compileBoundsSearch(">", false, "GT"), lt: compileBoundsSearch("<", true, "LT"), le: compileBoundsSearch("<=", true, "LE"), eq: compileBoundsSearch("-", true, "EQ", true) } },{}],21:[function(require,module,exports){ "use strict" function dcubicHermite(p0, v0, p1, v1, t, f) { var dh00 = 6*t*t-6*t, dh10 = 3*t*t-4*t + 1, dh01 = -6*t*t+6*t, dh11 = 3*t*t-2*t if(p0.length) { if(!f) { f = new Array(p0.length) } for(var i=p0.length-1; i>=0; --i) { f[i] = dh00*p0[i] + dh10*v0[i] + dh01*p1[i] + dh11*v1[i] } return f } return dh00*p0 + dh10*v0 + dh01*p1[i] + dh11*v1 } function cubicHermite(p0, v0, p1, v1, t, f) { var ti = (t-1), t2 = t*t, ti2 = ti*ti, h00 = (1+2*t)*ti2, h10 = t*ti2, h01 = t2*(3-2*t), h11 = t2*ti if(p0.length) { if(!f) { f = new Array(p0.length) } for(var i=p0.length-1; i>=0; --i) { f[i] = h00*p0[i] + h10*v0[i] + h01*p1[i] + h11*v1[i] } return f } return h00*p0 + h10*v0 + h01*p1 + h11*v1 } module.exports = cubicHermite module.exports.derivative = dcubicHermite },{}],22:[function(require,module,exports){ module.exports = cross; /** * Computes the cross product of two vec3's * * @param {vec3} out the receiving vector * @param {vec3} a the first operand * @param {vec3} b the second operand * @returns {vec3} out */ function cross(out, a, b) { var ax = a[0], ay = a[1], az = a[2], bx = b[0], by = b[1], bz = b[2] out[0] = ay * bz - az * by out[1] = az * bx - ax * bz out[2] = ax * by - ay * bx return out } },{}],23:[function(require,module,exports){ module.exports = dot; /** * Calculates the dot product of two vec3's * * @param {vec3} a the first operand * @param {vec3} b the second operand * @returns {Number} dot product of a and b */ function dot(a, b) { return a[0] * b[0] + a[1] * b[1] + a[2] * b[2] } },{}],24:[function(require,module,exports){ module.exports = length; /** * Calculates the length of a vec3 * * @param {vec3} a vector to calculate length of * @returns {Number} length of a */ function length(a) { var x = a[0], y = a[1], z = a[2] return Math.sqrt(x*x + y*y + z*z) } },{}],25:[function(require,module,exports){ module.exports = lerp; /** * Performs a linear interpolation between two vec3's * * @param {vec3} out the receiving vector * @param {vec3} a the first operand * @param {vec3} b the second operand * @param {Number} t interpolation amount between the two inputs * @returns {vec3} out */ function lerp(out, a, b, t) { var ax = a[0], ay = a[1], az = a[2] out[0] = ax + t * (b[0] - ax) out[1] = ay + t * (b[1] - ay) out[2] = az + t * (b[2] - az) return out } },{}],26:[function(require,module,exports){ module.exports = normalize; /** * Normalize a vec3 * * @param {vec3} out the receiving vector * @param {vec3} a vector to normalize * @returns {vec3} out */ function normalize(out, a) { var x = a[0], y = a[1], z = a[2] var len = x*x + y*y + z*z if (len > 0) { //TODO: evaluate use of glm_invsqrt here? len = 1 / Math.sqrt(len) out[0] = a[0] * len out[1] = a[1] * len out[2] = a[2] * len } return out } },{}],27:[function(require,module,exports){ 'use strict' var bsearch = require('binary-search-bounds') var m4interp = require('mat4-interpolate') var invert44 = require('gl-mat4/invert') var rotateX = require('gl-mat4/rotateX') var rotateY = require('gl-mat4/rotateY') var rotateZ = require('gl-mat4/rotateZ') var lookAt = require('gl-mat4/lookAt') var translate = require('gl-mat4/translate') var scale = require('gl-mat4/scale') var normalize = require('gl-vec3/normalize') var DEFAULT_CENTER = [0,0,0] module.exports = createMatrixCameraController function MatrixCameraController(initialMatrix) { this._components = initialMatrix.slice() this._time = [0] this.prevMatrix = initialMatrix.slice() this.nextMatrix = initialMatrix.slice() this.computedMatrix = initialMatrix.slice() this.computedInverse = initialMatrix.slice() this.computedEye = [0,0,0] this.computedUp = [0,0,0] this.computedCenter = [0,0,0] this.computedRadius = [0] this._limits = [-Infinity, Infinity] } var proto = MatrixCameraController.prototype proto.recalcMatrix = function(t) { var time = this._time var tidx = bsearch.le(time, t) var mat = this.computedMatrix if(tidx < 0) { return } var comps = this._components if(tidx === time.length-1) { var ptr = 16*tidx for(var i=0; i<16; ++i) { mat[i] = comps[ptr++] } } else { var dt = (time[tidx+1] - time[tidx]) var ptr = 16*tidx var prev = this.prevMatrix var allEqual = true for(var i=0; i<16; ++i) { prev[i] = comps[ptr++] } var next = this.nextMatrix for(var i=0; i<16; ++i) { next[i] = comps[ptr++] allEqual = allEqual && (prev[i] === next[i]) } if(dt < 1e-6 || allEqual) { for(var i=0; i<16; ++i) { mat[i] = prev[i] } } else { m4interp(mat, prev, next, (t - time[tidx])/dt) } } var up = this.computedUp up[0] = mat[1] up[1] = mat[5] up[2] = mat[6] normalize(up, up) var imat = this.computedInverse invert44(imat, mat) var eye = this.computedEye var w = imat[15] eye[0] = imat[12]/w eye[1] = imat[13]/w eye[2] = imat[14]/w var center = this.computedCenter var radius = Math.exp(this.computedRadius[0]) for(var i=0; i<3; ++i) { center[i] = eye[i] - mat[2+4*i] * radius } } proto.idle = function(t) { if(t < this.lastT()) { return } var mc = this._components var ptr = mc.length-16 for(var i=0; i<16; ++i) { mc.push(mc[ptr++]) } this._time.push(t) } proto.flush = function(t) { var idx = bsearch.gt(this._time, t) - 2 if(idx < 0) { return } this._time.slice(0, idx) this._components.slice(0, 16*idx) } proto.lastT = function() { return this._time[this._time.length-1] } proto.lookAt = function(t, eye, center, up) { this.recalcMatrix(t) eye = eye || this.computedEye center = center || DEFAULT_CENTER up = up || this.computedUp this.setMatrix(t, lookAt(this.computedMatrix, eye, center, up)) var d2 = 0.0 for(var i=0; i<3; ++i) { d2 += Math.pow(center[i] - eye[i], 2) } d2 = Math.log(Math.sqrt(d2)) this.computedRadius[0] = d2 } proto.rotate = function(t, yaw, pitch, roll) { this.recalcMatrix(t) var mat = this.computedInverse if(yaw) rotateY(mat, mat, yaw) if(pitch) rotateX(mat, mat, pitch) if(roll) rotateZ(mat, mat, roll) this.setMatrix(t, invert44(this.computedMatrix, mat)) } var tvec = [0,0,0] proto.pan = function(t, dx, dy, dz) { tvec[0] = -(dx || 0.0) tvec[1] = -(dy || 0.0) tvec[2] = -(dz || 0.0) this.recalcMatrix(t) var mat = this.computedInverse translate(mat, mat, tvec) this.setMatrix(t, invert44(mat, mat)) } proto.translate = function(t, dx, dy, dz) { tvec[0] = dx || 0.0 tvec[1] = dy || 0.0 tvec[2] = dz || 0.0 this.recalcMatrix(t) var mat = this.computedMatrix translate(mat, mat, tvec) this.setMatrix(t, mat) } proto.setMatrix = function(t, mat) { if(t < this.lastT()) { return } this._time.push(t) for(var i=0; i<16; ++i) { this._components.push(mat[i]) } } proto.setDistance = function(t, d) { this.computedRadius[0] = d } proto.setDistanceLimits = function(a,b) { var lim = this._limits lim[0] = a lim[1] = b } proto.getDistanceLimits = function(out) { var lim = this._limits if(out) { out[0] = lim[0] out[1] = lim[1] return out } return lim } function createMatrixCameraController(options) { options = options || {} var matrix = options.matrix || [1,0,0,0, 0,1,0,0, 0,0,1,0, 0,0,0,1] return new MatrixCameraController(matrix) } },{"binary-search-bounds":28,"gl-mat4/invert":94,"gl-mat4/lookAt":95,"gl-mat4/rotateX":99,"gl-mat4/rotateY":100,"gl-mat4/rotateZ":101,"gl-mat4/scale":102,"gl-mat4/translate":103,"gl-vec3/normalize":26,"mat4-interpolate":29}],28:[function(require,module,exports){ arguments[4][20][0].apply(exports,arguments) },{"dup":20}],29:[function(require,module,exports){ var lerp = require('gl-vec3/lerp') var recompose = require('mat4-recompose') var decompose = require('mat4-decompose') var determinant = require('gl-mat4/determinant') var slerp = require('quat-slerp') var state0 = state() var state1 = state() var tmp = state() module.exports = interpolate function interpolate(out, start, end, alpha) { if (determinant(start) === 0 || determinant(end) === 0) return false //decompose the start and end matrices into individual components var r0 = decompose(start, state0.translate, state0.scale, state0.skew, state0.perspective, state0.quaternion) var r1 = decompose(end, state1.translate, state1.scale, state1.skew, state1.perspective, state1.quaternion) if (!r0 || !r1) return false //now lerp/slerp the start and end components into a temporary lerp(tmptranslate, state0.translate, state1.translate, alpha) lerp(tmp.translate, state0.translate, state1.translate, alpha) lerp(tmp.skew, state0.skew, state1.skew, alpha) lerp(tmp.scale, state0.scale, state1.scale, alpha) lerp(tmp.perspective, state0.perspective, state1.perspective, alpha) slerp(tmp.quaternion, state0.quaternion, state1.quaternion, alpha) //and recompose into our 'out' matrix recompose(out, tmp.translate, tmp.scale, tmp.skew, tmp.perspective, tmp.quaternion) return true } function state() { return { translate: vec3(), scale: vec3(1), skew: vec3(), perspective: vec4(), quaternion: vec4() } } function vec3(n) { return [n||0,n||0,n||0] } function vec4() { return [0,0,0,1] } },{"gl-mat4/determinant":90,"gl-vec3/lerp":25,"mat4-decompose":30,"mat4-recompose":32,"quat-slerp":33}],30:[function(require,module,exports){ /*jshint unused:true*/ /* Input: matrix ; a 4x4 matrix Output: translation ; a 3 component vector scale ; a 3 component vector skew ; skew factors XY,XZ,YZ represented as a 3 component vector perspective ; a 4 component vector quaternion ; a 4 component vector Returns false if the matrix cannot be decomposed, true if it can References: https://github.com/kamicane/matrix3d/blob/master/lib/Matrix3d.js https://github.com/ChromiumWebApps/chromium/blob/master/ui/gfx/transform_util.cc http://www.w3.org/TR/css3-transforms/#decomposing-a-3d-matrix */ var normalize = require('./normalize') var create = require('gl-mat4/create') var clone = require('gl-mat4/clone') var determinant = require('gl-mat4/determinant') var invert = require('gl-mat4/invert') var transpose = require('gl-mat4/transpose') var vec3 = { length: require('gl-vec3/length'), normalize: require('gl-vec3/normalize'), dot: require('gl-vec3/dot'), cross: require('gl-vec3/cross') } var tmp = create() var perspectiveMatrix = create() var tmpVec4 = [0, 0, 0, 0] var row = [ [0,0,0], [0,0,0], [0,0,0] ] var pdum3 = [0,0,0] module.exports = function decomposeMat4(matrix, translation, scale, skew, perspective, quaternion) { if (!translation) translation = [0,0,0] if (!scale) scale = [0,0,0] if (!skew) skew = [0,0,0] if (!perspective) perspective = [0,0,0,1] if (!quaternion) quaternion = [0,0,0,1] //normalize, if not possible then bail out early if (!normalize(tmp, matrix)) return false // perspectiveMatrix is used to solve for perspective, but it also provides // an easy way to test for singularity of the upper 3x3 component. clone(perspectiveMatrix, tmp) perspectiveMatrix[3] = 0 perspectiveMatrix[7] = 0 perspectiveMatrix[11] = 0 perspectiveMatrix[15] = 1 // If the perspectiveMatrix is not invertible, we are also unable to // decompose, so we'll bail early. Constant taken from SkMatrix44::invert. if (Math.abs(determinant(perspectiveMatrix) < 1e-8)) return false var a03 = tmp[3], a13 = tmp[7], a23 = tmp[11], a30 = tmp[12], a31 = tmp[13], a32 = tmp[14], a33 = tmp[15] // First, isolate perspective. if (a03 !== 0 || a13 !== 0 || a23 !== 0) { tmpVec4[0] = a03 tmpVec4[1] = a13 tmpVec4[2] = a23 tmpVec4[3] = a33 // Solve the equation by inverting perspectiveMatrix and multiplying // rightHandSide by the inverse. // resuing the perspectiveMatrix here since it's no longer needed var ret = invert(perspectiveMatrix, perspectiveMatrix) if (!ret) return false transpose(perspectiveMatrix, perspectiveMatrix) //multiply by transposed inverse perspective matrix, into perspective vec4 vec4multMat4(perspective, tmpVec4, perspectiveMatrix) } else { //no perspective perspective[0] = perspective[1] = perspective[2] = 0 perspective[3] = 1 } // Next take care of translation translation[0] = a30 translation[1] = a31 translation[2] = a32 // Now get scale and shear. 'row' is a 3 element array of 3 component vectors mat3from4(row, tmp) // Compute X scale factor and normalize first row. scale[0] = vec3.length(row[0]) vec3.normalize(row[0], row[0]) // Compute XY shear factor and make 2nd row orthogonal to 1st. skew[0] = vec3.dot(row[0], row[1]) combine(row[1], row[1], row[0], 1.0, -skew[0]) // Now, compute Y scale and normalize 2nd row. scale[1] = vec3.length(row[1]) vec3.normalize(row[1], row[1]) skew[0] /= scale[1] // Compute XZ and YZ shears, orthogonalize 3rd row skew[1] = vec3.dot(row[0], row[2]) combine(row[2], row[2], row[0], 1.0, -skew[1]) skew[2] = vec3.dot(row[1], row[2]) combine(row[2], row[2], row[1], 1.0, -skew[2]) // Next, get Z scale and normalize 3rd row. scale[2] = vec3.length(row[2]) vec3.normalize(row[2], row[2]) skew[1] /= scale[2] skew[2] /= scale[2] // At this point, the matrix (in rows) is orthonormal. // Check for a coordinate system flip. If the determinant // is -1, then negate the matrix and the scaling factors. vec3.cross(pdum3, row[1], row[2]) if (vec3.dot(row[0], pdum3) < 0) { for (var i = 0; i < 3; i++) { scale[i] *= -1; row[i][0] *= -1 row[i][1] *= -1 row[i][2] *= -1 } } // Now, get the rotations out quaternion[0] = 0.5 * Math.sqrt(Math.max(1 + row[0][0] - row[1][1] - row[2][2], 0)) quaternion[1] = 0.5 * Math.sqrt(Math.max(1 - row[0][0] + row[1][1] - row[2][2], 0)) quaternion[2] = 0.5 * Math.sqrt(Math.max(1 - row[0][0] - row[1][1] + row[2][2], 0)) quaternion[3] = 0.5 * Math.sqrt(Math.max(1 + row[0][0] + row[1][1] + row[2][2], 0)) if (row[2][1] > row[1][2]) quaternion[0] = -quaternion[0] if (row[0][2] > row[2][0]) quaternion[1] = -quaternion[1] if (row[1][0] > row[0][1]) quaternion[2] = -quaternion[2] return true } //will be replaced by gl-vec4 eventually function vec4multMat4(out, a, m) { var x = a[0], y = a[1], z = a[2], w = a[3]; out[0] = m[0] * x + m[4] * y + m[8] * z + m[12] * w; out[1] = m[1] * x + m[5] * y + m[9] * z + m[13] * w; out[2] = m[2] * x + m[6] * y + m[10] * z + m[14] * w; out[3] = m[3] * x + m[7] * y + m[11] * z + m[15] * w; return out; } //gets upper-left of a 4x4 matrix into a 3x3 of vectors function mat3from4(out, mat4x4) { out[0][0] = mat4x4[0] out[0][1] = mat4x4[1] out[0][2] = mat4x4[2] out[1][0] = mat4x4[4] out[1][1] = mat4x4[5] out[1][2] = mat4x4[6] out[2][0] = mat4x4[8] out[2][1] = mat4x4[9] out[2][2] = mat4x4[10] } function combine(out, a, b, scale1, scale2) { out[0] = a[0] * scale1 + b[0] * scale2 out[1] = a[1] * scale1 + b[1] * scale2 out[2] = a[2] * scale1 + b[2] * scale2 } },{"./normalize":31,"gl-mat4/clone":88,"gl-mat4/create":89,"gl-mat4/determinant":90,"gl-mat4/invert":94,"gl-mat4/transpose":104,"gl-vec3/cross":22,"gl-vec3/dot":23,"gl-vec3/length":24,"gl-vec3/normalize":26}],31:[function(require,module,exports){ module.exports = function normalize(out, mat) { var m44 = mat[15] // Cannot normalize. if (m44 === 0) return false var scale = 1 / m44 for (var i=0; i<16; i++) out[i] = mat[i] * scale return true } },{}],32:[function(require,module,exports){ /* Input: translation ; a 3 component vector scale ; a 3 component vector skew ; skew factors XY,XZ,YZ represented as a 3 component vector perspective ; a 4 component vector quaternion ; a 4 component vector Output: matrix ; a 4x4 matrix From: http://www.w3.org/TR/css3-transforms/#recomposing-to-a-3d-matrix */ var mat4 = { identity: require('gl-mat4/identity'), translate: require('gl-mat4/translate'), multiply: require('gl-mat4/multiply'), create: require('gl-mat4/create'), scale: require('gl-mat4/scale'), fromRotationTranslation: require('gl-mat4/fromRotationTranslation') } var rotationMatrix = mat4.create() var temp = mat4.create() module.exports = function recomposeMat4(matrix, translation, scale, skew, perspective, quaternion) { mat4.identity(matrix) //apply translation & rotation mat4.fromRotationTranslation(matrix, quaternion, translation) //apply perspective matrix[3] = perspective[0] matrix[7] = perspective[1] matrix[11] = perspective[2] matrix[15] = perspective[3] // apply skew // temp is a identity 4x4 matrix initially mat4.identity(temp) if (skew[2] !== 0) { temp[9] = skew[2] mat4.multiply(matrix, matrix, temp) } if (skew[1] !== 0) { temp[9] = 0 temp[8] = skew[1] mat4.multiply(matrix, matrix, temp) } if (skew[0] !== 0) { temp[8] = 0 temp[4] = skew[0] mat4.multiply(matrix, matrix, temp) } //apply scale mat4.scale(matrix, matrix, scale) return matrix } },{"gl-mat4/create":89,"gl-mat4/fromRotationTranslation":92,"gl-mat4/identity":93,"gl-mat4/multiply":96,"gl-mat4/scale":102,"gl-mat4/translate":103}],33:[function(require,module,exports){ module.exports = require('gl-quat/slerp') },{"gl-quat/slerp":34}],34:[function(require,module,exports){ module.exports = slerp /** * Performs a spherical linear interpolation between two quat * * @param {quat} out the receiving quaternion * @param {quat} a the first operand * @param {quat} b the second operand * @param {Number} t interpolation amount between the two inputs * @returns {quat} out */ function slerp (out, a, b, t) { // benchmarks: // http://jsperf.com/quaternion-slerp-implementations var ax = a[0], ay = a[1], az = a[2], aw = a[3], bx = b[0], by = b[1], bz = b[2], bw = b[3] var omega, cosom, sinom, scale0, scale1 // calc cosine cosom = ax * bx + ay * by + az * bz + aw * bw // adjust signs (if necessary) if (cosom < 0.0) { cosom = -cosom bx = -bx by = -by bz = -bz bw = -bw } // calculate coefficients if ((1.0 - cosom) > 0.000001) { // standard case (slerp) omega = Math.acos(cosom) sinom = Math.sin(omega) scale0 = Math.sin((1.0 - t) * omega) / sinom scale1 = Math.sin(t * omega) / sinom } else { // "from" and "to" quaternions are very close // ... so we can do a linear interpolation scale0 = 1.0 - t scale1 = t } // calculate final values out[0] = scale0 * ax + scale1 * bx out[1] = scale0 * ay + scale1 * by out[2] = scale0 * az + scale1 * bz out[3] = scale0 * aw + scale1 * bw return out } },{}],35:[function(require,module,exports){ 'use strict' module.exports = quatFromFrame function quatFromFrame( out, rx, ry, rz, ux, uy, uz, fx, fy, fz) { var tr = rx + uy + fz if(l > 0) { var l = Math.sqrt(tr + 1.0) out[0] = 0.5 * (uz - fy) / l out[1] = 0.5 * (fx - rz) / l out[2] = 0.5 * (ry - uy) / l out[3] = 0.5 * l } else { var tf = Math.max(rx, uy, fz) var l = Math.sqrt(2 * tf - tr + 1.0) if(rx >= tf) { //x y z order out[0] = 0.5 * l out[1] = 0.5 * (ux + ry) / l out[2] = 0.5 * (fx + rz) / l out[3] = 0.5 * (uz - fy) / l } else if(uy >= tf) { //y z x order out[0] = 0.5 * (ry + ux) / l out[1] = 0.5 * l out[2] = 0.5 * (fy + uz) / l out[3] = 0.5 * (fx - rz) / l } else { //z x y order out[0] = 0.5 * (rz + fx) / l out[1] = 0.5 * (uz + fy) / l out[2] = 0.5 * l out[3] = 0.5 * (ry - ux) / l } } return out } },{}],36:[function(require,module,exports){ 'use strict' module.exports = createOrbitController var filterVector = require('filtered-vector') var lookAt = require('gl-mat4/lookAt') var mat4FromQuat = require('gl-mat4/fromQuat') var invert44 = require('gl-mat4/invert') var quatFromFrame = require('./lib/quatFromFrame') function len3(x,y,z) { return Math.sqrt(Math.pow(x,2) + Math.pow(y,2) + Math.pow(z,2)) } function len4(w,x,y,z) { return Math.sqrt(Math.pow(w,2) + Math.pow(x,2) + Math.pow(y,2) + Math.pow(z,2)) } function normalize4(out, a) { var ax = a[0] var ay = a[1] var az = a[2] var aw = a[3] var al = len4(ax, ay, az, aw) if(al > 1e-6) { out[0] = ax/al out[1] = ay/al out[2] = az/al out[3] = aw/al } else { out[0] = out[1] = out[2] = 0.0 out[3] = 1.0 } } function OrbitCameraController(initQuat, initCenter, initRadius) { this.radius = filterVector([initRadius]) this.center = filterVector(initCenter) this.rotation = filterVector(initQuat) this.computedRadius = this.radius.curve(0) this.computedCenter = this.center.curve(0) this.computedRotation = this.rotation.curve(0) this.computedUp = [0.1,0,0] this.computedEye = [0.1,0,0] this.computedMatrix = [0.1,0,0,0,0,0,0,0,0,0,0,0,0,0,0,0] this.recalcMatrix(0) } var proto = OrbitCameraController.prototype proto.lastT = function() { return Math.max( this.radius.lastT(), this.center.lastT(), this.rotation.lastT()) } proto.recalcMatrix = function(t) { this.radius.curve(t) this.center.curve(t) this.rotation.curve(t) var quat = this.computedRotation normalize4(quat, quat) var mat = this.computedMatrix mat4FromQuat(mat, quat) var center = this.computedCenter var eye = this.computedEye var up = this.computedUp var radius = Math.exp(this.computedRadius[0]) eye[0] = center[0] + radius * mat[2] eye[1] = center[1] + radius * mat[6] eye[2] = center[2] + radius * mat[10] up[0] = mat[1] up[1] = mat[5] up[2] = mat[9] for(var i=0; i<3; ++i) { var rr = 0.0 for(var j=0; j<3; ++j) { rr += mat[i+4*j] * eye[j] } mat[12+i] = -rr } } proto.getMatrix = function(t, result) { this.recalcMatrix(t) var m = this.computedMatrix if(result) { for(var i=0; i<16; ++i) { result[i] = m[i] } return result } return m } proto.idle = function(t) { this.center.idle(t) this.radius.idle(t) this.rotation.idle(t) } proto.flush = function(t) { this.center.flush(t) this.radius.flush(t) this.rotation.flush(t) } proto.pan = function(t, dx, dy, dz) { dx = dx || 0.0 dy = dy || 0.0 dz = dz || 0.0 this.recalcMatrix(t) var mat = this.computedMatrix var ux = mat[1] var uy = mat[5] var uz = mat[9] var ul = len3(ux, uy, uz) ux /= ul uy /= ul uz /= ul var rx = mat[0] var ry = mat[4] var rz = mat[8] var ru = rx * ux + ry * uy + rz * uz rx -= ux * ru ry -= uy * ru rz -= uz * ru var rl = len3(rx, ry, rz) rx /= rl ry /= rl rz /= rl var fx = mat[2] var fy = mat[6] var fz = mat[10] var fu = fx * ux + fy * uy + fz * uz var fr = fx * rx + fy * ry + fz * rz fx -= fu * ux + fr * rx fy -= fu * uy + fr * ry fz -= fu * uz + fr * rz var fl = len3(fx, fy, fz) fx /= fl fy /= fl fz /= fl var vx = rx * dx + ux * dy var vy = ry * dx + uy * dy var vz = rz * dx + uz * dy this.center.move(t, vx, vy, vz) //Update z-component of radius var radius = Math.exp(this.computedRadius[0]) radius = Math.max(1e-4, radius + dz) this.radius.set(t, Math.log(radius)) } proto.rotate = function(t, dx, dy, dz) { this.recalcMatrix(t) dx = dx||0.0 dy = dy||0.0 var mat = this.computedMatrix var rx = mat[0] var ry = mat[4] var rz = mat[8] var ux = mat[1] var uy = mat[5] var uz = mat[9] var fx = mat[2] var fy = mat[6] var fz = mat[10] var qx = dx * rx + dy * ux var qy = dx * ry + dy * uy var qz = dx * rz + dy * uz var bx = -(fy * qz - fz * qy) var by = -(fz * qx - fx * qz) var bz = -(fx * qy - fy * qx) var bw = Math.sqrt(Math.max(0.0, 1.0 - Math.pow(bx,2) - Math.pow(by,2) - Math.pow(bz,2))) var bl = len4(bx, by, bz, bw) if(bl > 1e-6) { bx /= bl by /= bl bz /= bl bw /= bl } else { bx = by = bz = 0.0 bw = 1.0 } var rotation = this.computedRotation var ax = rotation[0] var ay = rotation[1] var az = rotation[2] var aw = rotation[3] var cx = ax*bw + aw*bx + ay*bz - az*by var cy = ay*bw + aw*by + az*bx - ax*bz var cz = az*bw + aw*bz + ax*by - ay*bx var cw = aw*bw - ax*bx - ay*by - az*bz //Apply roll if(dz) { bx = fx by = fy bz = fz var s = Math.sin(dz) / len3(bx, by, bz) bx *= s by *= s bz *= s bw = Math.cos(dx) cx = cx*bw + cw*bx + cy*bz - cz*by cy = cy*bw + cw*by + cz*bx - cx*bz cz = cz*bw + cw*bz + cx*by - cy*bx cw = cw*bw - cx*bx - cy*by - cz*bz } var cl = len4(cx, cy, cz, cw) if(cl > 1e-6) { cx /= cl cy /= cl cz /= cl cw /= cl } else { cx = cy = cz = 0.0 cw = 1.0 } this.rotation.set(t, cx, cy, cz, cw) } proto.lookAt = function(t, eye, center, up) { this.recalcMatrix(t) center = center || this.computedCenter eye = eye || this.computedEye up = up || this.computedUp var mat = this.computedMatrix lookAt(mat, eye, center, up) var rotation = this.computedRotation quatFromFrame(rotation, mat[0], mat[1], mat[2], mat[4], mat[5], mat[6], mat[8], mat[9], mat[10]) normalize4(rotation, rotation) this.rotation.set(t, rotation[0], rotation[1], rotation[2], rotation[3]) var fl = 0.0 for(var i=0; i<3; ++i) { fl += Math.pow(center[i] - eye[i], 2) } this.radius.set(t, 0.5 * Math.log(Math.max(fl, 1e-6))) this.center.set(t, center[0], center[1], center[2]) } proto.translate = function(t, dx, dy, dz) { this.center.move(t, dx||0.0, dy||0.0, dz||0.0) } proto.setMatrix = function(t, matrix) { var rotation = this.computedRotation quatFromFrame(rotation, matrix[0], matrix[1], matrix[2], matrix[4], matrix[5], matrix[6], matrix[8], matrix[9], matrix[10]) normalize4(rotation, rotation) this.rotation.set(t, rotation[0], rotation[1], rotation[2], rotation[3]) var mat = this.computedMatrix invert44(mat, matrix) var w = mat[15] if(Math.abs(w) > 1e-6) { var cx = mat[12]/w var cy = mat[13]/w var cz = mat[14]/w this.recalcMatrix(t) var r = Math.exp(this.computedRadius[0]) this.center.set(t, cx-mat[2]*r, cy-mat[6]*r, cz-mat[10]*r) this.radius.idle(t) } else { this.center.idle(t) this.radius.idle(t) } } proto.setDistance = function(t, d) { if(d > 0) { this.radius.set(t, Math.log(d)) } } proto.setDistanceLimits = function(lo, hi) { if(lo > 0) { lo = Math.log(lo) } else { lo = -Infinity } if(hi > 0) { hi = Math.log(hi) } else { hi = Infinity } hi = Math.max(hi, lo) this.radius.bounds[0][0] = lo this.radius.bounds[1][0] = hi } proto.getDistanceLimits = function(out) { var bounds = this.radius.bounds if(out) { out[0] = Math.exp(bounds[0][0]) out[1] = Math.exp(bounds[1][0]) return out } return [ Math.exp(bounds[0][0]), Math.exp(bounds[1][0]) ] } proto.toJSON = function() { this.recalcMatrix(this.lastT()) return { center: this.computedCenter.slice(), rotation: this.computedRotation.slice(), distance: Math.log(this.computedRadius[0]), zoomMin: this.radius.bounds[0][0], zoomMax: this.radius.bounds[1][0] } } proto.fromJSON = function(options) { var t = this.lastT() var c = options.center if(c) { this.center.set(t, c[0], c[1], c[2]) } var r = options.rotation if(r) { this.rotation.set(t, r[0], r[1], r[2], r[3]) } var d = options.distance if(d && d > 0) { this.radius.set(t, Math.log(d)) } this.setDistanceLimits(options.zoomMin, options.zoomMax) } function createOrbitController(options) { options = options || {} var center = options.center || [0,0,0] var rotation = options.rotation || [0,0,0,1] var radius = options.radius || 1.0 center = [].slice.call(center, 0, 3) rotation = [].slice.call(rotation, 0, 4) normalize4(rotation, rotation) var result = new OrbitCameraController( rotation, center, Math.log(radius)) result.setDistanceLimits(options.zoomMin, options.zoomMax) if('eye' in options || 'up' in options) { result.lookAt(0, options.eye, options.center, options.up) } return result } },{"./lib/quatFromFrame":35,"filtered-vector":19,"gl-mat4/fromQuat":91,"gl-mat4/invert":94,"gl-mat4/lookAt":95}],37:[function(require,module,exports){ 'use strict' module.exports = createTurntableController var filterVector = require('filtered-vector') var invert44 = require('gl-mat4/invert') var rotateM = require('gl-mat4/rotate') var cross = require('gl-vec3/cross') var normalize3 = require('gl-vec3/normalize') var dot3 = require('gl-vec3/dot') function len3(x, y, z) { return Math.sqrt(Math.pow(x, 2) + Math.pow(y, 2) + Math.pow(z, 2)) } function clamp1(x) { return Math.min(1.0, Math.max(-1.0, x)) } function findOrthoPair(v) { var vx = Math.abs(v[0]) var vy = Math.abs(v[1]) var vz = Math.abs(v[2]) var u = [0,0,0] if(vx > Math.max(vy, vz)) { u[2] = 1 } else if(vy > Math.max(vx, vz)) { u[0] = 1 } else { u[1] = 1 } var vv = 0 var uv = 0 for(var i=0; i<3; ++i ) { vv += v[i] * v[i] uv += u[i] * v[i] } for(var i=0; i<3; ++i) { u[i] -= (uv / vv) * v[i] } normalize3(u, u) return u } function TurntableController(zoomMin, zoomMax, center, up, right, radius, theta, phi) { this.center = filterVector(center) this.up = filterVector(up) this.right = filterVector(right) this.radius = filterVector([radius]) this.angle = filterVector([theta, phi]) this.angle.bounds = [[-Infinity,-Math.PI/2], [Infinity,Math.PI/2]] this.setDistanceLimits(zoomMin, zoomMax) this.computedCenter = this.center.curve(0) this.computedUp = this.up.curve(0) this.computedRight = this.right.curve(0) this.computedRadius = this.radius.curve(0) this.computedAngle = this.angle.curve(0) this.computedToward = [0,0,0] this.computedEye = [0,0,0] this.computedMatrix = new Array(16) for(var i=0; i<16; ++i) { this.computedMatrix[i] = 0.5 } this.recalcMatrix(0) } var proto = TurntableController.prototype proto.setDistanceLimits = function(minDist, maxDist) { if(minDist > 0) { minDist = Math.log(minDist) } else { minDist = -Infinity } if(maxDist > 0) { maxDist = Math.log(maxDist) } else { maxDist = Infinity } maxDist = Math.max(maxDist, minDist) this.radius.bounds[0][0] = minDist this.radius.bounds[1][0] = maxDist } proto.getDistanceLimits = function(out) { var bounds = this.radius.bounds[0] if(out) { out[0] = Math.exp(bounds[0][0]) out[1] = Math.exp(bounds[1][0]) return out } return [ Math.exp(bounds[0][0]), Math.exp(bounds[1][0]) ] } proto.recalcMatrix = function(t) { //Recompute curves this.center.curve(t) this.up.curve(t) this.right.curve(t) this.radius.curve(t) this.angle.curve(t) //Compute frame for camera matrix var up = this.computedUp var right = this.computedRight var uu = 0.0 var ur = 0.0 for(var i=0; i<3; ++i) { ur += up[i] * right[i] uu += up[i] * up[i] } var ul = Math.sqrt(uu) var rr = 0.0 for(var i=0; i<3; ++i) { right[i] -= up[i] * ur / uu rr += right[i] * right[i] up[i] /= ul } var rl = Math.sqrt(rr) for(var i=0; i<3; ++i) { right[i] /= rl } //Compute toward vector var toward = this.computedToward cross(toward, up, right) normalize3(toward, toward) //Compute angular parameters var radius = Math.exp(this.computedRadius[0]) var theta = this.computedAngle[0] var phi = this.computedAngle[1] var ctheta = Math.cos(theta) var stheta = Math.sin(theta) var cphi = Math.cos(phi) var sphi = Math.sin(phi) var center = this.computedCenter var wx = ctheta * cphi var wy = stheta * cphi var wz = sphi var sx = -ctheta * sphi var sy = -stheta * sphi var sz = cphi var eye = this.computedEye var mat = this.computedMatrix for(var i=0; i<3; ++i) { var x = wx * right[i] + wy * toward[i] + wz * up[i] mat[4*i+1] = sx * right[i] + sy * toward[i] + sz * up[i] mat[4*i+2] = x mat[4*i+3] = 0.0 } var ax = mat[1] var ay = mat[5] var az = mat[9] var bx = mat[2] var by = mat[6] var bz = mat[10] var cx = ay * bz - az * by var cy = az * bx - ax * bz var cz = ax * by - ay * bx var cl = len3(cx, cy, cz) cx /= cl cy /= cl cz /= cl mat[0] = cx mat[4] = cy mat[8] = cz for(var i=0; i<3; ++i) { eye[i] = center[i] + mat[2+4*i]*radius } for(var i=0; i<3; ++i) { var rr = 0.0 for(var j=0; j<3; ++j) { rr += mat[i+4*j] * eye[j] } mat[12+i] = -rr } mat[15] = 1.0 } proto.getMatrix = function(t, result) { this.recalcMatrix(t) var mat = this.computedMatrix if(result) { for(var i=0; i<16; ++i) { result[i] = mat[i] } return result } return mat } var zAxis = [0,0,0] proto.rotate = function(t, dtheta, dphi, droll) { this.angle.move(t, dtheta, dphi) if(droll) { this.recalcMatrix(t) var mat = this.computedMatrix zAxis[0] = mat[2] zAxis[1] = mat[6] zAxis[2] = mat[10] var up = this.computedUp var right = this.computedRight var toward = this.computedToward for(var i=0; i<3; ++i) { mat[4*i] = up[i] mat[4*i+1] = right[i] mat[4*i+2] = toward[i] } rotateM(mat, mat, droll, zAxis) for(var i=0; i<3; ++i) { up[i] = mat[4*i] right[i] = mat[4*i+1] } this.up.set(t, up[0], up[1], up[2]) this.right.set(t, right[0], right[1], right[2]) } } proto.pan = function(t, dx, dy, dz) { dx = dx || 0.0 dy = dy || 0.0 dz = dz || 0.0 this.recalcMatrix(t) var mat = this.computedMatrix var dist = Math.exp(this.computedRadius[0]) var ux = mat[1] var uy = mat[5] var uz = mat[9] var ul = len3(ux, uy, uz) ux /= ul uy /= ul uz /= ul var rx = mat[0] var ry = mat[4] var rz = mat[8] var ru = rx * ux + ry * uy + rz * uz rx -= ux * ru ry -= uy * ru rz -= uz * ru var rl = len3(rx, ry, rz) rx /= rl ry /= rl rz /= rl var vx = rx * dx + ux * dy var vy = ry * dx + uy * dy var vz = rz * dx + uz * dy this.center.move(t, vx, vy, vz) //Update z-component of radius var radius = Math.exp(this.computedRadius[0]) radius = Math.max(1e-4, radius + dz) this.radius.set(t, Math.log(radius)) } proto.translate = function(t, dx, dy, dz) { this.center.move(t, dx||0.0, dy||0.0, dz||0.0) } //Recenters the coordinate axes proto.setMatrix = function(t, mat, axes, noSnap) { //Get the axes for tare var ushift = 1 if(typeof axes === 'number') { ushift = (axes)|0 } if(ushift < 0 || ushift > 3) { ushift = 1 } var vshift = (ushift + 2) % 3 var fshift = (ushift + 1) % 3 //Recompute state for new t value if(!mat) { this.recalcMatrix(t) mat = this.computedMatrix } //Get right and up vectors var ux = mat[ushift] var uy = mat[ushift+4] var uz = mat[ushift+8] if(!noSnap) { var ul = len3(ux, uy, uz) ux /= ul uy /= ul uz /= ul } else { var ax = Math.abs(ux) var ay = Math.abs(uy) var az = Math.abs(uz) var am = Math.max(ax,ay,az) if(ax === am) { ux = (ux < 0) ? -1 : 1 uy = uz = 0 } else if(az === am) { uz = (uz < 0) ? -1 : 1 ux = uy = 0 } else { uy = (uy < 0) ? -1 : 1 ux = uz = 0 } } var rx = mat[vshift] var ry = mat[vshift+4] var rz = mat[vshift+8] var ru = rx * ux + ry * uy + rz * uz rx -= ux * ru ry -= uy * ru rz -= uz * ru var rl = len3(rx, ry, rz) rx /= rl ry /= rl rz /= rl var fx = uy * rz - uz * ry var fy = uz * rx - ux * rz var fz = ux * ry - uy * rx var fl = len3(fx, fy, fz) fx /= fl fy /= fl fz /= fl this.center.jump(t, ex, ey, ez) this.radius.idle(t) this.up.jump(t, ux, uy, uz) this.right.jump(t, rx, ry, rz) var phi, theta if(ushift === 2) { var cx = mat[1] var cy = mat[5] var cz = mat[9] var cr = cx * rx + cy * ry + cz * rz var cf = cx * fx + cy * fy + cz * fz if(tu < 0) { phi = -Math.PI/2 } else { phi = Math.PI/2 } theta = Math.atan2(cf, cr) } else { var tx = mat[2] var ty = mat[6] var tz = mat[10] var tu = tx * ux + ty * uy + tz * uz var tr = tx * rx + ty * ry + tz * rz var tf = tx * fx + ty * fy + tz * fz phi = Math.asin(clamp1(tu)) theta = Math.atan2(tf, tr) } this.angle.jump(t, theta, phi) this.recalcMatrix(t) var dx = mat[2] var dy = mat[6] var dz = mat[10] var imat = this.computedMatrix invert44(imat, mat) var w = imat[15] var ex = imat[12] / w var ey = imat[13] / w var ez = imat[14] / w var gs = Math.exp(this.computedRadius[0]) this.center.jump(t, ex-dx*gs, ey-dy*gs, ez-dz*gs) } proto.lastT = function() { return Math.max( this.center.lastT(), this.up.lastT(), this.right.lastT(), this.radius.lastT(), this.angle.lastT()) } proto.idle = function(t) { this.center.idle(t) this.up.idle(t) this.right.idle(t) this.radius.idle(t) this.angle.idle(t) } proto.flush = function(t) { this.center.flush(t) this.up.flush(t) this.right.flush(t) this.radius.flush(t) this.angle.flush(t) } proto.setDistance = function(t, d) { if(d > 0) { this.radius.set(t, Math.log(d)) } } proto.lookAt = function(t, eye, center, up) { this.recalcMatrix(t) eye = eye || this.computedEye center = center || this.computedCenter up = up || this.computedUp var ux = up[0] var uy = up[1] var uz = up[2] var ul = len3(ux, uy, uz) if(ul < 1e-6) { return } ux /= ul uy /= ul uz /= ul var tx = eye[0] - center[0] var ty = eye[1] - center[1] var tz = eye[2] - center[2] var tl = len3(tx, ty, tz) if(tl < 1e-6) { return } tx /= tl ty /= tl tz /= tl var right = this.computedRight var rx = right[0] var ry = right[1] var rz = right[2] var ru = ux*rx + uy*ry + uz*rz rx -= ru * ux ry -= ru * uy rz -= ru * uz var rl = len3(rx, ry, rz) if(rl < 0.01) { rx = uy * tz - uz * ty ry = uz * tx - ux * tz rz = ux * ty - uy * tx rl = len3(rx, ry, rz) if(rl < 1e-6) { return } } rx /= rl ry /= rl rz /= rl this.up.set(t, ux, uy, uz) this.right.set(t, rx, ry, rz) this.center.set(t, center[0], center[1], center[2]) this.radius.set(t, Math.log(tl)) var fx = uy * rz - uz * ry var fy = uz * rx - ux * rz var fz = ux * ry - uy * rx var fl = len3(fx, fy, fz) fx /= fl fy /= fl fz /= fl var tu = ux*tx + uy*ty + uz*tz var tr = rx*tx + ry*ty + rz*tz var tf = fx*tx + fy*ty + fz*tz var phi = Math.asin(clamp1(tu)) var theta = Math.atan2(tf, tr) var angleState = this.angle._state var lastTheta = angleState[angleState.length-1] var lastPhi = angleState[angleState.length-2] lastTheta = lastTheta % (2.0 * Math.PI) var dp = Math.abs(lastTheta + 2.0 * Math.PI - theta) var d0 = Math.abs(lastTheta - theta) var dn = Math.abs(lastTheta - 2.0 * Math.PI - theta) if(dp < d0) { lastTheta += 2.0 * Math.PI } if(dn < d0) { lastTheta -= 2.0 * Math.PI } this.angle.jump(this.angle.lastT(), lastTheta, lastPhi) this.angle.set(t, theta, phi) } function createTurntableController(options) { options = options || {} var center = options.center || [0,0,0] var up = options.up || [0,1,0] var right = options.right || findOrthoPair(up) var radius = options.radius || 1.0 var theta = options.theta || 0.0 var phi = options.phi || 0.0 center = [].slice.call(center, 0, 3) up = [].slice.call(up, 0, 3) normalize3(up, up) right = [].slice.call(right, 0, 3) normalize3(right, right) if('eye' in options) { var eye = options.eye var toward = [ eye[0]-center[0], eye[1]-center[1], eye[2]-center[2] ] cross(right, toward, up) if(len3(right[0], right[1], right[2]) < 1e-6) { right = findOrthoPair(up) } else { normalize3(right, right) } radius = len3(toward[0], toward[1], toward[2]) var ut = dot3(up, toward) / radius var rt = dot3(right, toward) / radius phi = Math.acos(ut) theta = Math.acos(rt) } //Use logarithmic coordinates for radius radius = Math.log(radius) //Return the controller return new TurntableController( options.zoomMin, options.zoomMax, center, up, right, radius, theta, phi) } },{"filtered-vector":19,"gl-mat4/invert":94,"gl-mat4/rotate":98,"gl-vec3/cross":22,"gl-vec3/dot":23,"gl-vec3/normalize":26}],38:[function(require,module,exports){ 'use strict' module.exports = createViewController var createTurntable = require('turntable-camera-controller') var createOrbit = require('orbit-camera-controller') var createMatrix = require('matrix-camera-controller') function ViewController(controllers, mode) { this._controllerNames = Object.keys(controllers) this._controllerList = this._controllerNames.map(function(n) { return controllers[n] }) this._mode = mode this._active = controllers[mode] if(!this._active) { this._mode = 'turntable' this._active = controllers.turntable } this.modes = this._controllerNames this.computedMatrix = this._active.computedMatrix this.computedEye = this._active.computedEye this.computedUp = this._active.computedUp this.computedCenter = this._active.computedCenter this.computedRadius = this._active.computedRadius } var proto = ViewController.prototype var COMMON_METHODS = [ ['flush', 1], ['idle', 1], ['lookAt', 4], ['rotate', 4], ['pan', 4], ['translate', 4], ['setMatrix', 2], ['setDistanceLimits', 2], ['setDistance', 2] ] COMMON_METHODS.forEach(function(method) { var name = method[0] var argNames = [] for(var i=0; i 0) { var f = cells[ptr-1] if(compareCell(c, f) === 0 && orientation(f) !== o) { ptr -= 1 continue } } cells[ptr++] = c } cells.length = ptr return cells } },{"cell-orientation":45,"compare-cell":59,"compare-oriented-cell":46}],48:[function(require,module,exports){ 'use strict'; var arraytools = function () { var that = {}; var RGB_REGEX = /^rgba?\(\s*\d{1,3}\s*,\s*\d{1,3}\s*,\s*\d{1,3}\s*(,.*)?\)$/; var RGB_GROUP_REGEX = /^rgba?\(\s*(\d{1,3})\s*,\s*(\d{1,3})\s*,\s*(\d{1,3})\s*,?\s*(.*)?\)$/; function isPlainObject (v) { return !Array.isArray(v) && v !== null && typeof v === 'object'; } function linspace (start, end, num) { var inc = (end - start) / Math.max(num - 1, 1); var a = []; for( var ii = 0; ii < num; ii++) a.push(start + ii*inc); return a; } function zip () { var arrays = [].slice.call(arguments); var lengths = arrays.map(function (a) {return a.length;}); var len = Math.min.apply(null, lengths); var zipped = []; for (var i = 0; i < len; i++) { zipped[i] = []; for (var j = 0; j < arrays.length; ++j) { zipped[i][j] = arrays[j][i]; } } return zipped; } function zip3 (a, b, c) { var len = Math.min.apply(null, [a.length, b.length, c.length]); var result = []; for (var n = 0; n < len; n++) { result.push([a[n], b[n], c[n]]); } return result; } function sum (A) { var acc = 0; accumulate(A, acc); function accumulate(x) { for (var i = 0; i < x.length; i++) { if (Array.isArray(x[i])) accumulate(x[i], acc); else acc += x[i]; } } return acc; } function copy2D (arr) { var carr = []; for (var i = 0; i < arr.length; ++i) { carr[i] = []; for (var j = 0; j < arr[i].length; ++j) { carr[i][j] = arr[i][j]; } } return carr; } function copy1D (arr) { var carr = []; for (var i = 0; i < arr.length; ++i) { carr[i] = arr[i]; } return carr; } function isEqual(arr1, arr2) { if(arr1.length !== arr2.length) return false; for(var i = arr1.length; i--;) { if(arr1[i] !== arr2[i]) return false; } return true; } function str2RgbArray(str, twoFiftySix) { // convert hex or rbg strings to 0->1 or 0->255 rgb array var rgb, match; if (typeof str !== 'string') return str; rgb = []; // hex notation if (str[0] === '#') { str = str.substr(1) // remove hash if (str.length === 3) str += str // fff -> ffffff match = parseInt(str, 16); rgb[0] = ((match >> 16) & 255); rgb[1] = ((match >> 8) & 255); rgb[2] = (match & 255); } // rgb(34, 34, 127) or rgba(34, 34, 127, 0.1) notation else if (RGB_REGEX.test(str)) { match = str.match(RGB_GROUP_REGEX); rgb[0] = parseInt(match[1]); rgb[1] = parseInt(match[2]); rgb[2] = parseInt(match[3]); } if (!twoFiftySix) { for (var j=0; j<3; ++j) rgb[j] = rgb[j]/255 } return rgb; } function str2RgbaArray(str, twoFiftySix) { // convert hex or rbg strings to 0->1 or 0->255 rgb array var rgb, match; if (typeof str !== 'string') return str; rgb = []; // hex notation if (str[0] === '#') { str = str.substr(1) // remove hash if (str.length === 3) str += str // fff -> ffffff match = parseInt(str, 16); rgb[0] = ((match >> 16) & 255); rgb[1] = ((match >> 8) & 255); rgb[2] = (match & 255); } // rgb(34, 34, 127) or rgba(34, 34, 127, 0.1) notation else if (RGB_REGEX.test(str)) { match = str.match(RGB_GROUP_REGEX); rgb[0] = parseInt(match[1]); rgb[1] = parseInt(match[2]); rgb[2] = parseInt(match[3]); if (match[4]) rgb[3] = parseFloat(match[4]); else rgb[3] = 1.0; } if (!twoFiftySix) { for (var j=0; j<3; ++j) rgb[j] = rgb[j]/255 } return rgb; } that.isPlainObject = isPlainObject; that.linspace = linspace; that.zip3 = zip3; that.sum = sum; that.zip = zip; that.isEqual = isEqual; that.copy2D = copy2D; that.copy1D = copy1D; that.str2RgbArray = str2RgbArray; that.str2RgbaArray = str2RgbaArray; return that } module.exports = arraytools(); },{}],49:[function(require,module,exports){ /** * Bit twiddling hacks for JavaScript. * * Author: Mikola Lysenko * * Ported from Stanford bit twiddling hack library: * http://graphics.stanford.edu/~seander/bithacks.html */ "use strict"; "use restrict"; //Number of bits in an integer var INT_BITS = 32; //Constants exports.INT_BITS = INT_BITS; exports.INT_MAX = 0x7fffffff; exports.INT_MIN = -1<<(INT_BITS-1); //Returns -1, 0, +1 depending on sign of x exports.sign = function(v) { return (v > 0) - (v < 0); } //Computes absolute value of integer exports.abs = function(v) { var mask = v >> (INT_BITS-1); return (v ^ mask) - mask; } //Computes minimum of integers x and y exports.min = function(x, y) { return y ^ ((x ^ y) & -(x < y)); } //Computes maximum of integers x and y exports.max = function(x, y) { return x ^ ((x ^ y) & -(x < y)); } //Checks if a number is a power of two exports.isPow2 = function(v) { return !(v & (v-1)) && (!!v); } //Computes log base 2 of v exports.log2 = function(v) { var r, shift; r = (v > 0xFFFF) << 4; v >>>= r; shift = (v > 0xFF ) << 3; v >>>= shift; r |= shift; shift = (v > 0xF ) << 2; v >>>= shift; r |= shift; shift = (v > 0x3 ) << 1; v >>>= shift; r |= shift; return r | (v >> 1); } //Computes log base 10 of v exports.log10 = function(v) { return (v >= 1000000000) ? 9 : (v >= 100000000) ? 8 : (v >= 10000000) ? 7 : (v >= 1000000) ? 6 : (v >= 100000) ? 5 : (v >= 10000) ? 4 : (v >= 1000) ? 3 : (v >= 100) ? 2 : (v >= 10) ? 1 : 0; } //Counts number of bits exports.popCount = function(v) { v = v - ((v >>> 1) & 0x55555555); v = (v & 0x33333333) + ((v >>> 2) & 0x33333333); return ((v + (v >>> 4) & 0xF0F0F0F) * 0x1010101) >>> 24; } //Counts number of trailing zeros function countTrailingZeros(v) { var c = 32; v &= -v; if (v) c--; if (v & 0x0000FFFF) c -= 16; if (v & 0x00FF00FF) c -= 8; if (v & 0x0F0F0F0F) c -= 4; if (v & 0x33333333) c -= 2; if (v & 0x55555555) c -= 1; return c; } exports.countTrailingZeros = countTrailingZeros; //Rounds to next power of 2 exports.nextPow2 = function(v) { v += v === 0; --v; v |= v >>> 1; v |= v >>> 2; v |= v >>> 4; v |= v >>> 8; v |= v >>> 16; return v + 1; } //Rounds down to previous power of 2 exports.prevPow2 = function(v) { v |= v >>> 1; v |= v >>> 2; v |= v >>> 4; v |= v >>> 8; v |= v >>> 16; return v - (v>>>1); } //Computes parity of word exports.parity = function(v) { v ^= v >>> 16; v ^= v >>> 8; v ^= v >>> 4; v &= 0xf; return (0x6996 >>> v) & 1; } var REVERSE_TABLE = new Array(256); (function(tab) { for(var i=0; i<256; ++i) { var v = i, r = i, s = 7; for (v >>>= 1; v; v >>>= 1) { r <<= 1; r |= v & 1; --s; } tab[i] = (r << s) & 0xff; } })(REVERSE_TABLE); //Reverse bits in a 32 bit word exports.reverse = function(v) { return (REVERSE_TABLE[ v & 0xff] << 24) | (REVERSE_TABLE[(v >>> 8) & 0xff] << 16) | (REVERSE_TABLE[(v >>> 16) & 0xff] << 8) | REVERSE_TABLE[(v >>> 24) & 0xff]; } //Interleave bits of 2 coordinates with 16 bits. Useful for fast quadtree codes exports.interleave2 = function(x, y) { x &= 0xFFFF; x = (x | (x << 8)) & 0x00FF00FF; x = (x | (x << 4)) & 0x0F0F0F0F; x = (x | (x << 2)) & 0x33333333; x = (x | (x << 1)) & 0x55555555; y &= 0xFFFF; y = (y | (y << 8)) & 0x00FF00FF; y = (y | (y << 4)) & 0x0F0F0F0F; y = (y | (y << 2)) & 0x33333333; y = (y | (y << 1)) & 0x55555555; return x | (y << 1); } //Extracts the nth interleaved component exports.deinterleave2 = function(v, n) { v = (v >>> n) & 0x55555555; v = (v | (v >>> 1)) & 0x33333333; v = (v | (v >>> 2)) & 0x0F0F0F0F; v = (v | (v >>> 4)) & 0x00FF00FF; v = (v | (v >>> 16)) & 0x000FFFF; return (v << 16) >> 16; } //Interleave bits of 3 coordinates, each with 10 bits. Useful for fast octree codes exports.interleave3 = function(x, y, z) { x &= 0x3FF; x = (x | (x<<16)) & 4278190335; x = (x | (x<<8)) & 251719695; x = (x | (x<<4)) & 3272356035; x = (x | (x<<2)) & 1227133513; y &= 0x3FF; y = (y | (y<<16)) & 4278190335; y = (y | (y<<8)) & 251719695; y = (y | (y<<4)) & 3272356035; y = (y | (y<<2)) & 1227133513; x |= (y << 1); z &= 0x3FF; z = (z | (z<<16)) & 4278190335; z = (z | (z<<8)) & 251719695; z = (z | (z<<4)) & 3272356035; z = (z | (z<<2)) & 1227133513; return x | (z << 2); } //Extracts nth interleaved component of a 3-tuple exports.deinterleave3 = function(v, n) { v = (v >>> n) & 1227133513; v = (v | (v>>>2)) & 3272356035; v = (v | (v>>>4)) & 251719695; v = (v | (v>>>8)) & 4278190335; v = (v | (v>>>16)) & 0x3FF; return (v<<22)>>22; } //Computes next combination in colexicographic order (this is mistakenly called nextPermutation on the bit twiddling hacks page) exports.nextCombination = function(v) { var t = v | (v - 1); return (t + 1) | (((~t & -~t) - 1) >>> (countTrailingZeros(v) + 1)); } },{}],50:[function(require,module,exports){ (function (global){ /*! * The buffer module from node.js, for the browser. * * @author Feross Aboukhadijeh * @license MIT */ /* eslint-disable no-proto */ 'use strict' var base64 = require('base64-js') var ieee754 = require('ieee754') var isArray = require('isarray') exports.Buffer = Buffer exports.SlowBuffer = SlowBuffer exports.INSPECT_MAX_BYTES = 50 Buffer.poolSize = 8192 // not used by this implementation var rootParent = {} /** * If `Buffer.TYPED_ARRAY_SUPPORT`: * === true Use Uint8Array implementation (fastest) * === false Use Object implementation (most compatible, even IE6) * * Browsers that support typed arrays are IE 10+, Firefox 4+, Chrome 7+, Safari 5.1+, * Opera 11.6+, iOS 4.2+. * * Due to various browser bugs, sometimes the Object implementation will be used even * when the browser supports typed arrays. * * Note: * * - Firefox 4-29 lacks support for adding new properties to `Uint8Array` instances, * See: https://bugzilla.mozilla.org/show_bug.cgi?id=695438. * * - Chrome 9-10 is missing the `TypedArray.prototype.subarray` function. * * - IE10 has a broken `TypedArray.prototype.subarray` function which returns arrays of * incorrect length in some situations. * We detect these buggy browsers and set `Buffer.TYPED_ARRAY_SUPPORT` to `false` so they * get the Object implementation, which is slower but behaves correctly. */ Buffer.TYPED_ARRAY_SUPPORT = global.TYPED_ARRAY_SUPPORT !== undefined ? global.TYPED_ARRAY_SUPPORT : typedArraySupport() function typedArraySupport () { try { var arr = new Uint8Array(1) arr.foo = function () { return 42 } return arr.foo() === 42 && // typed array instances can be augmented typeof arr.subarray === 'function' && // chrome 9-10 lack `subarray` arr.subarray(1, 1).byteLength === 0 // ie10 has broken `subarray` } catch (e) { return false } } function kMaxLength () { return Buffer.TYPED_ARRAY_SUPPORT ? 0x7fffffff : 0x3fffffff } /** * Class: Buffer * ============= * * The Buffer constructor returns instances of `Uint8Array` that are augmented * with function properties for all the node `Buffer` API functions. We use * `Uint8Array` so that square bracket notation works as expected -- it returns * a single octet. * * By augmenting the instances, we can avoid modifying the `Uint8Array` * prototype. */ function Buffer (arg) { if (!(this instanceof Buffer)) { // Avoid going through an ArgumentsAdaptorTrampoline in the common case. if (arguments.length > 1) return new Buffer(arg, arguments[1]) return new Buffer(arg) } if (!Buffer.TYPED_ARRAY_SUPPORT) { this.length = 0 this.parent = undefined } // Common case. if (typeof arg === 'number') { return fromNumber(this, arg) } // Slightly less common case. if (typeof arg === 'string') { return fromString(this, arg, arguments.length > 1 ? arguments[1] : 'utf8') } // Unusual. return fromObject(this, arg) } function fromNumber (that, length) { that = allocate(that, length < 0 ? 0 : checked(length) | 0) if (!Buffer.TYPED_ARRAY_SUPPORT) { for (var i = 0; i < length; i++) { that[i] = 0 } } return that } function fromString (that, string, encoding) { if (typeof encoding !== 'string' || encoding === '') encoding = 'utf8' // Assumption: byteLength() return value is always < kMaxLength. var length = byteLength(string, encoding) | 0 that = allocate(that, length) that.write(string, encoding) return that } function fromObject (that, object) { if (Buffer.isBuffer(object)) return fromBuffer(that, object) if (isArray(object)) return fromArray(that, object) if (object == null) { throw new TypeError('must start with number, buffer, array or string') } if (typeof ArrayBuffer !== 'undefined') { if (object.buffer instanceof ArrayBuffer) { return fromTypedArray(that, object) } if (object instanceof ArrayBuffer) { return fromArrayBuffer(that, object) } } if (object.length) return fromArrayLike(that, object) return fromJsonObject(that, object) } function fromBuffer (that, buffer) { var length = checked(buffer.length) | 0 that = allocate(that, length) buffer.copy(that, 0, 0, length) return that } function fromArray (that, array) { var length = checked(array.length) | 0 that = allocate(that, length) for (var i = 0; i < length; i += 1) { that[i] = array[i] & 255 } return that } // Duplicate of fromArray() to keep fromArray() monomorphic. function fromTypedArray (that, array) { var length = checked(array.length) | 0 that = allocate(that, length) // Truncating the elements is probably not what people expect from typed // arrays with BYTES_PER_ELEMENT > 1 but it's compatible with the behavior // of the old Buffer constructor. for (var i = 0; i < length; i += 1) { that[i] = array[i] & 255 } return that } function fromArrayBuffer (that, array) { array.byteLength // this throws if `array` is not a valid ArrayBuffer if (Buffer.TYPED_ARRAY_SUPPORT) { // Return an augmented `Uint8Array` instance, for best performance that = new Uint8Array(array) that.__proto__ = Buffer.prototype } else { // Fallback: Return an object instance of the Buffer class that = fromTypedArray(that, new Uint8Array(array)) } return that } function fromArrayLike (that, array) { var length = checked(array.length) | 0 that = allocate(that, length) for (var i = 0; i < length; i += 1) { that[i] = array[i] & 255 } return that } // Deserialize { type: 'Buffer', data: [1,2,3,...] } into a Buffer object. // Returns a zero-length buffer for inputs that don't conform to the spec. function fromJsonObject (that, object) { var array var length = 0 if (object.type === 'Buffer' && isArray(object.data)) { array = object.data length = checked(array.length) | 0 } that = allocate(that, length) for (var i = 0; i < length; i += 1) { that[i] = array[i] & 255 } return that } if (Buffer.TYPED_ARRAY_SUPPORT) { Buffer.prototype.__proto__ = Uint8Array.prototype Buffer.__proto__ = Uint8Array } else { // pre-set for values that may exist in the future Buffer.prototype.length = undefined Buffer.prototype.parent = undefined } function allocate (that, length) { if (Buffer.TYPED_ARRAY_SUPPORT) { // Return an augmented `Uint8Array` instance, for best performance that = new Uint8Array(length) that.__proto__ = Buffer.prototype } else { // Fallback: Return an object instance of the Buffer class that.length = length } var fromPool = length !== 0 && length <= Buffer.poolSize >>> 1 if (fromPool) that.parent = rootParent return that } function checked (length) { // Note: cannot use `length < kMaxLength` here because that fails when // length is NaN (which is otherwise coerced to zero.) if (length >= kMaxLength()) { throw new RangeError('Attempt to allocate Buffer larger than maximum ' + 'size: 0x' + kMaxLength().toString(16) + ' bytes') } return length | 0 } function SlowBuffer (subject, encoding) { if (!(this instanceof SlowBuffer)) return new SlowBuffer(subject, encoding) var buf = new Buffer(subject, encoding) delete buf.parent return buf } Buffer.isBuffer = function isBuffer (b) { return !!(b != null && b._isBuffer) } Buffer.compare = function compare (a, b) { if (!Buffer.isBuffer(a) || !Buffer.isBuffer(b)) { throw new TypeError('Arguments must be Buffers') } if (a === b) return 0 var x = a.length var y = b.length var i = 0 var len = Math.min(x, y) while (i < len) { if (a[i] !== b[i]) break ++i } if (i !== len) { x = a[i] y = b[i] } if (x < y) return -1 if (y < x) return 1 return 0 } Buffer.isEncoding = function isEncoding (encoding) { switch (String(encoding).toLowerCase()) { case 'hex': case 'utf8': case 'utf-8': case 'ascii': case 'binary': case 'base64': case 'raw': case 'ucs2': case 'ucs-2': case 'utf16le': case 'utf-16le': return true default: return false } } Buffer.concat = function concat (list, length) { if (!isArray(list)) throw new TypeError('list argument must be an Array of Buffers.') if (list.length === 0) { return new Buffer(0) } var i if (length === undefined) { length = 0 for (i = 0; i < list.length; i++) { length += list[i].length } } var buf = new Buffer(length) var pos = 0 for (i = 0; i < list.length; i++) { var item = list[i] item.copy(buf, pos) pos += item.length } return buf } function byteLength (string, encoding) { if (typeof string !== 'string') string = '' + string var len = string.length if (len === 0) return 0 // Use a for loop to avoid recursion var loweredCase = false for (;;) { switch (encoding) { case 'ascii': case 'binary': // Deprecated case 'raw': case 'raws': return len case 'utf8': case 'utf-8': return utf8ToBytes(string).length case 'ucs2': case 'ucs-2': case 'utf16le': case 'utf-16le': return len * 2 case 'hex': return len >>> 1 case 'base64': return base64ToBytes(string).length default: if (loweredCase) return utf8ToBytes(string).length // assume utf8 encoding = ('' + encoding).toLowerCase() loweredCase = true } } } Buffer.byteLength = byteLength function slowToString (encoding, start, end) { var loweredCase = false start = start | 0 end = end === undefined || end === Infinity ? this.length : end | 0 if (!encoding) encoding = 'utf8' if (start < 0) start = 0 if (end > this.length) end = this.length if (end <= start) return '' while (true) { switch (encoding) { case 'hex': return hexSlice(this, start, end) case 'utf8': case 'utf-8': return utf8Slice(this, start, end) case 'ascii': return asciiSlice(this, start, end) case 'binary': return binarySlice(this, start, end) case 'base64': return base64Slice(this, start, end) case 'ucs2': case 'ucs-2': case 'utf16le': case 'utf-16le': return utf16leSlice(this, start, end) default: if (loweredCase) throw new TypeError('Unknown encoding: ' + encoding) encoding = (encoding + '').toLowerCase() loweredCase = true } } } // Even though this property is private, it shouldn't be removed because it is // used by `is-buffer` to detect buffer instances in Safari 5-7. Buffer.prototype._isBuffer = true Buffer.prototype.toString = function toString () { var length = this.length | 0 if (length === 0) return '' if (arguments.length === 0) return utf8Slice(this, 0, length) return slowToString.apply(this, arguments) } Buffer.prototype.equals = function equals (b) { if (!Buffer.isBuffer(b)) throw new TypeError('Argument must be a Buffer') if (this === b) return true return Buffer.compare(this, b) === 0 } Buffer.prototype.inspect = function inspect () { var str = '' var max = exports.INSPECT_MAX_BYTES if (this.length > 0) { str = this.toString('hex', 0, max).match(/.{2}/g).join(' ') if (this.length > max) str += ' ... ' } return '' } Buffer.prototype.compare = function compare (b) { if (!Buffer.isBuffer(b)) throw new TypeError('Argument must be a Buffer') if (this === b) return 0 return Buffer.compare(this, b) } Buffer.prototype.indexOf = function indexOf (val, byteOffset) { if (byteOffset > 0x7fffffff) byteOffset = 0x7fffffff else if (byteOffset < -0x80000000) byteOffset = -0x80000000 byteOffset >>= 0 if (this.length === 0) return -1 if (byteOffset >= this.length) return -1 // Negative offsets start from the end of the buffer if (byteOffset < 0) byteOffset = Math.max(this.length + byteOffset, 0) if (typeof val === 'string') { if (val.length === 0) return -1 // special case: looking for empty string always fails return String.prototype.indexOf.call(this, val, byteOffset) } if (Buffer.isBuffer(val)) { return arrayIndexOf(this, val, byteOffset) } if (typeof val === 'number') { if (Buffer.TYPED_ARRAY_SUPPORT && Uint8Array.prototype.indexOf === 'function') { return Uint8Array.prototype.indexOf.call(this, val, byteOffset) } return arrayIndexOf(this, [ val ], byteOffset) } function arrayIndexOf (arr, val, byteOffset) { var foundIndex = -1 for (var i = 0; byteOffset + i < arr.length; i++) { if (arr[byteOffset + i] === val[foundIndex === -1 ? 0 : i - foundIndex]) { if (foundIndex === -1) foundIndex = i if (i - foundIndex + 1 === val.length) return byteOffset + foundIndex } else { foundIndex = -1 } } return -1 } throw new TypeError('val must be string, number or Buffer') } function hexWrite (buf, string, offset, length) { offset = Number(offset) || 0 var remaining = buf.length - offset if (!length) { length = remaining } else { length = Number(length) if (length > remaining) { length = remaining } } // must be an even number of digits var strLen = string.length if (strLen % 2 !== 0) throw new Error('Invalid hex string') if (length > strLen / 2) { length = strLen / 2 } for (var i = 0; i < length; i++) { var parsed = parseInt(string.substr(i * 2, 2), 16) if (isNaN(parsed)) throw new Error('Invalid hex string') buf[offset + i] = parsed } return i } function utf8Write (buf, string, offset, length) { return blitBuffer(utf8ToBytes(string, buf.length - offset), buf, offset, length) } function asciiWrite (buf, string, offset, length) { return blitBuffer(asciiToBytes(string), buf, offset, length) } function binaryWrite (buf, string, offset, length) { return asciiWrite(buf, string, offset, length) } function base64Write (buf, string, offset, length) { return blitBuffer(base64ToBytes(string), buf, offset, length) } function ucs2Write (buf, string, offset, length) { return blitBuffer(utf16leToBytes(string, buf.length - offset), buf, offset, length) } Buffer.prototype.write = function write (string, offset, length, encoding) { // Buffer#write(string) if (offset === undefined) { encoding = 'utf8' length = this.length offset = 0 // Buffer#write(string, encoding) } else if (length === undefined && typeof offset === 'string') { encoding = offset length = this.length offset = 0 // Buffer#write(string, offset[, length][, encoding]) } else if (isFinite(offset)) { offset = offset | 0 if (isFinite(length)) { length = length | 0 if (encoding === undefined) encoding = 'utf8' } else { encoding = length length = undefined } // legacy write(string, encoding, offset, length) - remove in v0.13 } else { var swap = encoding encoding = offset offset = length | 0 length = swap } var remaining = this.length - offset if (length === undefined || length > remaining) length = remaining if ((string.length > 0 && (length < 0 || offset < 0)) || offset > this.length) { throw new RangeError('attempt to write outside buffer bounds') } if (!encoding) encoding = 'utf8' var loweredCase = false for (;;) { switch (encoding) { case 'hex': return hexWrite(this, string, offset, length) case 'utf8': case 'utf-8': return utf8Write(this, string, offset, length) case 'ascii': return asciiWrite(this, string, offset, length) case 'binary': return binaryWrite(this, string, offset, length) case 'base64': // Warning: maxLength not taken into account in base64Write return base64Write(this, string, offset, length) case 'ucs2': case 'ucs-2': case 'utf16le': case 'utf-16le': return ucs2Write(this, string, offset, length) default: if (loweredCase) throw new TypeError('Unknown encoding: ' + encoding) encoding = ('' + encoding).toLowerCase() loweredCase = true } } } Buffer.prototype.toJSON = function toJSON () { return { type: 'Buffer', data: Array.prototype.slice.call(this._arr || this, 0) } } function base64Slice (buf, start, end) { if (start === 0 && end === buf.length) { return base64.fromByteArray(buf) } else { return base64.fromByteArray(buf.slice(start, end)) } } function utf8Slice (buf, start, end) { end = Math.min(buf.length, end) var res = [] var i = start while (i < end) { var firstByte = buf[i] var codePoint = null var bytesPerSequence = (firstByte > 0xEF) ? 4 : (firstByte > 0xDF) ? 3 : (firstByte > 0xBF) ? 2 : 1 if (i + bytesPerSequence <= end) { var secondByte, thirdByte, fourthByte, tempCodePoint switch (bytesPerSequence) { case 1: if (firstByte < 0x80) { codePoint = firstByte } break case 2: secondByte = buf[i + 1] if ((secondByte & 0xC0) === 0x80) { tempCodePoint = (firstByte & 0x1F) << 0x6 | (secondByte & 0x3F) if (tempCodePoint > 0x7F) { codePoint = tempCodePoint } } break case 3: secondByte = buf[i + 1] thirdByte = buf[i + 2] if ((secondByte & 0xC0) === 0x80 && (thirdByte & 0xC0) === 0x80) { tempCodePoint = (firstByte & 0xF) << 0xC | (secondByte & 0x3F) << 0x6 | (thirdByte & 0x3F) if (tempCodePoint > 0x7FF && (tempCodePoint < 0xD800 || tempCodePoint > 0xDFFF)) { codePoint = tempCodePoint } } break case 4: secondByte = buf[i + 1] thirdByte = buf[i + 2] fourthByte = buf[i + 3] if ((secondByte & 0xC0) === 0x80 && (thirdByte & 0xC0) === 0x80 && (fourthByte & 0xC0) === 0x80) { tempCodePoint = (firstByte & 0xF) << 0x12 | (secondByte & 0x3F) << 0xC | (thirdByte & 0x3F) << 0x6 | (fourthByte & 0x3F) if (tempCodePoint > 0xFFFF && tempCodePoint < 0x110000) { codePoint = tempCodePoint } } } } if (codePoint === null) { // we did not generate a valid codePoint so insert a // replacement char (U+FFFD) and advance only 1 byte codePoint = 0xFFFD bytesPerSequence = 1 } else if (codePoint > 0xFFFF) { // encode to utf16 (surrogate pair dance) codePoint -= 0x10000 res.push(codePoint >>> 10 & 0x3FF | 0xD800) codePoint = 0xDC00 | codePoint & 0x3FF } res.push(codePoint) i += bytesPerSequence } return decodeCodePointsArray(res) } // Based on http://stackoverflow.com/a/22747272/680742, the browser with // the lowest limit is Chrome, with 0x10000 args. // We go 1 magnitude less, for safety var MAX_ARGUMENTS_LENGTH = 0x1000 function decodeCodePointsArray (codePoints) { var len = codePoints.length if (len <= MAX_ARGUMENTS_LENGTH) { return String.fromCharCode.apply(String, codePoints) // avoid extra slice() } // Decode in chunks to avoid "call stack size exceeded". var res = '' var i = 0 while (i < len) { res += String.fromCharCode.apply( String, codePoints.slice(i, i += MAX_ARGUMENTS_LENGTH) ) } return res } function asciiSlice (buf, start, end) { var ret = '' end = Math.min(buf.length, end) for (var i = start; i < end; i++) { ret += String.fromCharCode(buf[i] & 0x7F) } return ret } function binarySlice (buf, start, end) { var ret = '' end = Math.min(buf.length, end) for (var i = start; i < end; i++) { ret += String.fromCharCode(buf[i]) } return ret } function hexSlice (buf, start, end) { var len = buf.length if (!start || start < 0) start = 0 if (!end || end < 0 || end > len) end = len var out = '' for (var i = start; i < end; i++) { out += toHex(buf[i]) } return out } function utf16leSlice (buf, start, end) { var bytes = buf.slice(start, end) var res = '' for (var i = 0; i < bytes.length; i += 2) { res += String.fromCharCode(bytes[i] + bytes[i + 1] * 256) } return res } Buffer.prototype.slice = function slice (start, end) { var len = this.length start = ~~start end = end === undefined ? len : ~~end if (start < 0) { start += len if (start < 0) start = 0 } else if (start > len) { start = len } if (end < 0) { end += len if (end < 0) end = 0 } else if (end > len) { end = len } if (end < start) end = start var newBuf if (Buffer.TYPED_ARRAY_SUPPORT) { newBuf = this.subarray(start, end) newBuf.__proto__ = Buffer.prototype } else { var sliceLen = end - start newBuf = new Buffer(sliceLen, undefined) for (var i = 0; i < sliceLen; i++) { newBuf[i] = this[i + start] } } if (newBuf.length) newBuf.parent = this.parent || this return newBuf } /* * Need to make sure that buffer isn't trying to write out of bounds. */ function checkOffset (offset, ext, length) { if ((offset % 1) !== 0 || offset < 0) throw new RangeError('offset is not uint') if (offset + ext > length) throw new RangeError('Trying to access beyond buffer length') } Buffer.prototype.readUIntLE = function readUIntLE (offset, byteLength, noAssert) { offset = offset | 0 byteLength = byteLength | 0 if (!noAssert) checkOffset(offset, byteLength, this.length) var val = this[offset] var mul = 1 var i = 0 while (++i < byteLength && (mul *= 0x100)) { val += this[offset + i] * mul } return val } Buffer.prototype.readUIntBE = function readUIntBE (offset, byteLength, noAssert) { offset = offset | 0 byteLength = byteLength | 0 if (!noAssert) { checkOffset(offset, byteLength, this.length) } var val = this[offset + --byteLength] var mul = 1 while (byteLength > 0 && (mul *= 0x100)) { val += this[offset + --byteLength] * mul } return val } Buffer.prototype.readUInt8 = function readUInt8 (offset, noAssert) { if (!noAssert) checkOffset(offset, 1, this.length) return this[offset] } Buffer.prototype.readUInt16LE = function readUInt16LE (offset, noAssert) { if (!noAssert) checkOffset(offset, 2, this.length) return this[offset] | (this[offset + 1] << 8) } Buffer.prototype.readUInt16BE = function readUInt16BE (offset, noAssert) { if (!noAssert) checkOffset(offset, 2, this.length) return (this[offset] << 8) | this[offset + 1] } Buffer.prototype.readUInt32LE = function readUInt32LE (offset, noAssert) { if (!noAssert) checkOffset(offset, 4, this.length) return ((this[offset]) | (this[offset + 1] << 8) | (this[offset + 2] << 16)) + (this[offset + 3] * 0x1000000) } Buffer.prototype.readUInt32BE = function readUInt32BE (offset, noAssert) { if (!noAssert) checkOffset(offset, 4, this.length) return (this[offset] * 0x1000000) + ((this[offset + 1] << 16) | (this[offset + 2] << 8) | this[offset + 3]) } Buffer.prototype.readIntLE = function readIntLE (offset, byteLength, noAssert) { offset = offset | 0 byteLength = byteLength | 0 if (!noAssert) checkOffset(offset, byteLength, this.length) var val = this[offset] var mul = 1 var i = 0 while (++i < byteLength && (mul *= 0x100)) { val += this[offset + i] * mul } mul *= 0x80 if (val >= mul) val -= Math.pow(2, 8 * byteLength) return val } Buffer.prototype.readIntBE = function readIntBE (offset, byteLength, noAssert) { offset = offset | 0 byteLength = byteLength | 0 if (!noAssert) checkOffset(offset, byteLength, this.length) var i = byteLength var mul = 1 var val = this[offset + --i] while (i > 0 && (mul *= 0x100)) { val += this[offset + --i] * mul } mul *= 0x80 if (val >= mul) val -= Math.pow(2, 8 * byteLength) return val } Buffer.prototype.readInt8 = function readInt8 (offset, noAssert) { if (!noAssert) checkOffset(offset, 1, this.length) if (!(this[offset] & 0x80)) return (this[offset]) return ((0xff - this[offset] + 1) * -1) } Buffer.prototype.readInt16LE = function readInt16LE (offset, noAssert) { if (!noAssert) checkOffset(offset, 2, this.length) var val = this[offset] | (this[offset + 1] << 8) return (val & 0x8000) ? val | 0xFFFF0000 : val } Buffer.prototype.readInt16BE = function readInt16BE (offset, noAssert) { if (!noAssert) checkOffset(offset, 2, this.length) var val = this[offset + 1] | (this[offset] << 8) return (val & 0x8000) ? val | 0xFFFF0000 : val } Buffer.prototype.readInt32LE = function readInt32LE (offset, noAssert) { if (!noAssert) checkOffset(offset, 4, this.length) return (this[offset]) | (this[offset + 1] << 8) | (this[offset + 2] << 16) | (this[offset + 3] << 24) } Buffer.prototype.readInt32BE = function readInt32BE (offset, noAssert) { if (!noAssert) checkOffset(offset, 4, this.length) return (this[offset] << 24) | (this[offset + 1] << 16) | (this[offset + 2] << 8) | (this[offset + 3]) } Buffer.prototype.readFloatLE = function readFloatLE (offset, noAssert) { if (!noAssert) checkOffset(offset, 4, this.length) return ieee754.read(this, offset, true, 23, 4) } Buffer.prototype.readFloatBE = function readFloatBE (offset, noAssert) { if (!noAssert) checkOffset(offset, 4, this.length) return ieee754.read(this, offset, false, 23, 4) } Buffer.prototype.readDoubleLE = function readDoubleLE (offset, noAssert) { if (!noAssert) checkOffset(offset, 8, this.length) return ieee754.read(this, offset, true, 52, 8) } Buffer.prototype.readDoubleBE = function readDoubleBE (offset, noAssert) { if (!noAssert) checkOffset(offset, 8, this.length) return ieee754.read(this, offset, false, 52, 8) } function checkInt (buf, value, offset, ext, max, min) { if (!Buffer.isBuffer(buf)) throw new TypeError('buffer must be a Buffer instance') if (value > max || value < min) throw new RangeError('value is out of bounds') if (offset + ext > buf.length) throw new RangeError('index out of range') } Buffer.prototype.writeUIntLE = function writeUIntLE (value, offset, byteLength, noAssert) { value = +value offset = offset | 0 byteLength = byteLength | 0 if (!noAssert) checkInt(this, value, offset, byteLength, Math.pow(2, 8 * byteLength), 0) var mul = 1 var i = 0 this[offset] = value & 0xFF while (++i < byteLength && (mul *= 0x100)) { this[offset + i] = (value / mul) & 0xFF } return offset + byteLength } Buffer.prototype.writeUIntBE = function writeUIntBE (value, offset, byteLength, noAssert) { value = +value offset = offset | 0 byteLength = byteLength | 0 if (!noAssert) checkInt(this, value, offset, byteLength, Math.pow(2, 8 * byteLength), 0) var i = byteLength - 1 var mul = 1 this[offset + i] = value & 0xFF while (--i >= 0 && (mul *= 0x100)) { this[offset + i] = (value / mul) & 0xFF } return offset + byteLength } Buffer.prototype.writeUInt8 = function writeUInt8 (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 1, 0xff, 0) if (!Buffer.TYPED_ARRAY_SUPPORT) value = Math.floor(value) this[offset] = (value & 0xff) return offset + 1 } function objectWriteUInt16 (buf, value, offset, littleEndian) { if (value < 0) value = 0xffff + value + 1 for (var i = 0, j = Math.min(buf.length - offset, 2); i < j; i++) { buf[offset + i] = (value & (0xff << (8 * (littleEndian ? i : 1 - i)))) >>> (littleEndian ? i : 1 - i) * 8 } } Buffer.prototype.writeUInt16LE = function writeUInt16LE (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 2, 0xffff, 0) if (Buffer.TYPED_ARRAY_SUPPORT) { this[offset] = (value & 0xff) this[offset + 1] = (value >>> 8) } else { objectWriteUInt16(this, value, offset, true) } return offset + 2 } Buffer.prototype.writeUInt16BE = function writeUInt16BE (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 2, 0xffff, 0) if (Buffer.TYPED_ARRAY_SUPPORT) { this[offset] = (value >>> 8) this[offset + 1] = (value & 0xff) } else { objectWriteUInt16(this, value, offset, false) } return offset + 2 } function objectWriteUInt32 (buf, value, offset, littleEndian) { if (value < 0) value = 0xffffffff + value + 1 for (var i = 0, j = Math.min(buf.length - offset, 4); i < j; i++) { buf[offset + i] = (value >>> (littleEndian ? i : 3 - i) * 8) & 0xff } } Buffer.prototype.writeUInt32LE = function writeUInt32LE (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 4, 0xffffffff, 0) if (Buffer.TYPED_ARRAY_SUPPORT) { this[offset + 3] = (value >>> 24) this[offset + 2] = (value >>> 16) this[offset + 1] = (value >>> 8) this[offset] = (value & 0xff) } else { objectWriteUInt32(this, value, offset, true) } return offset + 4 } Buffer.prototype.writeUInt32BE = function writeUInt32BE (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 4, 0xffffffff, 0) if (Buffer.TYPED_ARRAY_SUPPORT) { this[offset] = (value >>> 24) this[offset + 1] = (value >>> 16) this[offset + 2] = (value >>> 8) this[offset + 3] = (value & 0xff) } else { objectWriteUInt32(this, value, offset, false) } return offset + 4 } Buffer.prototype.writeIntLE = function writeIntLE (value, offset, byteLength, noAssert) { value = +value offset = offset | 0 if (!noAssert) { var limit = Math.pow(2, 8 * byteLength - 1) checkInt(this, value, offset, byteLength, limit - 1, -limit) } var i = 0 var mul = 1 var sub = value < 0 ? 1 : 0 this[offset] = value & 0xFF while (++i < byteLength && (mul *= 0x100)) { this[offset + i] = ((value / mul) >> 0) - sub & 0xFF } return offset + byteLength } Buffer.prototype.writeIntBE = function writeIntBE (value, offset, byteLength, noAssert) { value = +value offset = offset | 0 if (!noAssert) { var limit = Math.pow(2, 8 * byteLength - 1) checkInt(this, value, offset, byteLength, limit - 1, -limit) } var i = byteLength - 1 var mul = 1 var sub = value < 0 ? 1 : 0 this[offset + i] = value & 0xFF while (--i >= 0 && (mul *= 0x100)) { this[offset + i] = ((value / mul) >> 0) - sub & 0xFF } return offset + byteLength } Buffer.prototype.writeInt8 = function writeInt8 (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 1, 0x7f, -0x80) if (!Buffer.TYPED_ARRAY_SUPPORT) value = Math.floor(value) if (value < 0) value = 0xff + value + 1 this[offset] = (value & 0xff) return offset + 1 } Buffer.prototype.writeInt16LE = function writeInt16LE (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 2, 0x7fff, -0x8000) if (Buffer.TYPED_ARRAY_SUPPORT) { this[offset] = (value & 0xff) this[offset + 1] = (value >>> 8) } else { objectWriteUInt16(this, value, offset, true) } return offset + 2 } Buffer.prototype.writeInt16BE = function writeInt16BE (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 2, 0x7fff, -0x8000) if (Buffer.TYPED_ARRAY_SUPPORT) { this[offset] = (value >>> 8) this[offset + 1] = (value & 0xff) } else { objectWriteUInt16(this, value, offset, false) } return offset + 2 } Buffer.prototype.writeInt32LE = function writeInt32LE (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 4, 0x7fffffff, -0x80000000) if (Buffer.TYPED_ARRAY_SUPPORT) { this[offset] = (value & 0xff) this[offset + 1] = (value >>> 8) this[offset + 2] = (value >>> 16) this[offset + 3] = (value >>> 24) } else { objectWriteUInt32(this, value, offset, true) } return offset + 4 } Buffer.prototype.writeInt32BE = function writeInt32BE (value, offset, noAssert) { value = +value offset = offset | 0 if (!noAssert) checkInt(this, value, offset, 4, 0x7fffffff, -0x80000000) if (value < 0) value = 0xffffffff + value + 1 if (Buffer.TYPED_ARRAY_SUPPORT) { this[offset] = (value >>> 24) this[offset + 1] = (value >>> 16) this[offset + 2] = (value >>> 8) this[offset + 3] = (value & 0xff) } else { objectWriteUInt32(this, value, offset, false) } return offset + 4 } function checkIEEE754 (buf, value, offset, ext, max, min) { if (value > max || value < min) throw new RangeError('value is out of bounds') if (offset + ext > buf.length) throw new RangeError('index out of range') if (offset < 0) throw new RangeError('index out of range') } function writeFloat (buf, value, offset, littleEndian, noAssert) { if (!noAssert) { checkIEEE754(buf, value, offset, 4, 3.4028234663852886e+38, -3.4028234663852886e+38) } ieee754.write(buf, value, offset, littleEndian, 23, 4) return offset + 4 } Buffer.prototype.writeFloatLE = function writeFloatLE (value, offset, noAssert) { return writeFloat(this, value, offset, true, noAssert) } Buffer.prototype.writeFloatBE = function writeFloatBE (value, offset, noAssert) { return writeFloat(this, value, offset, false, noAssert) } function writeDouble (buf, value, offset, littleEndian, noAssert) { if (!noAssert) { checkIEEE754(buf, value, offset, 8, 1.7976931348623157E+308, -1.7976931348623157E+308) } ieee754.write(buf, value, offset, littleEndian, 52, 8) return offset + 8 } Buffer.prototype.writeDoubleLE = function writeDoubleLE (value, offset, noAssert) { return writeDouble(this, value, offset, true, noAssert) } Buffer.prototype.writeDoubleBE = function writeDoubleBE (value, offset, noAssert) { return writeDouble(this, value, offset, false, noAssert) } // copy(targetBuffer, targetStart=0, sourceStart=0, sourceEnd=buffer.length) Buffer.prototype.copy = function copy (target, targetStart, start, end) { if (!start) start = 0 if (!end && end !== 0) end = this.length if (targetStart >= target.length) targetStart = target.length if (!targetStart) targetStart = 0 if (end > 0 && end < start) end = start // Copy 0 bytes; we're done if (end === start) return 0 if (target.length === 0 || this.length === 0) return 0 // Fatal error conditions if (targetStart < 0) { throw new RangeError('targetStart out of bounds') } if (start < 0 || start >= this.length) throw new RangeError('sourceStart out of bounds') if (end < 0) throw new RangeError('sourceEnd out of bounds') // Are we oob? if (end > this.length) end = this.length if (target.length - targetStart < end - start) { end = target.length - targetStart + start } var len = end - start var i if (this === target && start < targetStart && targetStart < end) { // descending copy from end for (i = len - 1; i >= 0; i--) { target[i + targetStart] = this[i + start] } } else if (len < 1000 || !Buffer.TYPED_ARRAY_SUPPORT) { // ascending copy from start for (i = 0; i < len; i++) { target[i + targetStart] = this[i + start] } } else { Uint8Array.prototype.set.call( target, this.subarray(start, start + len), targetStart ) } return len } // fill(value, start=0, end=buffer.length) Buffer.prototype.fill = function fill (value, start, end) { if (!value) value = 0 if (!start) start = 0 if (!end) end = this.length if (end < start) throw new RangeError('end < start') // Fill 0 bytes; we're done if (end === start) return if (this.length === 0) return if (start < 0 || start >= this.length) throw new RangeError('start out of bounds') if (end < 0 || end > this.length) throw new RangeError('end out of bounds') var i if (typeof value === 'number') { for (i = start; i < end; i++) { this[i] = value } } else { var bytes = utf8ToBytes(value.toString()) var len = bytes.length for (i = start; i < end; i++) { this[i] = bytes[i % len] } } return this } // HELPER FUNCTIONS // ================ var INVALID_BASE64_RE = /[^+\/0-9A-Za-z-_]/g function base64clean (str) { // Node strips out invalid characters like \n and \t from the string, base64-js does not str = stringtrim(str).replace(INVALID_BASE64_RE, '') // Node converts strings with length < 2 to '' if (str.length < 2) return '' // Node allows for non-padded base64 strings (missing trailing ===), base64-js does not while (str.length % 4 !== 0) { str = str + '=' } return str } function stringtrim (str) { if (str.trim) return str.trim() return str.replace(/^\s+|\s+$/g, '') } function toHex (n) { if (n < 16) return '0' + n.toString(16) return n.toString(16) } function utf8ToBytes (string, units) { units = units || Infinity var codePoint var length = string.length var leadSurrogate = null var bytes = [] for (var i = 0; i < length; i++) { codePoint = string.charCodeAt(i) // is surrogate component if (codePoint > 0xD7FF && codePoint < 0xE000) { // last char was a lead if (!leadSurrogate) { // no lead yet if (codePoint > 0xDBFF) { // unexpected trail if ((units -= 3) > -1) bytes.push(0xEF, 0xBF, 0xBD) continue } else if (i + 1 === length) { // unpaired lead if ((units -= 3) > -1) bytes.push(0xEF, 0xBF, 0xBD) continue } // valid lead leadSurrogate = codePoint continue } // 2 leads in a row if (codePoint < 0xDC00) { if ((units -= 3) > -1) bytes.push(0xEF, 0xBF, 0xBD) leadSurrogate = codePoint continue } // valid surrogate pair codePoint = (leadSurrogate - 0xD800 << 10 | codePoint - 0xDC00) + 0x10000 } else if (leadSurrogate) { // valid bmp char, but last char was a lead if ((units -= 3) > -1) bytes.push(0xEF, 0xBF, 0xBD) } leadSurrogate = null // encode utf8 if (codePoint < 0x80) { if ((units -= 1) < 0) break bytes.push(codePoint) } else if (codePoint < 0x800) { if ((units -= 2) < 0) break bytes.push( codePoint >> 0x6 | 0xC0, codePoint & 0x3F | 0x80 ) } else if (codePoint < 0x10000) { if ((units -= 3) < 0) break bytes.push( codePoint >> 0xC | 0xE0, codePoint >> 0x6 & 0x3F | 0x80, codePoint & 0x3F | 0x80 ) } else if (codePoint < 0x110000) { if ((units -= 4) < 0) break bytes.push( codePoint >> 0x12 | 0xF0, codePoint >> 0xC & 0x3F | 0x80, codePoint >> 0x6 & 0x3F | 0x80, codePoint & 0x3F | 0x80 ) } else { throw new Error('Invalid code point') } } return bytes } function asciiToBytes (str) { var byteArray = [] for (var i = 0; i < str.length; i++) { // Node's code seems to be doing this and not & 0x7F.. byteArray.push(str.charCodeAt(i) & 0xFF) } return byteArray } function utf16leToBytes (str, units) { var c, hi, lo var byteArray = [] for (var i = 0; i < str.length; i++) { if ((units -= 2) < 0) break c = str.charCodeAt(i) hi = c >> 8 lo = c % 256 byteArray.push(lo) byteArray.push(hi) } return byteArray } function base64ToBytes (str) { return base64.toByteArray(base64clean(str)) } function blitBuffer (src, dst, offset, length) { for (var i = 0; i < length; i++) { if ((i + offset >= dst.length) || (i >= src.length)) break dst[i + offset] = src[i] } return i } }).call(this,typeof global !== "undefined" ? global : typeof self !== "undefined" ? self : typeof window !== "undefined" ? window : {}) },{"base64-js":51,"ieee754":52,"isarray":53}],51:[function(require,module,exports){ ;(function (exports) { 'use strict' var lookup = 'ABCDEFGHIJKLMNOPQRSTUVWXYZabcdefghijklmnopqrstuvwxyz0123456789+/' var Arr = (typeof Uint8Array !== 'undefined') ? Uint8Array : Array var PLUS = '+'.charCodeAt(0) var SLASH = '/'.charCodeAt(0) var NUMBER = '0'.charCodeAt(0) var LOWER = 'a'.charCodeAt(0) var UPPER = 'A'.charCodeAt(0) var PLUS_URL_SAFE = '-'.charCodeAt(0) var SLASH_URL_SAFE = '_'.charCodeAt(0) function decode (elt) { var code = elt.charCodeAt(0) if (code === PLUS || code === PLUS_URL_SAFE) return 62 // '+' if (code === SLASH || code === SLASH_URL_SAFE) return 63 // '/' if (code < NUMBER) return -1 // no match if (code < NUMBER + 10) return code - NUMBER + 26 + 26 if (code < UPPER + 26) return code - UPPER if (code < LOWER + 26) return code - LOWER + 26 } function b64ToByteArray (b64) { var i, j, l, tmp, placeHolders, arr if (b64.length % 4 > 0) { throw new Error('Invalid string. Length must be a multiple of 4') } // the number of equal signs (place holders) // if there are two placeholders, than the two characters before it // represent one byte // if there is only one, then the three characters before it represent 2 bytes // this is just a cheap hack to not do indexOf twice var len = b64.length placeHolders = b64.charAt(len - 2) === '=' ? 2 : b64.charAt(len - 1) === '=' ? 1 : 0 // base64 is 4/3 + up to two characters of the original data arr = new Arr(b64.length * 3 / 4 - placeHolders) // if there are placeholders, only get up to the last complete 4 chars l = placeHolders > 0 ? b64.length - 4 : b64.length var L = 0 function push (v) { arr[L++] = v } for (i = 0, j = 0; i < l; i += 4, j += 3) { tmp = (decode(b64.charAt(i)) << 18) | (decode(b64.charAt(i + 1)) << 12) | (decode(b64.charAt(i + 2)) << 6) | decode(b64.charAt(i + 3)) push((tmp & 0xFF0000) >> 16) push((tmp & 0xFF00) >> 8) push(tmp & 0xFF) } if (placeHolders === 2) { tmp = (decode(b64.charAt(i)) << 2) | (decode(b64.charAt(i + 1)) >> 4) push(tmp & 0xFF) } else if (placeHolders === 1) { tmp = (decode(b64.charAt(i)) << 10) | (decode(b64.charAt(i + 1)) << 4) | (decode(b64.charAt(i + 2)) >> 2) push((tmp >> 8) & 0xFF) push(tmp & 0xFF) } return arr } function uint8ToBase64 (uint8) { var i var extraBytes = uint8.length % 3 // if we have 1 byte left, pad 2 bytes var output = '' var temp, length function encode (num) { return lookup.charAt(num) } function tripletToBase64 (num) { return encode(num >> 18 & 0x3F) + encode(num >> 12 & 0x3F) + encode(num >> 6 & 0x3F) + encode(num & 0x3F) } // go through the array every three bytes, we'll deal with trailing stuff later for (i = 0, length = uint8.length - extraBytes; i < length; i += 3) { temp = (uint8[i] << 16) + (uint8[i + 1] << 8) + (uint8[i + 2]) output += tripletToBase64(temp) } // pad the end with zeros, but make sure to not forget the extra bytes switch (extraBytes) { case 1: temp = uint8[uint8.length - 1] output += encode(temp >> 2) output += encode((temp << 4) & 0x3F) output += '==' break case 2: temp = (uint8[uint8.length - 2] << 8) + (uint8[uint8.length - 1]) output += encode(temp >> 10) output += encode((temp >> 4) & 0x3F) output += encode((temp << 2) & 0x3F) output += '=' break default: break } return output } exports.toByteArray = b64ToByteArray exports.fromByteArray = uint8ToBase64 }(typeof exports === 'undefined' ? (this.base64js = {}) : exports)) },{}],52:[function(require,module,exports){ exports.read = function (buffer, offset, isLE, mLen, nBytes) { var e, m var eLen = nBytes * 8 - mLen - 1 var eMax = (1 << eLen) - 1 var eBias = eMax >> 1 var nBits = -7 var i = isLE ? (nBytes - 1) : 0 var d = isLE ? -1 : 1 var s = buffer[offset + i] i += d e = s & ((1 << (-nBits)) - 1) s >>= (-nBits) nBits += eLen for (; nBits > 0; e = e * 256 + buffer[offset + i], i += d, nBits -= 8) {} m = e & ((1 << (-nBits)) - 1) e >>= (-nBits) nBits += mLen for (; nBits > 0; m = m * 256 + buffer[offset + i], i += d, nBits -= 8) {} if (e === 0) { e = 1 - eBias } else if (e === eMax) { return m ? NaN : ((s ? -1 : 1) * Infinity) } else { m = m + Math.pow(2, mLen) e = e - eBias } return (s ? -1 : 1) * m * Math.pow(2, e - mLen) } exports.write = function (buffer, value, offset, isLE, mLen, nBytes) { var e, m, c var eLen = nBytes * 8 - mLen - 1 var eMax = (1 << eLen) - 1 var eBias = eMax >> 1 var rt = (mLen === 23 ? Math.pow(2, -24) - Math.pow(2, -77) : 0) var i = isLE ? 0 : (nBytes - 1) var d = isLE ? 1 : -1 var s = value < 0 || (value === 0 && 1 / value < 0) ? 1 : 0 value = Math.abs(value) if (isNaN(value) || value === Infinity) { m = isNaN(value) ? 1 : 0 e = eMax } else { e = Math.floor(Math.log(value) / Math.LN2) if (value * (c = Math.pow(2, -e)) < 1) { e-- c *= 2 } if (e + eBias >= 1) { value += rt / c } else { value += rt * Math.pow(2, 1 - eBias) } if (value * c >= 2) { e++ c /= 2 } if (e + eBias >= eMax) { m = 0 e = eMax } else if (e + eBias >= 1) { m = (value * c - 1) * Math.pow(2, mLen) e = e + eBias } else { m = value * Math.pow(2, eBias - 1) * Math.pow(2, mLen) e = 0 } } for (; mLen >= 8; buffer[offset + i] = m & 0xff, i += d, m /= 256, mLen -= 8) {} e = (e << mLen) | m eLen += mLen for (; eLen > 0; buffer[offset + i] = e & 0xff, i += d, e /= 256, eLen -= 8) {} buffer[offset + i - d] |= s * 128 } },{}],53:[function(require,module,exports){ var toString = {}.toString; module.exports = Array.isArray || function (arr) { return toString.call(arr) == '[object Array]'; }; },{}],54:[function(require,module,exports){ // Copyright Joyent, Inc. and other Node contributors. // // Permission is hereby granted, free of charge, to any person obtaining a // copy of this software and associated documentation files (the // "Software"), to deal in the Software without restriction, including // without limitation the rights to use, copy, modify, merge, publish, // distribute, sublicense, and/or sell copies of the Software, and to permit // persons to whom the Software is furnished to do so, subject to the // following conditions: // // The above copyright notice and this permission notice shall be included // in all copies or substantial portions of the Software. // // THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS // OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF // MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN // NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, // DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR // OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE // USE OR OTHER DEALINGS IN THE SOFTWARE. function EventEmitter() { this._events = this._events || {}; this._maxListeners = this._maxListeners || undefined; } module.exports = EventEmitter; // Backwards-compat with node 0.10.x EventEmitter.EventEmitter = EventEmitter; EventEmitter.prototype._events = undefined; EventEmitter.prototype._maxListeners = undefined; // By default EventEmitters will print a warning if more than 10 listeners are // added to it. This is a useful default which helps finding memory leaks. EventEmitter.defaultMaxListeners = 10; // Obviously not all Emitters should be limited to 10. This function allows // that to be increased. Set to zero for unlimited. EventEmitter.prototype.setMaxListeners = function(n) { if (!isNumber(n) || n < 0 || isNaN(n)) throw TypeError('n must be a positive number'); this._maxListeners = n; return this; }; EventEmitter.prototype.emit = function(type) { var er, handler, len, args, i, listeners; if (!this._events) this._events = {}; // If there is no 'error' event listener then throw. if (type === 'error') { if (!this._events.error || (isObject(this._events.error) && !this._events.error.length)) { er = arguments[1]; if (er instanceof Error) { throw er; // Unhandled 'error' event } throw TypeError('Uncaught, unspecified "error" event.'); } } handler = this._events[type]; if (isUndefined(handler)) return false; if (isFunction(handler)) { switch (arguments.length) { // fast cases case 1: handler.call(this); break; case 2: handler.call(this, arguments[1]); break; case 3: handler.call(this, arguments[1], arguments[2]); break; // slower default: args = Array.prototype.slice.call(arguments, 1); handler.apply(this, args); } } else if (isObject(handler)) { args = Array.prototype.slice.call(arguments, 1); listeners = handler.slice(); len = listeners.length; for (i = 0; i < len; i++) listeners[i].apply(this, args); } return true; }; EventEmitter.prototype.addListener = function(type, listener) { var m; if (!isFunction(listener)) throw TypeError('listener must be a function'); if (!this._events) this._events = {}; // To avoid recursion in the case that type === "newListener"! Before // adding it to the listeners, first emit "newListener". if (this._events.newListener) this.emit('newListener', type, isFunction(listener.listener) ? listener.listener : listener); if (!this._events[type]) // Optimize the case of one listener. Don't need the extra array object. this._events[type] = listener; else if (isObject(this._events[type])) // If we've already got an array, just append. this._events[type].push(listener); else // Adding the second element, need to change to array. this._events[type] = [this._events[type], listener]; // Check for listener leak if (isObject(this._events[type]) && !this._events[type].warned) { if (!isUndefined(this._maxListeners)) { m = this._maxListeners; } else { m = EventEmitter.defaultMaxListeners; } if (m && m > 0 && this._events[type].length > m) { this._events[type].warned = true; console.error('(node) warning: possible EventEmitter memory ' + 'leak detected. %d listeners added. ' + 'Use emitter.setMaxListeners() to increase limit.', this._events[type].length); if (typeof console.trace === 'function') { // not supported in IE 10 console.trace(); } } } return this; }; EventEmitter.prototype.on = EventEmitter.prototype.addListener; EventEmitter.prototype.once = function(type, listener) { if (!isFunction(listener)) throw TypeError('listener must be a function'); var fired = false; function g() { this.removeListener(type, g); if (!fired) { fired = true; listener.apply(this, arguments); } } g.listener = listener; this.on(type, g); return this; }; // emits a 'removeListener' event iff the listener was removed EventEmitter.prototype.removeListener = function(type, listener) { var list, position, length, i; if (!isFunction(listener)) throw TypeError('listener must be a function'); if (!this._events || !this._events[type]) return this; list = this._events[type]; length = list.length; position = -1; if (list === listener || (isFunction(list.listener) && list.listener === listener)) { delete this._events[type]; if (this._events.removeListener) this.emit('removeListener', type, listener); } else if (isObject(list)) { for (i = length; i-- > 0;) { if (list[i] === listener || (list[i].listener && list[i].listener === listener)) { position = i; break; } } if (position < 0) return this; if (list.length === 1) { list.length = 0; delete this._events[type]; } else { list.splice(position, 1); } if (this._events.removeListener) this.emit('removeListener', type, listener); } return this; }; EventEmitter.prototype.removeAllListeners = function(type) { var key, listeners; if (!this._events) return this; // not listening for removeListener, no need to emit if (!this._events.removeListener) { if (arguments.length === 0) this._events = {}; else if (this._events[type]) delete this._events[type]; return this; } // emit removeListener for all listeners on all events if (arguments.length === 0) { for (key in this._events) { if (key === 'removeListener') continue; this.removeAllListeners(key); } this.removeAllListeners('removeListener'); this._events = {}; return this; } listeners = this._events[type]; if (isFunction(listeners)) { this.removeListener(type, listeners); } else if (listeners) { // LIFO order while (listeners.length) this.removeListener(type, listeners[listeners.length - 1]); } delete this._events[type]; return this; }; EventEmitter.prototype.listeners = function(type) { var ret; if (!this._events || !this._events[type]) ret = []; else if (isFunction(this._events[type])) ret = [this._events[type]]; else ret = this._events[type].slice(); return ret; }; EventEmitter.prototype.listenerCount = function(type) { if (this._events) { var evlistener = this._events[type]; if (isFunction(evlistener)) return 1; else if (evlistener) return evlistener.length; } return 0; }; EventEmitter.listenerCount = function(emitter, type) { return emitter.listenerCount(type); }; function isFunction(arg) { return typeof arg === 'function'; } function isNumber(arg) { return typeof arg === 'number'; } function isObject(arg) { return typeof arg === 'object' && arg !== null; } function isUndefined(arg) { return arg === void 0; } },{}],55:[function(require,module,exports){ // shim for using process in browser var process = module.exports = {}; var queue = []; var draining = false; var currentQueue; var queueIndex = -1; function cleanUpNextTick() { draining = false; if (currentQueue.length) { queue = currentQueue.concat(queue); } else { queueIndex = -1; } if (queue.length) { drainQueue(); } } function drainQueue() { if (draining) { return; } var timeout = setTimeout(cleanUpNextTick); draining = true; var len = queue.length; while(len) { currentQueue = queue; queue = []; while (++queueIndex < len) { if (currentQueue) { currentQueue[queueIndex].run(); } } queueIndex = -1; len = queue.length; } currentQueue = null; draining = false; clearTimeout(timeout); } process.nextTick = function (fun) { var args = new Array(arguments.length - 1); if (arguments.length > 1) { for (var i = 1; i < arguments.length; i++) { args[i - 1] = arguments[i]; } } queue.push(new Item(fun, args)); if (queue.length === 1 && !draining) { setTimeout(drainQueue, 0); } }; // v8 likes predictible objects function Item(fun, array) { this.fun = fun; this.array = array; } Item.prototype.run = function () { this.fun.apply(null, this.array); }; process.title = 'browser'; process.browser = true; process.env = {}; process.argv = []; process.version = ''; // empty string to avoid regexp issues process.versions = {}; function noop() {} process.on = noop; process.addListener = noop; process.once = noop; process.off = noop; process.removeListener = noop; process.removeAllListeners = noop; process.emit = noop; process.binding = function (name) { throw new Error('process.binding is not supported'); }; process.cwd = function () { return '/' }; process.chdir = function (dir) { throw new Error('process.chdir is not supported'); }; process.umask = function() { return 0; }; },{}],56:[function(require,module,exports){ module.exports={"jet":[{"index":0,"rgb":[0,0,131]},{"index":0.125,"rgb":[0,60,170]},{"index":0.375,"rgb":[5,255,255]},{"index":0.625,"rgb":[255,255,0]},{"index":0.875,"rgb":[250,0,0]},{"index":1,"rgb":[128,0,0]}],"hsv":[{"index":0,"rgb":[255,0,0]},{"index":0.169,"rgb":[253,255,2]},{"index":0.173,"rgb":[247,255,2]},{"index":0.337,"rgb":[0,252,4]},{"index":0.341,"rgb":[0,252,10]},{"index":0.506,"rgb":[1,249,255]},{"index":0.671,"rgb":[2,0,253]},{"index":0.675,"rgb":[8,0,253]},{"index":0.839,"rgb":[255,0,251]},{"index":0.843,"rgb":[255,0,245]},{"index":1,"rgb":[255,0,6]}],"hot":[{"index":0,"rgb":[0,0,0]},{"index":0.3,"rgb":[230,0,0]},{"index":0.6,"rgb":[255,210,0]},{"index":1,"rgb":[255,255,255]}],"cool":[{"index":0,"rgb":[0,255,255]},{"index":1,"rgb":[255,0,255]}],"spring":[{"index":0,"rgb":[255,0,255]},{"index":1,"rgb":[255,255,0]}],"summer":[{"index":0,"rgb":[0,128,102]},{"index":1,"rgb":[255,255,102]}],"autumn":[{"index":0,"rgb":[255,0,0]},{"index":1,"rgb":[255,255,0]}],"winter":[{"index":0,"rgb":[0,0,255]},{"index":1,"rgb":[0,255,128]}],"bone":[{"index":0,"rgb":[0,0,0]},{"index":0.376,"rgb":[84,84,116]},{"index":0.753,"rgb":[169,200,200]},{"index":1,"rgb":[255,255,255]}],"copper":[{"index":0,"rgb":[0,0,0]},{"index":0.804,"rgb":[255,160,102]},{"index":1,"rgb":[255,199,127]}],"greys":[{"index":0,"rgb":[0,0,0]},{"index":1,"rgb":[255,255,255]}],"yignbu":[{"index":0,"rgb":[8,29,88]},{"index":0.125,"rgb":[37,52,148]},{"index":0.25,"rgb":[34,94,168]},{"index":0.375,"rgb":[29,145,192]},{"index":0.5,"rgb":[65,182,196]},{"index":0.625,"rgb":[127,205,187]},{"index":0.75,"rgb":[199,233,180]},{"index":0.875,"rgb":[237,248,217]},{"index":1,"rgb":[255,255,217]}],"greens":[{"index":0,"rgb":[0,68,27]},{"index":0.125,"rgb":[0,109,44]},{"index":0.25,"rgb":[35,139,69]},{"index":0.375,"rgb":[65,171,93]},{"index":0.5,"rgb":[116,196,118]},{"index":0.625,"rgb":[161,217,155]},{"index":0.75,"rgb":[199,233,192]},{"index":0.875,"rgb":[229,245,224]},{"index":1,"rgb":[247,252,245]}],"yiorrd":[{"index":0,"rgb":[128,0,38]},{"index":0.125,"rgb":[189,0,38]},{"index":0.25,"rgb":[227,26,28]},{"index":0.375,"rgb":[252,78,42]},{"index":0.5,"rgb":[253,141,60]},{"index":0.625,"rgb":[254,178,76]},{"index":0.75,"rgb":[254,217,118]},{"index":0.875,"rgb":[255,237,160]},{"index":1,"rgb":[255,255,204]}],"bluered":[{"index":0,"rgb":[0,0,255]},{"index":1,"rgb":[255,0,0]}],"rdbu":[{"index":0,"rgb":[5,10,172]},{"index":0.35,"rgb":[106,137,247]},{"index":0.5,"rgb":[190,190,190]},{"index":0.6,"rgb":[220,170,132]},{"index":0.7,"rgb":[230,145,90]},{"index":1,"rgb":[178,10,28]}],"picnic":[{"index":0,"rgb":[0,0,255]},{"index":0.1,"rgb":[51,153,255]},{"index":0.2,"rgb":[102,204,255]},{"index":0.3,"rgb":[153,204,255]},{"index":0.4,"rgb":[204,204,255]},{"index":0.5,"rgb":[255,255,255]},{"index":0.6,"rgb":[255,204,255]},{"index":0.7,"rgb":[255,153,255]},{"index":0.8,"rgb":[255,102,204]},{"index":0.9,"rgb":[255,102,102]},{"index":1,"rgb":[255,0,0]}],"rainbow":[{"index":0,"rgb":[150,0,90]},{"index":0.125,"rgb":[0,0,200]},{"index":0.25,"rgb":[0,25,255]},{"index":0.375,"rgb":[0,152,255]},{"index":0.5,"rgb":[44,255,150]},{"index":0.625,"rgb":[151,255,0]},{"index":0.75,"rgb":[255,234,0]},{"index":0.875,"rgb":[255,111,0]},{"index":1,"rgb":[255,0,0]}],"portland":[{"index":0,"rgb":[12,51,131]},{"index":0.25,"rgb":[10,136,186]},{"index":0.5,"rgb":[242,211,56]},{"index":0.75,"rgb":[242,143,56]},{"index":1,"rgb":[217,30,30]}],"blackbody":[{"index":0,"rgb":[0,0,0]},{"index":0.2,"rgb":[230,0,0]},{"index":0.4,"rgb":[230,210,0]},{"index":0.7,"rgb":[255,255,255]},{"index":1,"rgb":[160,200,255]}],"earth":[{"index":0,"rgb":[0,0,130]},{"index":0.1,"rgb":[0,180,180]},{"index":0.2,"rgb":[40,210,40]},{"index":0.4,"rgb":[230,230,50]},{"index":0.6,"rgb":[120,70,20]},{"index":1,"rgb":[255,255,255]}],"electric":[{"index":0,"rgb":[0,0,0]},{"index":0.15,"rgb":[30,0,100]},{"index":0.4,"rgb":[120,0,100]},{"index":0.6,"rgb":[160,90,0]},{"index":0.8,"rgb":[230,200,0]},{"index":1,"rgb":[255,250,220]}], "alpha": [{"index":0, "rgb": [255,255,255,0]},{"index":0, "rgb": [255,255,255,1]}]}; },{}],57:[function(require,module,exports){ /* * Ben Postlethwaite * January 2013 * License MIT */ 'use strict'; var at = require('arraytools'); var clone = require('clone'); var colorScale = require('./colorScales'); module.exports = function (spec) { /* * Default Options */ var indicies, rgba, fromrgba, torgba, nsteps, cmap, colormap, format, nshades, colors, alpha, index, i, r = [], g = [], b = [], a = []; if ( !at.isPlainObject(spec) ) spec = {}; nshades = spec.nshades || 72; format = spec.format || 'hex'; colormap = spec.colormap; if (!colormap) colormap = 'jet'; if (typeof colormap === 'string') { colormap = colormap.toLowerCase(); if (!colorScale[colormap]) { throw Error(colormap + ' not a supported colorscale'); } cmap = clone(colorScale[colormap]); } else if (Array.isArray(colormap)) { cmap = clone(colormap); } else { throw Error('unsupported colormap option', colormap); } if (cmap.length > nshades) { throw new Error( colormap+' map requires nshades to be at least size '+cmap.length ); } if (!Array.isArray(spec.alpha)) { if (typeof spec.alpha === 'number') { alpha = [spec.alpha, spec.alpha]; } else { alpha = [1, 1]; } } else if (spec.alpha.length !== 2) { alpha = [1, 1]; } else { alpha = clone(spec.alpha); } /* * map index points from 0->1 to 0 -> n-1 */ indicies = cmap.map(function(c) { return Math.round(c.index * nshades); }); /* * Add alpha channel to the map */ if (alpha[0] < 0) alpha[0] = 0; if (alpha[1] < 0) alpha[0] = 0; if (alpha[0] > 1) alpha[0] = 1; if (alpha[1] > 1) alpha[0] = 1; for (i = 0; i < indicies.length; ++i) { index = cmap[i].index; rgba = cmap[i].rgb; // if user supplies their own map use it if (rgba.length === 4 && rgba[3] >= 0 && rgba[3] <= 1) continue; rgba[3] = alpha[0] + (alpha[1] - alpha[0])*index; } /* * map increasing linear values between indicies to * linear steps in colorvalues */ for (i = 0; i < indicies.length-1; ++i) { nsteps = indicies[i+1] - indicies[i]; fromrgba = cmap[i].rgb; torgba = cmap[i+1].rgb; r = r.concat(at.linspace(fromrgba[0], torgba[0], nsteps ) ); g = g.concat(at.linspace(fromrgba[1], torgba[1], nsteps ) ); b = b.concat(at.linspace(fromrgba[2], torgba[2], nsteps ) ); a = a.concat(at.linspace(fromrgba[3], torgba[3], nsteps ) ); } r = r.map( Math.round ); g = g.map( Math.round ); b = b.map( Math.round ); colors = at.zip(r, g, b, a); if (format === 'hex') colors = colors.map( rgb2hex ); if (format === 'rgbaString') colors = colors.map( rgbaStr ); return colors; }; function rgb2hex (rgba) { var dig, hex = '#'; for (var i = 0; i < 3; ++i) { dig = rgba[i]; dig = dig.toString(16); hex += ('00' + dig).substr( dig.length ); } return hex; } function rgbaStr (rgba) { return 'rgba(' + rgba.join(',') + ')'; } },{"./colorScales":56,"arraytools":48,"clone":58}],58:[function(require,module,exports){ (function (Buffer){ var clone = (function() { 'use strict'; /** * Clones (copies) an Object using deep copying. * * This function supports circular references by default, but if you are certain * there are no circular references in your object, you can save some CPU time * by calling clone(obj, false). * * Caution: if `circular` is false and `parent` contains circular references, * your program may enter an infinite loop and crash. * * @param `parent` - the object to be cloned * @param `circular` - set to true if the object to be cloned may contain * circular references. (optional - true by default) * @param `depth` - set to a number if the object is only to be cloned to * a particular depth. (optional - defaults to Infinity) * @param `prototype` - sets the prototype to be used when cloning an object. * (optional - defaults to parent prototype). */ function clone(parent, circular, depth, prototype) { var filter; if (typeof circular === 'object') { depth = circular.depth; prototype = circular.prototype; filter = circular.filter; circular = circular.circular } // maintain two arrays for circular references, where corresponding parents // and children have the same index var allParents = []; var allChildren = []; var useBuffer = typeof Buffer != 'undefined'; if (typeof circular == 'undefined') circular = true; if (typeof depth == 'undefined') depth = Infinity; // recurse this function so we don't reset allParents and allChildren function _clone(parent, depth) { // cloning null always returns null if (parent === null) return null; if (depth == 0) return parent; var child; var proto; if (typeof parent != 'object') { return parent; } if (clone.__isArray(parent)) { child = []; } else if (clone.__isRegExp(parent)) { child = new RegExp(parent.source, __getRegExpFlags(parent)); if (parent.lastIndex) child.lastIndex = parent.lastIndex; } else if (clone.__isDate(parent)) { child = new Date(parent.getTime()); } else if (useBuffer && Buffer.isBuffer(parent)) { child = new Buffer(parent.length); parent.copy(child); return child; } else { if (typeof prototype == 'undefined') { proto = Object.getPrototypeOf(parent); child = Object.create(proto); } else { child = Object.create(prototype); proto = prototype; } } if (circular) { var index = allParents.indexOf(parent); if (index != -1) { return allChildren[index]; } allParents.push(parent); allChildren.push(child); } for (var i in parent) { var attrs; if (proto) { attrs = Object.getOwnPropertyDescriptor(proto, i); } if (attrs && attrs.set == null) { continue; } child[i] = _clone(parent[i], depth - 1); } return child; } return _clone(parent, depth); } /** * Simple flat clone using prototype, accepts only objects, usefull for property * override on FLAT configuration object (no nested props). * * USE WITH CAUTION! This may not behave as you wish if you do not know how this * works. */ clone.clonePrototype = function clonePrototype(parent) { if (parent === null) return null; var c = function () {}; c.prototype = parent; return new c(); }; // private utility functions function __objToStr(o) { return Object.prototype.toString.call(o); }; clone.__objToStr = __objToStr; function __isDate(o) { return typeof o === 'object' && __objToStr(o) === '[object Date]'; }; clone.__isDate = __isDate; function __isArray(o) { return typeof o === 'object' && __objToStr(o) === '[object Array]'; }; clone.__isArray = __isArray; function __isRegExp(o) { return typeof o === 'object' && __objToStr(o) === '[object RegExp]'; }; clone.__isRegExp = __isRegExp; function __getRegExpFlags(re) { var flags = ''; if (re.global) flags += 'g'; if (re.ignoreCase) flags += 'i'; if (re.multiline) flags += 'm'; return flags; }; clone.__getRegExpFlags = __getRegExpFlags; return clone; })(); if (typeof module === 'object' && module.exports) { module.exports = clone; } }).call(this,require("buffer").Buffer) },{"buffer":50}],59:[function(require,module,exports){ module.exports = compareCells var min = Math.min function compareInt(a, b) { return a - b } function compareCells(a, b) { var n = a.length , t = a.length - b.length if(t) { return t } switch(n) { case 0: return 0 case 1: return a[0] - b[0] case 2: return (a[0]+a[1]-b[0]-b[1]) || min(a[0],a[1]) - min(b[0],b[1]) case 3: var l1 = a[0]+a[1] , m1 = b[0]+b[1] t = l1+a[2] - (m1+b[2]) if(t) { return t } var l0 = min(a[0], a[1]) , m0 = min(b[0], b[1]) return min(l0, a[2]) - min(m0, b[2]) || min(l0+a[2], l1) - min(m0+b[2], m1) case 4: var aw=a[0], ax=a[1], ay=a[2], az=a[3] , bw=b[0], bx=b[1], by=b[2], bz=b[3] return (aw+ax+ay+az)-(bw+bx+by+bz) || min(aw,ax,ay,az)-min(bw,bx,by,bz,bw) || min(aw+ax,aw+ay,aw+az,ax+ay,ax+az,ay+az) - min(bw+bx,bw+by,bw+bz,bx+by,bx+bz,by+bz) || min(aw+ax+ay,aw+ax+az,aw+ay+az,ax+ay+az) - min(bw+bx+by,bw+bx+bz,bw+by+bz,bx+by+bz) default: var as = a.slice().sort(compareInt) var bs = b.slice().sort(compareInt) for(var i=0; i points[hi][0]) { hi = i } } if(lo < hi) { return [[lo], [hi]] } else if(lo > hi) { return [[hi], [lo]] } else { return [[lo]] } } },{}],62:[function(require,module,exports){ 'use strict' module.exports = convexHull2D var monotoneHull = require('monotone-convex-hull-2d') function convexHull2D(points) { var hull = monotoneHull(points) var h = hull.length if(h <= 2) { return [] } var edges = new Array(h) var a = hull[h-1] for(var i=0; i= front[k]) { x += 1 } } c[j] = x } } } return cells } function convexHullnD(points, d) { try { return ich(points, true) } catch(e) { //If point set is degenerate, try to find a basis and rerun it var ah = aff(points) if(ah.length <= d) { //No basis, no try return [] } var npoints = permute(points, ah) var nhull = ich(npoints, true) return invPermute(nhull, ah) } } },{"affine-hull":64,"incremental-convex-hull":191}],64:[function(require,module,exports){ 'use strict' module.exports = affineHull var orient = require('robust-orientation') function linearlyIndependent(points, d) { var nhull = new Array(d+1) for(var i=0; i 1 && orient( points[lower[m-2]], points[lower[m-1]], p) <= 0) { m -= 1 lower.pop() } lower.push(idx) //Insert into upper list m = upper.length while(m > 1 && orient( points[upper[m-2]], points[upper[m-1]], p) >= 0) { m -= 1 upper.pop() } upper.push(idx) } //Merge lists together var result = new Array(upper.length + lower.length - 2) var ptr = 0 for(var i=0, nl=lower.length; i0; --j) { result[ptr++] = upper[j] } //Return result return result } },{"robust-orientation":214}],66:[function(require,module,exports){ "use strict" var createThunk = require("./lib/thunk.js") function Procedure() { this.argTypes = [] this.shimArgs = [] this.arrayArgs = [] this.arrayBlockIndices = [] this.scalarArgs = [] this.offsetArgs = [] this.offsetArgIndex = [] this.indexArgs = [] this.shapeArgs = [] this.funcName = "" this.pre = null this.body = null this.post = null this.debug = false } function compileCwise(user_args) { //Create procedure var proc = new Procedure() //Parse blocks proc.pre = user_args.pre proc.body = user_args.body proc.post = user_args.post //Parse arguments var proc_args = user_args.args.slice(0) proc.argTypes = proc_args for(var i=0; i0) { throw new Error("cwise: pre() block may not reference array args") } if(i < proc.post.args.length && proc.post.args[i].count>0) { throw new Error("cwise: post() block may not reference array args") } } else if(arg_type === "scalar") { proc.scalarArgs.push(i) proc.shimArgs.push("scalar" + i) } else if(arg_type === "index") { proc.indexArgs.push(i) if(i < proc.pre.args.length && proc.pre.args[i].count > 0) { throw new Error("cwise: pre() block may not reference array index") } if(i < proc.body.args.length && proc.body.args[i].lvalue) { throw new Error("cwise: body() block may not write to array index") } if(i < proc.post.args.length && proc.post.args[i].count > 0) { throw new Error("cwise: post() block may not reference array index") } } else if(arg_type === "shape") { proc.shapeArgs.push(i) if(i < proc.pre.args.length && proc.pre.args[i].lvalue) { throw new Error("cwise: pre() block may not write to array shape") } if(i < proc.body.args.length && proc.body.args[i].lvalue) { throw new Error("cwise: body() block may not write to array shape") } if(i < proc.post.args.length && proc.post.args[i].lvalue) { throw new Error("cwise: post() block may not write to array shape") } } else if(typeof arg_type === "object" && arg_type.offset) { proc.argTypes[i] = "offset" proc.offsetArgs.push({ array: arg_type.array, offset:arg_type.offset }) proc.offsetArgIndex.push(i) } else { throw new Error("cwise: Unknown argument type " + proc_args[i]) } } //Make sure at least one array argument was specified if(proc.arrayArgs.length <= 0) { throw new Error("cwise: No array arguments specified") } //Make sure arguments are correct if(proc.pre.args.length > proc_args.length) { throw new Error("cwise: Too many arguments in pre() block") } if(proc.body.args.length > proc_args.length) { throw new Error("cwise: Too many arguments in body() block") } if(proc.post.args.length > proc_args.length) { throw new Error("cwise: Too many arguments in post() block") } //Check debug flag proc.debug = !!user_args.printCode || !!user_args.debug //Retrieve name proc.funcName = user_args.funcName || "cwise" //Read in block size proc.blockSize = user_args.blockSize || 64 return createThunk(proc) } module.exports = compileCwise },{"./lib/thunk.js":68}],67:[function(require,module,exports){ "use strict" var uniq = require("uniq") // This function generates very simple loops analogous to how you typically traverse arrays (the outermost loop corresponds to the slowest changing index, the innermost loop to the fastest changing index) // TODO: If two arrays have the same strides (and offsets) there is potential for decreasing the number of "pointers" and related variables. The drawback is that the type signature would become more specific and that there would thus be less potential for caching, but it might still be worth it, especially when dealing with large numbers of arguments. function innerFill(order, proc, body) { var dimension = order.length , nargs = proc.arrayArgs.length , has_index = proc.indexArgs.length>0 , code = [] , vars = [] , idx=0, pidx=0, i, j for(i=0; i=0; --i) { // Start at largest stride and work your way inwards idx = order[i] code.push(["for(i",i,"=0;i",i," 0) { code.push(["index[",pidx,"]-=s",pidx].join("")) } code.push(["++index[",idx,"]"].join("")) } code.push("}") } return code.join("\n") } // Generate "outer" loops that loop over blocks of data, applying "inner" loops to the blocks by manipulating the local variables in such a way that the inner loop only "sees" the current block. // TODO: If this is used, then the previous declaration (done by generateCwiseOp) of s* is essentially unnecessary. // I believe the s* are not used elsewhere (in particular, I don't think they're used in the pre/post parts and "shape" is defined independently), so it would be possible to make defining the s* dependent on what loop method is being used. function outerFill(matched, order, proc, body) { var dimension = order.length , nargs = proc.arrayArgs.length , blockSize = proc.blockSize , has_index = proc.indexArgs.length > 0 , code = [] for(var i=0; i0;){"].join("")) // Iterate back to front code.push(["if(j",i,"<",blockSize,"){"].join("")) // Either decrease j by blockSize (s = blockSize), or set it to zero (after setting s = j). code.push(["s",order[i],"=j",i].join("")) code.push(["j",i,"=0"].join("")) code.push(["}else{s",order[i],"=",blockSize].join("")) code.push(["j",i,"-=",blockSize,"}"].join("")) if(has_index) { code.push(["index[",order[i],"]=j",i].join("")) } } for(var i=0; i 0) { allEqual = allEqual && summary[i] === summary[i-1] } } if(allEqual) { return summary[0] } return summary.join("") } //Generates a cwise operator function generateCWiseOp(proc, typesig) { //Compute dimension // Arrays get put first in typesig, and there are two entries per array (dtype and order), so this gets the number of dimensions in the first array arg. var dimension = (typesig[1].length - Math.abs(proc.arrayBlockIndices[0]))|0 var orders = new Array(proc.arrayArgs.length) var dtypes = new Array(proc.arrayArgs.length) for(var i=0; i 0) { vars.push("shape=SS.slice(0)") // Makes the shape over which we iterate available to the user defined functions (so you can use width/height for example) } if(proc.indexArgs.length > 0) { // Prepare an array to keep track of the (logical) indices, initialized to dimension zeroes. var zeros = new Array(dimension) for(var i=0; i 3) { code.push(processBlock(proc.pre, proc, dtypes)) } //Process body var body = processBlock(proc.body, proc, dtypes) var matched = countMatches(loopOrders) if(matched < dimension) { code.push(outerFill(matched, loopOrders[0], proc, body)) // TODO: Rather than passing loopOrders[0], it might be interesting to look at passing an order that represents the majority of the arguments for example. } else { code.push(innerFill(loopOrders[0], proc, body)) } //Inline epilog if(proc.post.body.length > 3) { code.push(processBlock(proc.post, proc, dtypes)) } if(proc.debug) { console.log("-----Generated cwise routine for ", typesig, ":\n" + code.join("\n") + "\n----------") } var loopName = [(proc.funcName||"unnamed"), "_cwise_loop_", orders[0].join("s"),"m",matched,typeSummary(dtypes)].join("") var f = new Function(["function ",loopName,"(", arglist.join(","),"){", code.join("\n"),"} return ", loopName].join("")) return f() } module.exports = generateCWiseOp },{"uniq":234}],68:[function(require,module,exports){ "use strict" // The function below is called when constructing a cwise function object, and does the following: // A function object is constructed which accepts as argument a compilation function and returns another function. // It is this other function that is eventually returned by createThunk, and this function is the one that actually // checks whether a certain pattern of arguments has already been used before and compiles new loops as needed. // The compilation passed to the first function object is used for compiling new functions. // Once this function object is created, it is called with compile as argument, where the first argument of compile // is bound to "proc" (essentially containing a preprocessed version of the user arguments to cwise). // So createThunk roughly works like this: // function createThunk(proc) { // var thunk = function(compileBound) { // var CACHED = {} // return function(arrays and scalars) { // if (dtype and order of arrays in CACHED) { // var func = CACHED[dtype and order of arrays] // } else { // var func = CACHED[dtype and order of arrays] = compileBound(dtype and order of arrays) // } // return func(arrays and scalars) // } // } // return thunk(compile.bind1(proc)) // } var compile = require("./compile.js") function createThunk(proc) { var code = ["'use strict'", "var CACHED={}"] var vars = [] var thunkName = proc.funcName + "_cwise_thunk" //Build thunk code.push(["return function ", thunkName, "(", proc.shimArgs.join(","), "){"].join("")) var typesig = [] var string_typesig = [] var proc_args = [["array",proc.arrayArgs[0],".shape.slice(", // Slice shape so that we only retain the shape over which we iterate (which gets passed to the cwise operator as SS). Math.max(0,proc.arrayBlockIndices[0]),proc.arrayBlockIndices[0]<0?(","+proc.arrayBlockIndices[0]+")"):")"].join("")] var shapeLengthConditions = [], shapeConditions = [] // Process array arguments for(var i=0; i0) { // Gather conditions to check for shape equality (ignoring block indices) shapeLengthConditions.push("array" + proc.arrayArgs[0] + ".shape.length===array" + j + ".shape.length+" + (Math.abs(proc.arrayBlockIndices[0])-Math.abs(proc.arrayBlockIndices[i]))) shapeConditions.push("array" + proc.arrayArgs[0] + ".shape[shapeIndex+" + Math.max(0,proc.arrayBlockIndices[0]) + "]===array" + j + ".shape[shapeIndex+" + Math.max(0,proc.arrayBlockIndices[i]) + "]") } } // Check for shape equality if (proc.arrayArgs.length > 1) { code.push("if (!(" + shapeLengthConditions.join(" && ") + ")) throw new Error('cwise: Arrays do not all have the same dimensionality!')") code.push("for(var shapeIndex=array" + proc.arrayArgs[0] + ".shape.length-" + Math.abs(proc.arrayBlockIndices[0]) + "; shapeIndex-->0;) {") code.push("if (!(" + shapeConditions.join(" && ") + ")) throw new Error('cwise: Arrays do not all have the same shape!')") code.push("}") } // Process scalar arguments for(var i=0; i b ? 1 : a >= b ? 0 : NaN; } d3.descending = function(a, b) { return b < a ? -1 : b > a ? 1 : b >= a ? 0 : NaN; }; d3.min = function(array, f) { var i = -1, n = array.length, a, b; if (arguments.length === 1) { while (++i < n) if ((b = array[i]) != null && b >= b) { a = b; break; } while (++i < n) if ((b = array[i]) != null && a > b) a = b; } else { while (++i < n) if ((b = f.call(array, array[i], i)) != null && b >= b) { a = b; break; } while (++i < n) if ((b = f.call(array, array[i], i)) != null && a > b) a = b; } return a; }; d3.max = function(array, f) { var i = -1, n = array.length, a, b; if (arguments.length === 1) { while (++i < n) if ((b = array[i]) != null && b >= b) { a = b; break; } while (++i < n) if ((b = array[i]) != null && b > a) a = b; } else { while (++i < n) if ((b = f.call(array, array[i], i)) != null && b >= b) { a = b; break; } while (++i < n) if ((b = f.call(array, array[i], i)) != null && b > a) a = b; } return a; }; d3.extent = function(array, f) { var i = -1, n = array.length, a, b, c; if (arguments.length === 1) { while (++i < n) if ((b = array[i]) != null && b >= b) { a = c = b; break; } while (++i < n) if ((b = array[i]) != null) { if (a > b) a = b; if (c < b) c = b; } } else { while (++i < n) if ((b = f.call(array, array[i], i)) != null && b >= b) { a = c = b; break; } while (++i < n) if ((b = f.call(array, array[i], i)) != null) { if (a > b) a = b; if (c < b) c = b; } } return [ a, c ]; }; function d3_number(x) { return x === null ? NaN : +x; } function d3_numeric(x) { return !isNaN(x); } d3.sum = function(array, f) { var s = 0, n = array.length, a, i = -1; if (arguments.length === 1) { while (++i < n) if (d3_numeric(a = +array[i])) s += a; } else { while (++i < n) if (d3_numeric(a = +f.call(array, array[i], i))) s += a; } return s; }; d3.mean = function(array, f) { var s = 0, n = array.length, a, i = -1, j = n; if (arguments.length === 1) { while (++i < n) if (d3_numeric(a = d3_number(array[i]))) s += a; else --j; } else { while (++i < n) if (d3_numeric(a = d3_number(f.call(array, array[i], i)))) s += a; else --j; } if (j) return s / j; }; d3.quantile = function(values, p) { var H = (values.length - 1) * p + 1, h = Math.floor(H), v = +values[h - 1], e = H - h; return e ? v + e * (values[h] - v) : v; }; d3.median = function(array, f) { var numbers = [], n = array.length, a, i = -1; if (arguments.length === 1) { while (++i < n) if (d3_numeric(a = d3_number(array[i]))) numbers.push(a); } else { while (++i < n) if (d3_numeric(a = d3_number(f.call(array, array[i], i)))) numbers.push(a); } if (numbers.length) return d3.quantile(numbers.sort(d3_ascending), .5); }; d3.variance = function(array, f) { var n = array.length, m = 0, a, d, s = 0, i = -1, j = 0; if (arguments.length === 1) { while (++i < n) { if (d3_numeric(a = d3_number(array[i]))) { d = a - m; m += d / ++j; s += d * (a - m); } } } else { while (++i < n) { if (d3_numeric(a = d3_number(f.call(array, array[i], i)))) { d = a - m; m += d / ++j; s += d * (a - m); } } } if (j > 1) return s / (j - 1); }; d3.deviation = function() { var v = d3.variance.apply(this, arguments); return v ? Math.sqrt(v) : v; }; function d3_bisector(compare) { return { left: function(a, x, lo, hi) { if (arguments.length < 3) lo = 0; if (arguments.length < 4) hi = a.length; while (lo < hi) { var mid = lo + hi >>> 1; if (compare(a[mid], x) < 0) lo = mid + 1; else hi = mid; } return lo; }, right: function(a, x, lo, hi) { if (arguments.length < 3) lo = 0; if (arguments.length < 4) hi = a.length; while (lo < hi) { var mid = lo + hi >>> 1; if (compare(a[mid], x) > 0) hi = mid; else lo = mid + 1; } return lo; } }; } var d3_bisect = d3_bisector(d3_ascending); d3.bisectLeft = d3_bisect.left; d3.bisect = d3.bisectRight = d3_bisect.right; d3.bisector = function(f) { return d3_bisector(f.length === 1 ? function(d, x) { return d3_ascending(f(d), x); } : f); }; d3.shuffle = function(array, i0, i1) { if ((m = arguments.length) < 3) { i1 = array.length; if (m < 2) i0 = 0; } var m = i1 - i0, t, i; while (m) { i = Math.random() * m-- | 0; t = array[m + i0], array[m + i0] = array[i + i0], array[i + i0] = t; } return array; }; d3.permute = function(array, indexes) { var i = indexes.length, permutes = new Array(i); while (i--) permutes[i] = array[indexes[i]]; return permutes; }; d3.pairs = function(array) { var i = 0, n = array.length - 1, p0, p1 = array[0], pairs = new Array(n < 0 ? 0 : n); while (i < n) pairs[i] = [ p0 = p1, p1 = array[++i] ]; return pairs; }; d3.zip = function() { if (!(n = arguments.length)) return []; for (var i = -1, m = d3.min(arguments, d3_zipLength), zips = new Array(m); ++i < m; ) { for (var j = -1, n, zip = zips[i] = new Array(n); ++j < n; ) { zip[j] = arguments[j][i]; } } return zips; }; function d3_zipLength(d) { return d.length; } d3.transpose = function(matrix) { return d3.zip.apply(d3, matrix); }; d3.keys = function(map) { var keys = []; for (var key in map) keys.push(key); return keys; }; d3.values = function(map) { var values = []; for (var key in map) values.push(map[key]); return values; }; d3.entries = function(map) { var entries = []; for (var key in map) entries.push({ key: key, value: map[key] }); return entries; }; d3.merge = function(arrays) { var n = arrays.length, m, i = -1, j = 0, merged, array; while (++i < n) j += arrays[i].length; merged = new Array(j); while (--n >= 0) { array = arrays[n]; m = array.length; while (--m >= 0) { merged[--j] = array[m]; } } return merged; }; var abs = Math.abs; d3.range = function(start, stop, step) { if (arguments.length < 3) { step = 1; if (arguments.length < 2) { stop = start; start = 0; } } if ((stop - start) / step === Infinity) throw new Error("infinite range"); var range = [], k = d3_range_integerScale(abs(step)), i = -1, j; start *= k, stop *= k, step *= k; if (step < 0) while ((j = start + step * ++i) > stop) range.push(j / k); else while ((j = start + step * ++i) < stop) range.push(j / k); return range; }; function d3_range_integerScale(x) { var k = 1; while (x * k % 1) k *= 10; return k; } function d3_class(ctor, properties) { for (var key in properties) { Object.defineProperty(ctor.prototype, key, { value: properties[key], enumerable: false }); } } d3.map = function(object, f) { var map = new d3_Map(); if (object instanceof d3_Map) { object.forEach(function(key, value) { map.set(key, value); }); } else if (Array.isArray(object)) { var i = -1, n = object.length, o; if (arguments.length === 1) while (++i < n) map.set(i, object[i]); else while (++i < n) map.set(f.call(object, o = object[i], i), o); } else { for (var key in object) map.set(key, object[key]); } return map; }; function d3_Map() { this._ = Object.create(null); } var d3_map_proto = "__proto__", d3_map_zero = "\x00"; d3_class(d3_Map, { has: d3_map_has, get: function(key) { return this._[d3_map_escape(key)]; }, set: function(key, value) { return this._[d3_map_escape(key)] = value; }, remove: d3_map_remove, keys: d3_map_keys, values: function() { var values = []; for (var key in this._) values.push(this._[key]); return values; }, entries: function() { var entries = []; for (var key in this._) entries.push({ key: d3_map_unescape(key), value: this._[key] }); return entries; }, size: d3_map_size, empty: d3_map_empty, forEach: function(f) { for (var key in this._) f.call(this, d3_map_unescape(key), this._[key]); } }); function d3_map_escape(key) { return (key += "") === d3_map_proto || key[0] === d3_map_zero ? d3_map_zero + key : key; } function d3_map_unescape(key) { return (key += "")[0] === d3_map_zero ? key.slice(1) : key; } function d3_map_has(key) { return d3_map_escape(key) in this._; } function d3_map_remove(key) { return (key = d3_map_escape(key)) in this._ && delete this._[key]; } function d3_map_keys() { var keys = []; for (var key in this._) keys.push(d3_map_unescape(key)); return keys; } function d3_map_size() { var size = 0; for (var key in this._) ++size; return size; } function d3_map_empty() { for (var key in this._) return false; return true; } d3.nest = function() { var nest = {}, keys = [], sortKeys = [], sortValues, rollup; function map(mapType, array, depth) { if (depth >= keys.length) return rollup ? rollup.call(nest, array) : sortValues ? array.sort(sortValues) : array; var i = -1, n = array.length, key = keys[depth++], keyValue, object, setter, valuesByKey = new d3_Map(), values; while (++i < n) { if (values = valuesByKey.get(keyValue = key(object = array[i]))) { values.push(object); } else { valuesByKey.set(keyValue, [ object ]); } } if (mapType) { object = mapType(); setter = function(keyValue, values) { object.set(keyValue, map(mapType, values, depth)); }; } else { object = {}; setter = function(keyValue, values) { object[keyValue] = map(mapType, values, depth); }; } valuesByKey.forEach(setter); return object; } function entries(map, depth) { if (depth >= keys.length) return map; var array = [], sortKey = sortKeys[depth++]; map.forEach(function(key, keyMap) { array.push({ key: key, values: entries(keyMap, depth) }); }); return sortKey ? array.sort(function(a, b) { return sortKey(a.key, b.key); }) : array; } nest.map = function(array, mapType) { return map(mapType, array, 0); }; nest.entries = function(array) { return entries(map(d3.map, array, 0), 0); }; nest.key = function(d) { keys.push(d); return nest; }; nest.sortKeys = function(order) { sortKeys[keys.length - 1] = order; return nest; }; nest.sortValues = function(order) { sortValues = order; return nest; }; nest.rollup = function(f) { rollup = f; return nest; }; return nest; }; d3.set = function(array) { var set = new d3_Set(); if (array) for (var i = 0, n = array.length; i < n; ++i) set.add(array[i]); return set; }; function d3_Set() { this._ = Object.create(null); } d3_class(d3_Set, { has: d3_map_has, add: function(key) { this._[d3_map_escape(key += "")] = true; return key; }, remove: d3_map_remove, values: d3_map_keys, size: d3_map_size, empty: d3_map_empty, forEach: function(f) { for (var key in this._) f.call(this, d3_map_unescape(key)); } }); d3.behavior = {}; function d3_identity(d) { return d; } d3.rebind = function(target, source) { var i = 1, n = arguments.length, method; while (++i < n) target[method = arguments[i]] = d3_rebind(target, source, source[method]); return target; }; function d3_rebind(target, source, method) { return function() { var value = method.apply(source, arguments); return value === source ? target : value; }; } function d3_vendorSymbol(object, name) { if (name in object) return name; name = name.charAt(0).toUpperCase() + name.slice(1); for (var i = 0, n = d3_vendorPrefixes.length; i < n; ++i) { var prefixName = d3_vendorPrefixes[i] + name; if (prefixName in object) return prefixName; } } var d3_vendorPrefixes = [ "webkit", "ms", "moz", "Moz", "o", "O" ]; function d3_noop() {} d3.dispatch = function() { var dispatch = new d3_dispatch(), i = -1, n = arguments.length; while (++i < n) dispatch[arguments[i]] = d3_dispatch_event(dispatch); return dispatch; }; function d3_dispatch() {} d3_dispatch.prototype.on = function(type, listener) { var i = type.indexOf("."), name = ""; if (i >= 0) { name = type.slice(i + 1); type = type.slice(0, i); } if (type) return arguments.length < 2 ? this[type].on(name) : this[type].on(name, listener); if (arguments.length === 2) { if (listener == null) for (type in this) { if (this.hasOwnProperty(type)) this[type].on(name, null); } return this; } }; function d3_dispatch_event(dispatch) { var listeners = [], listenerByName = new d3_Map(); function event() { var z = listeners, i = -1, n = z.length, l; while (++i < n) if (l = z[i].on) l.apply(this, arguments); return dispatch; } event.on = function(name, listener) { var l = listenerByName.get(name), i; if (arguments.length < 2) return l && l.on; if (l) { l.on = null; listeners = listeners.slice(0, i = listeners.indexOf(l)).concat(listeners.slice(i + 1)); listenerByName.remove(name); } if (listener) listeners.push(listenerByName.set(name, { on: listener })); return dispatch; }; return event; } d3.event = null; function d3_eventPreventDefault() { d3.event.preventDefault(); } function d3_eventSource() { var e = d3.event, s; while (s = e.sourceEvent) e = s; return e; } function d3_eventDispatch(target) { var dispatch = new d3_dispatch(), i = 0, n = arguments.length; while (++i < n) dispatch[arguments[i]] = d3_dispatch_event(dispatch); dispatch.of = function(thiz, argumentz) { return function(e1) { try { var e0 = e1.sourceEvent = d3.event; e1.target = target; d3.event = e1; dispatch[e1.type].apply(thiz, argumentz); } finally { d3.event = e0; } }; }; return dispatch; } d3.requote = function(s) { return s.replace(d3_requote_re, "\\$&"); }; var d3_requote_re = /[\\\^\$\*\+\?\|\[\]\(\)\.\{\}]/g; var d3_subclass = {}.__proto__ ? function(object, prototype) { object.__proto__ = prototype; } : function(object, prototype) { for (var property in prototype) object[property] = prototype[property]; }; function d3_selection(groups) { d3_subclass(groups, d3_selectionPrototype); return groups; } var d3_select = function(s, n) { return n.querySelector(s); }, d3_selectAll = function(s, n) { return n.querySelectorAll(s); }, d3_selectMatches = function(n, s) { var d3_selectMatcher = n.matches || n[d3_vendorSymbol(n, "matchesSelector")]; d3_selectMatches = function(n, s) { return d3_selectMatcher.call(n, s); }; return d3_selectMatches(n, s); }; if (typeof Sizzle === "function") { d3_select = function(s, n) { return Sizzle(s, n)[0] || null; }; d3_selectAll = Sizzle; d3_selectMatches = Sizzle.matchesSelector; } d3.selection = function() { return d3.select(d3_document.documentElement); }; var d3_selectionPrototype = d3.selection.prototype = []; d3_selectionPrototype.select = function(selector) { var subgroups = [], subgroup, subnode, group, node; selector = d3_selection_selector(selector); for (var j = -1, m = this.length; ++j < m; ) { subgroups.push(subgroup = []); subgroup.parentNode = (group = this[j]).parentNode; for (var i = -1, n = group.length; ++i < n; ) { if (node = group[i]) { subgroup.push(subnode = selector.call(node, node.__data__, i, j)); if (subnode && "__data__" in node) subnode.__data__ = node.__data__; } else { subgroup.push(null); } } } return d3_selection(subgroups); }; function d3_selection_selector(selector) { return typeof selector === "function" ? selector : function() { return d3_select(selector, this); }; } d3_selectionPrototype.selectAll = function(selector) { var subgroups = [], subgroup, node; selector = d3_selection_selectorAll(selector); for (var j = -1, m = this.length; ++j < m; ) { for (var group = this[j], i = -1, n = group.length; ++i < n; ) { if (node = group[i]) { subgroups.push(subgroup = d3_array(selector.call(node, node.__data__, i, j))); subgroup.parentNode = node; } } } return d3_selection(subgroups); }; function d3_selection_selectorAll(selector) { return typeof selector === "function" ? selector : function() { return d3_selectAll(selector, this); }; } var d3_nsPrefix = { svg: "http://www.w3.org/2000/svg", xhtml: "http://www.w3.org/1999/xhtml", xlink: "http://www.w3.org/1999/xlink", xml: "http://www.w3.org/XML/1998/namespace", xmlns: "http://www.w3.org/2000/xmlns/" }; d3.ns = { prefix: d3_nsPrefix, qualify: function(name) { var i = name.indexOf(":"), prefix = name; if (i >= 0 && (prefix = name.slice(0, i)) !== "xmlns") name = name.slice(i + 1); return d3_nsPrefix.hasOwnProperty(prefix) ? { space: d3_nsPrefix[prefix], local: name } : name; } }; d3_selectionPrototype.attr = function(name, value) { if (arguments.length < 2) { if (typeof name === "string") { var node = this.node(); name = d3.ns.qualify(name); return name.local ? node.getAttributeNS(name.space, name.local) : node.getAttribute(name); } for (value in name) this.each(d3_selection_attr(value, name[value])); return this; } return this.each(d3_selection_attr(name, value)); }; function d3_selection_attr(name, value) { name = d3.ns.qualify(name); function attrNull() { this.removeAttribute(name); } function attrNullNS() { this.removeAttributeNS(name.space, name.local); } function attrConstant() { this.setAttribute(name, value); } function attrConstantNS() { this.setAttributeNS(name.space, name.local, value); } function attrFunction() { var x = value.apply(this, arguments); if (x == null) this.removeAttribute(name); else this.setAttribute(name, x); } function attrFunctionNS() { var x = value.apply(this, arguments); if (x == null) this.removeAttributeNS(name.space, name.local); else this.setAttributeNS(name.space, name.local, x); } return value == null ? name.local ? attrNullNS : attrNull : typeof value === "function" ? name.local ? attrFunctionNS : attrFunction : name.local ? attrConstantNS : attrConstant; } function d3_collapse(s) { return s.trim().replace(/\s+/g, " "); } d3_selectionPrototype.classed = function(name, value) { if (arguments.length < 2) { if (typeof name === "string") { var node = this.node(), n = (name = d3_selection_classes(name)).length, i = -1; if (value = node.classList) { while (++i < n) if (!value.contains(name[i])) return false; } else { value = node.getAttribute("class"); while (++i < n) if (!d3_selection_classedRe(name[i]).test(value)) return false; } return true; } for (value in name) this.each(d3_selection_classed(value, name[value])); return this; } return this.each(d3_selection_classed(name, value)); }; function d3_selection_classedRe(name) { return new RegExp("(?:^|\\s+)" + d3.requote(name) + "(?:\\s+|$)", "g"); } function d3_selection_classes(name) { return (name + "").trim().split(/^|\s+/); } function d3_selection_classed(name, value) { name = d3_selection_classes(name).map(d3_selection_classedName); var n = name.length; function classedConstant() { var i = -1; while (++i < n) name[i](this, value); } function classedFunction() { var i = -1, x = value.apply(this, arguments); while (++i < n) name[i](this, x); } return typeof value === "function" ? classedFunction : classedConstant; } function d3_selection_classedName(name) { var re = d3_selection_classedRe(name); return function(node, value) { if (c = node.classList) return value ? c.add(name) : c.remove(name); var c = node.getAttribute("class") || ""; if (value) { re.lastIndex = 0; if (!re.test(c)) node.setAttribute("class", d3_collapse(c + " " + name)); } else { node.setAttribute("class", d3_collapse(c.replace(re, " "))); } }; } d3_selectionPrototype.style = function(name, value, priority) { var n = arguments.length; if (n < 3) { if (typeof name !== "string") { if (n < 2) value = ""; for (priority in name) this.each(d3_selection_style(priority, name[priority], value)); return this; } if (n < 2) { var node = this.node(); return d3_window(node).getComputedStyle(node, null).getPropertyValue(name); } priority = ""; } return this.each(d3_selection_style(name, value, priority)); }; function d3_selection_style(name, value, priority) { function styleNull() { this.style.removeProperty(name); } function styleConstant() { this.style.setProperty(name, value, priority); } function styleFunction() { var x = value.apply(this, arguments); if (x == null) this.style.removeProperty(name); else this.style.setProperty(name, x, priority); } return value == null ? styleNull : typeof value === "function" ? styleFunction : styleConstant; } d3_selectionPrototype.property = function(name, value) { if (arguments.length < 2) { if (typeof name === "string") return this.node()[name]; for (value in name) this.each(d3_selection_property(value, name[value])); return this; } return this.each(d3_selection_property(name, value)); }; function d3_selection_property(name, value) { function propertyNull() { delete this[name]; } function propertyConstant() { this[name] = value; } function propertyFunction() { var x = value.apply(this, arguments); if (x == null) delete this[name]; else this[name] = x; } return value == null ? propertyNull : typeof value === "function" ? propertyFunction : propertyConstant; } d3_selectionPrototype.text = function(value) { return arguments.length ? this.each(typeof value === "function" ? function() { var v = value.apply(this, arguments); this.textContent = v == null ? "" : v; } : value == null ? function() { this.textContent = ""; } : function() { this.textContent = value; }) : this.node().textContent; }; d3_selectionPrototype.html = function(value) { return arguments.length ? this.each(typeof value === "function" ? function() { var v = value.apply(this, arguments); this.innerHTML = v == null ? "" : v; } : value == null ? function() { this.innerHTML = ""; } : function() { this.innerHTML = value; }) : this.node().innerHTML; }; d3_selectionPrototype.append = function(name) { name = d3_selection_creator(name); return this.select(function() { return this.appendChild(name.apply(this, arguments)); }); }; function d3_selection_creator(name) { function create() { var document = this.ownerDocument, namespace = this.namespaceURI; return namespace ? document.createElementNS(namespace, name) : document.createElement(name); } function createNS() { return this.ownerDocument.createElementNS(name.space, name.local); } return typeof name === "function" ? name : (name = d3.ns.qualify(name)).local ? createNS : create; } d3_selectionPrototype.insert = function(name, before) { name = d3_selection_creator(name); before = d3_selection_selector(before); return this.select(function() { return this.insertBefore(name.apply(this, arguments), before.apply(this, arguments) || null); }); }; d3_selectionPrototype.remove = function() { return this.each(d3_selectionRemove); }; function d3_selectionRemove() { var parent = this.parentNode; if (parent) parent.removeChild(this); } d3_selectionPrototype.data = function(value, key) { var i = -1, n = this.length, group, node; if (!arguments.length) { value = new Array(n = (group = this[0]).length); while (++i < n) { if (node = group[i]) { value[i] = node.__data__; } } return value; } function bind(group, groupData) { var i, n = group.length, m = groupData.length, n0 = Math.min(n, m), updateNodes = new Array(m), enterNodes = new Array(m), exitNodes = new Array(n), node, nodeData; if (key) { var nodeByKeyValue = new d3_Map(), keyValues = new Array(n), keyValue; for (i = -1; ++i < n; ) { if (node = group[i]) { if (nodeByKeyValue.has(keyValue = key.call(node, node.__data__, i))) { exitNodes[i] = node; } else { nodeByKeyValue.set(keyValue, node); } keyValues[i] = keyValue; } } for (i = -1; ++i < m; ) { if (!(node = nodeByKeyValue.get(keyValue = key.call(groupData, nodeData = groupData[i], i)))) { enterNodes[i] = d3_selection_dataNode(nodeData); } else if (node !== true) { updateNodes[i] = node; node.__data__ = nodeData; } nodeByKeyValue.set(keyValue, true); } for (i = -1; ++i < n; ) { if (i in keyValues && nodeByKeyValue.get(keyValues[i]) !== true) { exitNodes[i] = group[i]; } } } else { for (i = -1; ++i < n0; ) { node = group[i]; nodeData = groupData[i]; if (node) { node.__data__ = nodeData; updateNodes[i] = node; } else { enterNodes[i] = d3_selection_dataNode(nodeData); } } for (;i < m; ++i) { enterNodes[i] = d3_selection_dataNode(groupData[i]); } for (;i < n; ++i) { exitNodes[i] = group[i]; } } enterNodes.update = updateNodes; enterNodes.parentNode = updateNodes.parentNode = exitNodes.parentNode = group.parentNode; enter.push(enterNodes); update.push(updateNodes); exit.push(exitNodes); } var enter = d3_selection_enter([]), update = d3_selection([]), exit = d3_selection([]); if (typeof value === "function") { while (++i < n) { bind(group = this[i], value.call(group, group.parentNode.__data__, i)); } } else { while (++i < n) { bind(group = this[i], value); } } update.enter = function() { return enter; }; update.exit = function() { return exit; }; return update; }; function d3_selection_dataNode(data) { return { __data__: data }; } d3_selectionPrototype.datum = function(value) { return arguments.length ? this.property("__data__", value) : this.property("__data__"); }; d3_selectionPrototype.filter = function(filter) { var subgroups = [], subgroup, group, node; if (typeof filter !== "function") filter = d3_selection_filter(filter); for (var j = 0, m = this.length; j < m; j++) { subgroups.push(subgroup = []); subgroup.parentNode = (group = this[j]).parentNode; for (var i = 0, n = group.length; i < n; i++) { if ((node = group[i]) && filter.call(node, node.__data__, i, j)) { subgroup.push(node); } } } return d3_selection(subgroups); }; function d3_selection_filter(selector) { return function() { return d3_selectMatches(this, selector); }; } d3_selectionPrototype.order = function() { for (var j = -1, m = this.length; ++j < m; ) { for (var group = this[j], i = group.length - 1, next = group[i], node; --i >= 0; ) { if (node = group[i]) { if (next && next !== node.nextSibling) next.parentNode.insertBefore(node, next); next = node; } } } return this; }; d3_selectionPrototype.sort = function(comparator) { comparator = d3_selection_sortComparator.apply(this, arguments); for (var j = -1, m = this.length; ++j < m; ) this[j].sort(comparator); return this.order(); }; function d3_selection_sortComparator(comparator) { if (!arguments.length) comparator = d3_ascending; return function(a, b) { return a && b ? comparator(a.__data__, b.__data__) : !a - !b; }; } d3_selectionPrototype.each = function(callback) { return d3_selection_each(this, function(node, i, j) { callback.call(node, node.__data__, i, j); }); }; function d3_selection_each(groups, callback) { for (var j = 0, m = groups.length; j < m; j++) { for (var group = groups[j], i = 0, n = group.length, node; i < n; i++) { if (node = group[i]) callback(node, i, j); } } return groups; } d3_selectionPrototype.call = function(callback) { var args = d3_array(arguments); callback.apply(args[0] = this, args); return this; }; d3_selectionPrototype.empty = function() { return !this.node(); }; d3_selectionPrototype.node = function() { for (var j = 0, m = this.length; j < m; j++) { for (var group = this[j], i = 0, n = group.length; i < n; i++) { var node = group[i]; if (node) return node; } } return null; }; d3_selectionPrototype.size = function() { var n = 0; d3_selection_each(this, function() { ++n; }); return n; }; function d3_selection_enter(selection) { d3_subclass(selection, d3_selection_enterPrototype); return selection; } var d3_selection_enterPrototype = []; d3.selection.enter = d3_selection_enter; d3.selection.enter.prototype = d3_selection_enterPrototype; d3_selection_enterPrototype.append = d3_selectionPrototype.append; d3_selection_enterPrototype.empty = d3_selectionPrototype.empty; d3_selection_enterPrototype.node = d3_selectionPrototype.node; d3_selection_enterPrototype.call = d3_selectionPrototype.call; d3_selection_enterPrototype.size = d3_selectionPrototype.size; d3_selection_enterPrototype.select = function(selector) { var subgroups = [], subgroup, subnode, upgroup, group, node; for (var j = -1, m = this.length; ++j < m; ) { upgroup = (group = this[j]).update; subgroups.push(subgroup = []); subgroup.parentNode = group.parentNode; for (var i = -1, n = group.length; ++i < n; ) { if (node = group[i]) { subgroup.push(upgroup[i] = subnode = selector.call(group.parentNode, node.__data__, i, j)); subnode.__data__ = node.__data__; } else { subgroup.push(null); } } } return d3_selection(subgroups); }; d3_selection_enterPrototype.insert = function(name, before) { if (arguments.length < 2) before = d3_selection_enterInsertBefore(this); return d3_selectionPrototype.insert.call(this, name, before); }; function d3_selection_enterInsertBefore(enter) { var i0, j0; return function(d, i, j) { var group = enter[j].update, n = group.length, node; if (j != j0) j0 = j, i0 = 0; if (i >= i0) i0 = i + 1; while (!(node = group[i0]) && ++i0 < n) ; return node; }; } d3.select = function(node) { var group; if (typeof node === "string") { group = [ d3_select(node, d3_document) ]; group.parentNode = d3_document.documentElement; } else { group = [ node ]; group.parentNode = d3_documentElement(node); } return d3_selection([ group ]); }; d3.selectAll = function(nodes) { var group; if (typeof nodes === "string") { group = d3_array(d3_selectAll(nodes, d3_document)); group.parentNode = d3_document.documentElement; } else { group = d3_array(nodes); group.parentNode = null; } return d3_selection([ group ]); }; d3_selectionPrototype.on = function(type, listener, capture) { var n = arguments.length; if (n < 3) { if (typeof type !== "string") { if (n < 2) listener = false; for (capture in type) this.each(d3_selection_on(capture, type[capture], listener)); return this; } if (n < 2) return (n = this.node()["__on" + type]) && n._; capture = false; } return this.each(d3_selection_on(type, listener, capture)); }; function d3_selection_on(type, listener, capture) { var name = "__on" + type, i = type.indexOf("."), wrap = d3_selection_onListener; if (i > 0) type = type.slice(0, i); var filter = d3_selection_onFilters.get(type); if (filter) type = filter, wrap = d3_selection_onFilter; function onRemove() { var l = this[name]; if (l) { this.removeEventListener(type, l, l.$); delete this[name]; } } function onAdd() { var l = wrap(listener, d3_array(arguments)); onRemove.call(this); this.addEventListener(type, this[name] = l, l.$ = capture); l._ = listener; } function removeAll() { var re = new RegExp("^__on([^.]+)" + d3.requote(type) + "$"), match; for (var name in this) { if (match = name.match(re)) { var l = this[name]; this.removeEventListener(match[1], l, l.$); delete this[name]; } } } return i ? listener ? onAdd : onRemove : listener ? d3_noop : removeAll; } var d3_selection_onFilters = d3.map({ mouseenter: "mouseover", mouseleave: "mouseout" }); if (d3_document) { d3_selection_onFilters.forEach(function(k) { if ("on" + k in d3_document) d3_selection_onFilters.remove(k); }); } function d3_selection_onListener(listener, argumentz) { return function(e) { var o = d3.event; d3.event = e; argumentz[0] = this.__data__; try { listener.apply(this, argumentz); } finally { d3.event = o; } }; } function d3_selection_onFilter(listener, argumentz) { var l = d3_selection_onListener(listener, argumentz); return function(e) { var target = this, related = e.relatedTarget; if (!related || related !== target && !(related.compareDocumentPosition(target) & 8)) { l.call(target, e); } }; } var d3_event_dragSelect, d3_event_dragId = 0; function d3_event_dragSuppress(node) { var name = ".dragsuppress-" + ++d3_event_dragId, click = "click" + name, w = d3.select(d3_window(node)).on("touchmove" + name, d3_eventPreventDefault).on("dragstart" + name, d3_eventPreventDefault).on("selectstart" + name, d3_eventPreventDefault); if (d3_event_dragSelect == null) { d3_event_dragSelect = "onselectstart" in node ? false : d3_vendorSymbol(node.style, "userSelect"); } if (d3_event_dragSelect) { var style = d3_documentElement(node).style, select = style[d3_event_dragSelect]; style[d3_event_dragSelect] = "none"; } return function(suppressClick) { w.on(name, null); if (d3_event_dragSelect) style[d3_event_dragSelect] = select; if (suppressClick) { var off = function() { w.on(click, null); }; w.on(click, function() { d3_eventPreventDefault(); off(); }, true); setTimeout(off, 0); } }; } d3.mouse = function(container) { return d3_mousePoint(container, d3_eventSource()); }; var d3_mouse_bug44083 = this.navigator && /WebKit/.test(this.navigator.userAgent) ? -1 : 0; function d3_mousePoint(container, e) { if (e.changedTouches) e = e.changedTouches[0]; var svg = container.ownerSVGElement || container; if (svg.createSVGPoint) { var point = svg.createSVGPoint(); if (d3_mouse_bug44083 < 0) { var window = d3_window(container); if (window.scrollX || window.scrollY) { svg = d3.select("body").append("svg").style({ position: "absolute", top: 0, left: 0, margin: 0, padding: 0, border: "none" }, "important"); var ctm = svg[0][0].getScreenCTM(); d3_mouse_bug44083 = !(ctm.f || ctm.e); svg.remove(); } } if (d3_mouse_bug44083) point.x = e.pageX, point.y = e.pageY; else point.x = e.clientX, point.y = e.clientY; point = point.matrixTransform(container.getScreenCTM().inverse()); return [ point.x, point.y ]; } var rect = container.getBoundingClientRect(); return [ e.clientX - rect.left - container.clientLeft, e.clientY - rect.top - container.clientTop ]; } d3.touch = function(container, touches, identifier) { if (arguments.length < 3) identifier = touches, touches = d3_eventSource().changedTouches; if (touches) for (var i = 0, n = touches.length, touch; i < n; ++i) { if ((touch = touches[i]).identifier === identifier) { return d3_mousePoint(container, touch); } } }; d3.behavior.drag = function() { var event = d3_eventDispatch(drag, "drag", "dragstart", "dragend"), origin = null, mousedown = dragstart(d3_noop, d3.mouse, d3_window, "mousemove", "mouseup"), touchstart = dragstart(d3_behavior_dragTouchId, d3.touch, d3_identity, "touchmove", "touchend"); function drag() { this.on("mousedown.drag", mousedown).on("touchstart.drag", touchstart); } function dragstart(id, position, subject, move, end) { return function() { var that = this, target = d3.event.target, parent = that.parentNode, dispatch = event.of(that, arguments), dragged = 0, dragId = id(), dragName = ".drag" + (dragId == null ? "" : "-" + dragId), dragOffset, dragSubject = d3.select(subject(target)).on(move + dragName, moved).on(end + dragName, ended), dragRestore = d3_event_dragSuppress(target), position0 = position(parent, dragId); if (origin) { dragOffset = origin.apply(that, arguments); dragOffset = [ dragOffset.x - position0[0], dragOffset.y - position0[1] ]; } else { dragOffset = [ 0, 0 ]; } dispatch({ type: "dragstart" }); function moved() { var position1 = position(parent, dragId), dx, dy; if (!position1) return; dx = position1[0] - position0[0]; dy = position1[1] - position0[1]; dragged |= dx | dy; position0 = position1; dispatch({ type: "drag", x: position1[0] + dragOffset[0], y: position1[1] + dragOffset[1], dx: dx, dy: dy }); } function ended() { if (!position(parent, dragId)) return; dragSubject.on(move + dragName, null).on(end + dragName, null); dragRestore(dragged); dispatch({ type: "dragend" }); } }; } drag.origin = function(x) { if (!arguments.length) return origin; origin = x; return drag; }; return d3.rebind(drag, event, "on"); }; function d3_behavior_dragTouchId() { return d3.event.changedTouches[0].identifier; } d3.touches = function(container, touches) { if (arguments.length < 2) touches = d3_eventSource().touches; return touches ? d3_array(touches).map(function(touch) { var point = d3_mousePoint(container, touch); point.identifier = touch.identifier; return point; }) : []; }; var ε = 1e-6, ε2 = ε * ε, π = Math.PI, τ = 2 * π, τε = τ - ε, halfπ = π / 2, d3_radians = π / 180, d3_degrees = 180 / π; function d3_sgn(x) { return x > 0 ? 1 : x < 0 ? -1 : 0; } function d3_cross2d(a, b, c) { return (b[0] - a[0]) * (c[1] - a[1]) - (b[1] - a[1]) * (c[0] - a[0]); } function d3_acos(x) { return x > 1 ? 0 : x < -1 ? π : Math.acos(x); } function d3_asin(x) { return x > 1 ? halfπ : x < -1 ? -halfπ : Math.asin(x); } function d3_sinh(x) { return ((x = Math.exp(x)) - 1 / x) / 2; } function d3_cosh(x) { return ((x = Math.exp(x)) + 1 / x) / 2; } function d3_tanh(x) { return ((x = Math.exp(2 * x)) - 1) / (x + 1); } function d3_haversin(x) { return (x = Math.sin(x / 2)) * x; } var ρ = Math.SQRT2, ρ2 = 2, ρ4 = 4; d3.interpolateZoom = function(p0, p1) { var ux0 = p0[0], uy0 = p0[1], w0 = p0[2], ux1 = p1[0], uy1 = p1[1], w1 = p1[2], dx = ux1 - ux0, dy = uy1 - uy0, d2 = dx * dx + dy * dy, i, S; if (d2 < ε2) { S = Math.log(w1 / w0) / ρ; i = function(t) { return [ ux0 + t * dx, uy0 + t * dy, w0 * Math.exp(ρ * t * S) ]; }; } else { var d1 = Math.sqrt(d2), b0 = (w1 * w1 - w0 * w0 + ρ4 * d2) / (2 * w0 * ρ2 * d1), b1 = (w1 * w1 - w0 * w0 - ρ4 * d2) / (2 * w1 * ρ2 * d1), r0 = Math.log(Math.sqrt(b0 * b0 + 1) - b0), r1 = Math.log(Math.sqrt(b1 * b1 + 1) - b1); S = (r1 - r0) / ρ; i = function(t) { var s = t * S, coshr0 = d3_cosh(r0), u = w0 / (ρ2 * d1) * (coshr0 * d3_tanh(ρ * s + r0) - d3_sinh(r0)); return [ ux0 + u * dx, uy0 + u * dy, w0 * coshr0 / d3_cosh(ρ * s + r0) ]; }; } i.duration = S * 1e3; return i; }; d3.behavior.zoom = function() { var view = { x: 0, y: 0, k: 1 }, translate0, center0, center, size = [ 960, 500 ], scaleExtent = d3_behavior_zoomInfinity, duration = 250, zooming = 0, mousedown = "mousedown.zoom", mousemove = "mousemove.zoom", mouseup = "mouseup.zoom", mousewheelTimer, touchstart = "touchstart.zoom", touchtime, event = d3_eventDispatch(zoom, "zoomstart", "zoom", "zoomend"), x0, x1, y0, y1; if (!d3_behavior_zoomWheel) { d3_behavior_zoomWheel = "onwheel" in d3_document ? (d3_behavior_zoomDelta = function() { return -d3.event.deltaY * (d3.event.deltaMode ? 120 : 1); }, "wheel") : "onmousewheel" in d3_document ? (d3_behavior_zoomDelta = function() { return d3.event.wheelDelta; }, "mousewheel") : (d3_behavior_zoomDelta = function() { return -d3.event.detail; }, "MozMousePixelScroll"); } function zoom(g) { g.on(mousedown, mousedowned).on(d3_behavior_zoomWheel + ".zoom", mousewheeled).on("dblclick.zoom", dblclicked).on(touchstart, touchstarted); } zoom.event = function(g) { g.each(function() { var dispatch = event.of(this, arguments), view1 = view; if (d3_transitionInheritId) { d3.select(this).transition().each("start.zoom", function() { view = this.__chart__ || { x: 0, y: 0, k: 1 }; zoomstarted(dispatch); }).tween("zoom:zoom", function() { var dx = size[0], dy = size[1], cx = center0 ? center0[0] : dx / 2, cy = center0 ? center0[1] : dy / 2, i = d3.interpolateZoom([ (cx - view.x) / view.k, (cy - view.y) / view.k, dx / view.k ], [ (cx - view1.x) / view1.k, (cy - view1.y) / view1.k, dx / view1.k ]); return function(t) { var l = i(t), k = dx / l[2]; this.__chart__ = view = { x: cx - l[0] * k, y: cy - l[1] * k, k: k }; zoomed(dispatch); }; }).each("interrupt.zoom", function() { zoomended(dispatch); }).each("end.zoom", function() { zoomended(dispatch); }); } else { this.__chart__ = view; zoomstarted(dispatch); zoomed(dispatch); zoomended(dispatch); } }); }; zoom.translate = function(_) { if (!arguments.length) return [ view.x, view.y ]; view = { x: +_[0], y: +_[1], k: view.k }; rescale(); return zoom; }; zoom.scale = function(_) { if (!arguments.length) return view.k; view = { x: view.x, y: view.y, k: null }; scaleTo(+_); rescale(); return zoom; }; zoom.scaleExtent = function(_) { if (!arguments.length) return scaleExtent; scaleExtent = _ == null ? d3_behavior_zoomInfinity : [ +_[0], +_[1] ]; return zoom; }; zoom.center = function(_) { if (!arguments.length) return center; center = _ && [ +_[0], +_[1] ]; return zoom; }; zoom.size = function(_) { if (!arguments.length) return size; size = _ && [ +_[0], +_[1] ]; return zoom; }; zoom.duration = function(_) { if (!arguments.length) return duration; duration = +_; return zoom; }; zoom.x = function(z) { if (!arguments.length) return x1; x1 = z; x0 = z.copy(); view = { x: 0, y: 0, k: 1 }; return zoom; }; zoom.y = function(z) { if (!arguments.length) return y1; y1 = z; y0 = z.copy(); view = { x: 0, y: 0, k: 1 }; return zoom; }; function location(p) { return [ (p[0] - view.x) / view.k, (p[1] - view.y) / view.k ]; } function point(l) { return [ l[0] * view.k + view.x, l[1] * view.k + view.y ]; } function scaleTo(s) { view.k = Math.max(scaleExtent[0], Math.min(scaleExtent[1], s)); } function translateTo(p, l) { l = point(l); view.x += p[0] - l[0]; view.y += p[1] - l[1]; } function zoomTo(that, p, l, k) { that.__chart__ = { x: view.x, y: view.y, k: view.k }; scaleTo(Math.pow(2, k)); translateTo(center0 = p, l); that = d3.select(that); if (duration > 0) that = that.transition().duration(duration); that.call(zoom.event); } function rescale() { if (x1) x1.domain(x0.range().map(function(x) { return (x - view.x) / view.k; }).map(x0.invert)); if (y1) y1.domain(y0.range().map(function(y) { return (y - view.y) / view.k; }).map(y0.invert)); } function zoomstarted(dispatch) { if (!zooming++) dispatch({ type: "zoomstart" }); } function zoomed(dispatch) { rescale(); dispatch({ type: "zoom", scale: view.k, translate: [ view.x, view.y ] }); } function zoomended(dispatch) { if (!--zooming) dispatch({ type: "zoomend" }), center0 = null; } function mousedowned() { var that = this, dispatch = event.of(that, arguments), dragged = 0, subject = d3.select(d3_window(that)).on(mousemove, moved).on(mouseup, ended), location0 = location(d3.mouse(that)), dragRestore = d3_event_dragSuppress(that); d3_selection_interrupt.call(that); zoomstarted(dispatch); function moved() { dragged = 1; translateTo(d3.mouse(that), location0); zoomed(dispatch); } function ended() { subject.on(mousemove, null).on(mouseup, null); dragRestore(dragged); zoomended(dispatch); } } function touchstarted() { var that = this, dispatch = event.of(that, arguments), locations0 = {}, distance0 = 0, scale0, zoomName = ".zoom-" + d3.event.changedTouches[0].identifier, touchmove = "touchmove" + zoomName, touchend = "touchend" + zoomName, targets = [], subject = d3.select(that), dragRestore = d3_event_dragSuppress(that); started(); zoomstarted(dispatch); subject.on(mousedown, null).on(touchstart, started); function relocate() { var touches = d3.touches(that); scale0 = view.k; touches.forEach(function(t) { if (t.identifier in locations0) locations0[t.identifier] = location(t); }); return touches; } function started() { var target = d3.event.target; d3.select(target).on(touchmove, moved).on(touchend, ended); targets.push(target); var changed = d3.event.changedTouches; for (var i = 0, n = changed.length; i < n; ++i) { locations0[changed[i].identifier] = null; } var touches = relocate(), now = Date.now(); if (touches.length === 1) { if (now - touchtime < 500) { var p = touches[0]; zoomTo(that, p, locations0[p.identifier], Math.floor(Math.log(view.k) / Math.LN2) + 1); d3_eventPreventDefault(); } touchtime = now; } else if (touches.length > 1) { var p = touches[0], q = touches[1], dx = p[0] - q[0], dy = p[1] - q[1]; distance0 = dx * dx + dy * dy; } } function moved() { var touches = d3.touches(that), p0, l0, p1, l1; d3_selection_interrupt.call(that); for (var i = 0, n = touches.length; i < n; ++i, l1 = null) { p1 = touches[i]; if (l1 = locations0[p1.identifier]) { if (l0) break; p0 = p1, l0 = l1; } } if (l1) { var distance1 = (distance1 = p1[0] - p0[0]) * distance1 + (distance1 = p1[1] - p0[1]) * distance1, scale1 = distance0 && Math.sqrt(distance1 / distance0); p0 = [ (p0[0] + p1[0]) / 2, (p0[1] + p1[1]) / 2 ]; l0 = [ (l0[0] + l1[0]) / 2, (l0[1] + l1[1]) / 2 ]; scaleTo(scale1 * scale0); } touchtime = null; translateTo(p0, l0); zoomed(dispatch); } function ended() { if (d3.event.touches.length) { var changed = d3.event.changedTouches; for (var i = 0, n = changed.length; i < n; ++i) { delete locations0[changed[i].identifier]; } for (var identifier in locations0) { return void relocate(); } } d3.selectAll(targets).on(zoomName, null); subject.on(mousedown, mousedowned).on(touchstart, touchstarted); dragRestore(); zoomended(dispatch); } } function mousewheeled() { var dispatch = event.of(this, arguments); if (mousewheelTimer) clearTimeout(mousewheelTimer); else d3_selection_interrupt.call(this), translate0 = location(center0 = center || d3.mouse(this)), zoomstarted(dispatch); mousewheelTimer = setTimeout(function() { mousewheelTimer = null; zoomended(dispatch); }, 50); d3_eventPreventDefault(); scaleTo(Math.pow(2, d3_behavior_zoomDelta() * .002) * view.k); translateTo(center0, translate0); zoomed(dispatch); } function dblclicked() { var p = d3.mouse(this), k = Math.log(view.k) / Math.LN2; zoomTo(this, p, location(p), d3.event.shiftKey ? Math.ceil(k) - 1 : Math.floor(k) + 1); } return d3.rebind(zoom, event, "on"); }; var d3_behavior_zoomInfinity = [ 0, Infinity ], d3_behavior_zoomDelta, d3_behavior_zoomWheel; d3.color = d3_color; function d3_color() {} d3_color.prototype.toString = function() { return this.rgb() + ""; }; d3.hsl = d3_hsl; function d3_hsl(h, s, l) { return this instanceof d3_hsl ? void (this.h = +h, this.s = +s, this.l = +l) : arguments.length < 2 ? h instanceof d3_hsl ? new d3_hsl(h.h, h.s, h.l) : d3_rgb_parse("" + h, d3_rgb_hsl, d3_hsl) : new d3_hsl(h, s, l); } var d3_hslPrototype = d3_hsl.prototype = new d3_color(); d3_hslPrototype.brighter = function(k) { k = Math.pow(.7, arguments.length ? k : 1); return new d3_hsl(this.h, this.s, this.l / k); }; d3_hslPrototype.darker = function(k) { k = Math.pow(.7, arguments.length ? k : 1); return new d3_hsl(this.h, this.s, k * this.l); }; d3_hslPrototype.rgb = function() { return d3_hsl_rgb(this.h, this.s, this.l); }; function d3_hsl_rgb(h, s, l) { var m1, m2; h = isNaN(h) ? 0 : (h %= 360) < 0 ? h + 360 : h; s = isNaN(s) ? 0 : s < 0 ? 0 : s > 1 ? 1 : s; l = l < 0 ? 0 : l > 1 ? 1 : l; m2 = l <= .5 ? l * (1 + s) : l + s - l * s; m1 = 2 * l - m2; function v(h) { if (h > 360) h -= 360; else if (h < 0) h += 360; if (h < 60) return m1 + (m2 - m1) * h / 60; if (h < 180) return m2; if (h < 240) return m1 + (m2 - m1) * (240 - h) / 60; return m1; } function vv(h) { return Math.round(v(h) * 255); } return new d3_rgb(vv(h + 120), vv(h), vv(h - 120)); } d3.hcl = d3_hcl; function d3_hcl(h, c, l) { return this instanceof d3_hcl ? void (this.h = +h, this.c = +c, this.l = +l) : arguments.length < 2 ? h instanceof d3_hcl ? new d3_hcl(h.h, h.c, h.l) : h instanceof d3_lab ? d3_lab_hcl(h.l, h.a, h.b) : d3_lab_hcl((h = d3_rgb_lab((h = d3.rgb(h)).r, h.g, h.b)).l, h.a, h.b) : new d3_hcl(h, c, l); } var d3_hclPrototype = d3_hcl.prototype = new d3_color(); d3_hclPrototype.brighter = function(k) { return new d3_hcl(this.h, this.c, Math.min(100, this.l + d3_lab_K * (arguments.length ? k : 1))); }; d3_hclPrototype.darker = function(k) { return new d3_hcl(this.h, this.c, Math.max(0, this.l - d3_lab_K * (arguments.length ? k : 1))); }; d3_hclPrototype.rgb = function() { return d3_hcl_lab(this.h, this.c, this.l).rgb(); }; function d3_hcl_lab(h, c, l) { if (isNaN(h)) h = 0; if (isNaN(c)) c = 0; return new d3_lab(l, Math.cos(h *= d3_radians) * c, Math.sin(h) * c); } d3.lab = d3_lab; function d3_lab(l, a, b) { return this instanceof d3_lab ? void (this.l = +l, this.a = +a, this.b = +b) : arguments.length < 2 ? l instanceof d3_lab ? new d3_lab(l.l, l.a, l.b) : l instanceof d3_hcl ? d3_hcl_lab(l.h, l.c, l.l) : d3_rgb_lab((l = d3_rgb(l)).r, l.g, l.b) : new d3_lab(l, a, b); } var d3_lab_K = 18; var d3_lab_X = .95047, d3_lab_Y = 1, d3_lab_Z = 1.08883; var d3_labPrototype = d3_lab.prototype = new d3_color(); d3_labPrototype.brighter = function(k) { return new d3_lab(Math.min(100, this.l + d3_lab_K * (arguments.length ? k : 1)), this.a, this.b); }; d3_labPrototype.darker = function(k) { return new d3_lab(Math.max(0, this.l - d3_lab_K * (arguments.length ? k : 1)), this.a, this.b); }; d3_labPrototype.rgb = function() { return d3_lab_rgb(this.l, this.a, this.b); }; function d3_lab_rgb(l, a, b) { var y = (l + 16) / 116, x = y + a / 500, z = y - b / 200; x = d3_lab_xyz(x) * d3_lab_X; y = d3_lab_xyz(y) * d3_lab_Y; z = d3_lab_xyz(z) * d3_lab_Z; return new d3_rgb(d3_xyz_rgb(3.2404542 * x - 1.5371385 * y - .4985314 * z), d3_xyz_rgb(-.969266 * x + 1.8760108 * y + .041556 * z), d3_xyz_rgb(.0556434 * x - .2040259 * y + 1.0572252 * z)); } function d3_lab_hcl(l, a, b) { return l > 0 ? new d3_hcl(Math.atan2(b, a) * d3_degrees, Math.sqrt(a * a + b * b), l) : new d3_hcl(NaN, NaN, l); } function d3_lab_xyz(x) { return x > .206893034 ? x * x * x : (x - 4 / 29) / 7.787037; } function d3_xyz_lab(x) { return x > .008856 ? Math.pow(x, 1 / 3) : 7.787037 * x + 4 / 29; } function d3_xyz_rgb(r) { return Math.round(255 * (r <= .00304 ? 12.92 * r : 1.055 * Math.pow(r, 1 / 2.4) - .055)); } d3.rgb = d3_rgb; function d3_rgb(r, g, b) { return this instanceof d3_rgb ? void (this.r = ~~r, this.g = ~~g, this.b = ~~b) : arguments.length < 2 ? r instanceof d3_rgb ? new d3_rgb(r.r, r.g, r.b) : d3_rgb_parse("" + r, d3_rgb, d3_hsl_rgb) : new d3_rgb(r, g, b); } function d3_rgbNumber(value) { return new d3_rgb(value >> 16, value >> 8 & 255, value & 255); } function d3_rgbString(value) { return d3_rgbNumber(value) + ""; } var d3_rgbPrototype = d3_rgb.prototype = new d3_color(); d3_rgbPrototype.brighter = function(k) { k = Math.pow(.7, arguments.length ? k : 1); var r = this.r, g = this.g, b = this.b, i = 30; if (!r && !g && !b) return new d3_rgb(i, i, i); if (r && r < i) r = i; if (g && g < i) g = i; if (b && b < i) b = i; return new d3_rgb(Math.min(255, r / k), Math.min(255, g / k), Math.min(255, b / k)); }; d3_rgbPrototype.darker = function(k) { k = Math.pow(.7, arguments.length ? k : 1); return new d3_rgb(k * this.r, k * this.g, k * this.b); }; d3_rgbPrototype.hsl = function() { return d3_rgb_hsl(this.r, this.g, this.b); }; d3_rgbPrototype.toString = function() { return "#" + d3_rgb_hex(this.r) + d3_rgb_hex(this.g) + d3_rgb_hex(this.b); }; function d3_rgb_hex(v) { return v < 16 ? "0" + Math.max(0, v).toString(16) : Math.min(255, v).toString(16); } function d3_rgb_parse(format, rgb, hsl) { var r = 0, g = 0, b = 0, m1, m2, color; m1 = /([a-z]+)\((.*)\)/.exec(format = format.toLowerCase()); if (m1) { m2 = m1[2].split(","); switch (m1[1]) { case "hsl": { return hsl(parseFloat(m2[0]), parseFloat(m2[1]) / 100, parseFloat(m2[2]) / 100); } case "rgb": { return rgb(d3_rgb_parseNumber(m2[0]), d3_rgb_parseNumber(m2[1]), d3_rgb_parseNumber(m2[2])); } } } if (color = d3_rgb_names.get(format)) { return rgb(color.r, color.g, color.b); } if (format != null && format.charAt(0) === "#" && !isNaN(color = parseInt(format.slice(1), 16))) { if (format.length === 4) { r = (color & 3840) >> 4; r = r >> 4 | r; g = color & 240; g = g >> 4 | g; b = color & 15; b = b << 4 | b; } else if (format.length === 7) { r = (color & 16711680) >> 16; g = (color & 65280) >> 8; b = color & 255; } } return rgb(r, g, b); } function d3_rgb_hsl(r, g, b) { var min = Math.min(r /= 255, g /= 255, b /= 255), max = Math.max(r, g, b), d = max - min, h, s, l = (max + min) / 2; if (d) { s = l < .5 ? d / (max + min) : d / (2 - max - min); if (r == max) h = (g - b) / d + (g < b ? 6 : 0); else if (g == max) h = (b - r) / d + 2; else h = (r - g) / d + 4; h *= 60; } else { h = NaN; s = l > 0 && l < 1 ? 0 : h; } return new d3_hsl(h, s, l); } function d3_rgb_lab(r, g, b) { r = d3_rgb_xyz(r); g = d3_rgb_xyz(g); b = d3_rgb_xyz(b); var x = d3_xyz_lab((.4124564 * r + .3575761 * g + .1804375 * b) / d3_lab_X), y = d3_xyz_lab((.2126729 * r + .7151522 * g + .072175 * b) / d3_lab_Y), z = d3_xyz_lab((.0193339 * r + .119192 * g + .9503041 * b) / d3_lab_Z); return d3_lab(116 * y - 16, 500 * (x - y), 200 * (y - z)); } function d3_rgb_xyz(r) { return (r /= 255) <= .04045 ? r / 12.92 : Math.pow((r + .055) / 1.055, 2.4); } function d3_rgb_parseNumber(c) { var f = parseFloat(c); return c.charAt(c.length - 1) === "%" ? Math.round(f * 2.55) : f; } var d3_rgb_names = d3.map({ aliceblue: 15792383, antiquewhite: 16444375, aqua: 65535, aquamarine: 8388564, azure: 15794175, beige: 16119260, bisque: 16770244, black: 0, blanchedalmond: 16772045, blue: 255, blueviolet: 9055202, brown: 10824234, burlywood: 14596231, cadetblue: 6266528, chartreuse: 8388352, chocolate: 13789470, coral: 16744272, cornflowerblue: 6591981, cornsilk: 16775388, crimson: 14423100, cyan: 65535, darkblue: 139, darkcyan: 35723, darkgoldenrod: 12092939, darkgray: 11119017, darkgreen: 25600, darkgrey: 11119017, darkkhaki: 12433259, darkmagenta: 9109643, darkolivegreen: 5597999, darkorange: 16747520, darkorchid: 10040012, darkred: 9109504, darksalmon: 15308410, darkseagreen: 9419919, darkslateblue: 4734347, darkslategray: 3100495, darkslategrey: 3100495, darkturquoise: 52945, darkviolet: 9699539, deeppink: 16716947, deepskyblue: 49151, dimgray: 6908265, dimgrey: 6908265, dodgerblue: 2003199, firebrick: 11674146, floralwhite: 16775920, forestgreen: 2263842, fuchsia: 16711935, gainsboro: 14474460, ghostwhite: 16316671, gold: 16766720, goldenrod: 14329120, gray: 8421504, green: 32768, greenyellow: 11403055, grey: 8421504, honeydew: 15794160, hotpink: 16738740, indianred: 13458524, indigo: 4915330, ivory: 16777200, khaki: 15787660, lavender: 15132410, lavenderblush: 16773365, lawngreen: 8190976, lemonchiffon: 16775885, lightblue: 11393254, lightcoral: 15761536, lightcyan: 14745599, lightgoldenrodyellow: 16448210, lightgray: 13882323, lightgreen: 9498256, lightgrey: 13882323, lightpink: 16758465, lightsalmon: 16752762, lightseagreen: 2142890, lightskyblue: 8900346, lightslategray: 7833753, lightslategrey: 7833753, lightsteelblue: 11584734, lightyellow: 16777184, lime: 65280, limegreen: 3329330, linen: 16445670, magenta: 16711935, maroon: 8388608, mediumaquamarine: 6737322, mediumblue: 205, mediumorchid: 12211667, mediumpurple: 9662683, mediumseagreen: 3978097, mediumslateblue: 8087790, mediumspringgreen: 64154, mediumturquoise: 4772300, mediumvioletred: 13047173, midnightblue: 1644912, mintcream: 16121850, mistyrose: 16770273, moccasin: 16770229, navajowhite: 16768685, navy: 128, oldlace: 16643558, olive: 8421376, olivedrab: 7048739, orange: 16753920, orangered: 16729344, orchid: 14315734, palegoldenrod: 15657130, palegreen: 10025880, paleturquoise: 11529966, palevioletred: 14381203, papayawhip: 16773077, peachpuff: 16767673, peru: 13468991, pink: 16761035, plum: 14524637, powderblue: 11591910, purple: 8388736, rebeccapurple: 6697881, red: 16711680, rosybrown: 12357519, royalblue: 4286945, saddlebrown: 9127187, salmon: 16416882, sandybrown: 16032864, seagreen: 3050327, seashell: 16774638, sienna: 10506797, silver: 12632256, skyblue: 8900331, slateblue: 6970061, slategray: 7372944, slategrey: 7372944, snow: 16775930, springgreen: 65407, steelblue: 4620980, tan: 13808780, teal: 32896, thistle: 14204888, tomato: 16737095, turquoise: 4251856, violet: 15631086, wheat: 16113331, white: 16777215, whitesmoke: 16119285, yellow: 16776960, yellowgreen: 10145074 }); d3_rgb_names.forEach(function(key, value) { d3_rgb_names.set(key, d3_rgbNumber(value)); }); function d3_functor(v) { return typeof v === "function" ? v : function() { return v; }; } d3.functor = d3_functor; d3.xhr = d3_xhrType(d3_identity); function d3_xhrType(response) { return function(url, mimeType, callback) { if (arguments.length === 2 && typeof mimeType === "function") callback = mimeType, mimeType = null; return d3_xhr(url, mimeType, response, callback); }; } function d3_xhr(url, mimeType, response, callback) { var xhr = {}, dispatch = d3.dispatch("beforesend", "progress", "load", "error"), headers = {}, request = new XMLHttpRequest(), responseType = null; if (this.XDomainRequest && !("withCredentials" in request) && /^(http(s)?:)?\/\//.test(url)) request = new XDomainRequest(); "onload" in request ? request.onload = request.onerror = respond : request.onreadystatechange = function() { request.readyState > 3 && respond(); }; function respond() { var status = request.status, result; if (!status && d3_xhrHasResponse(request) || status >= 200 && status < 300 || status === 304) { try { result = response.call(xhr, request); } catch (e) { dispatch.error.call(xhr, e); return; } dispatch.load.call(xhr, result); } else { dispatch.error.call(xhr, request); } } request.onprogress = function(event) { var o = d3.event; d3.event = event; try { dispatch.progress.call(xhr, request); } finally { d3.event = o; } }; xhr.header = function(name, value) { name = (name + "").toLowerCase(); if (arguments.length < 2) return headers[name]; if (value == null) delete headers[name]; else headers[name] = value + ""; return xhr; }; xhr.mimeType = function(value) { if (!arguments.length) return mimeType; mimeType = value == null ? null : value + ""; return xhr; }; xhr.responseType = function(value) { if (!arguments.length) return responseType; responseType = value; return xhr; }; xhr.response = function(value) { response = value; return xhr; }; [ "get", "post" ].forEach(function(method) { xhr[method] = function() { return xhr.send.apply(xhr, [ method ].concat(d3_array(arguments))); }; }); xhr.send = function(method, data, callback) { if (arguments.length === 2 && typeof data === "function") callback = data, data = null; request.open(method, url, true); if (mimeType != null && !("accept" in headers)) headers["accept"] = mimeType + ",*/*"; if (request.setRequestHeader) for (var name in headers) request.setRequestHeader(name, headers[name]); if (mimeType != null && request.overrideMimeType) request.overrideMimeType(mimeType); if (responseType != null) request.responseType = responseType; if (callback != null) xhr.on("error", callback).on("load", function(request) { callback(null, request); }); dispatch.beforesend.call(xhr, request); request.send(data == null ? null : data); return xhr; }; xhr.abort = function() { request.abort(); return xhr; }; d3.rebind(xhr, dispatch, "on"); return callback == null ? xhr : xhr.get(d3_xhr_fixCallback(callback)); } function d3_xhr_fixCallback(callback) { return callback.length === 1 ? function(error, request) { callback(error == null ? request : null); } : callback; } function d3_xhrHasResponse(request) { var type = request.responseType; return type && type !== "text" ? request.response : request.responseText; } d3.dsv = function(delimiter, mimeType) { var reFormat = new RegExp('["' + delimiter + "\n]"), delimiterCode = delimiter.charCodeAt(0); function dsv(url, row, callback) { if (arguments.length < 3) callback = row, row = null; var xhr = d3_xhr(url, mimeType, row == null ? response : typedResponse(row), callback); xhr.row = function(_) { return arguments.length ? xhr.response((row = _) == null ? response : typedResponse(_)) : row; }; return xhr; } function response(request) { return dsv.parse(request.responseText); } function typedResponse(f) { return function(request) { return dsv.parse(request.responseText, f); }; } dsv.parse = function(text, f) { var o; return dsv.parseRows(text, function(row, i) { if (o) return o(row, i - 1); var a = new Function("d", "return {" + row.map(function(name, i) { return JSON.stringify(name) + ": d[" + i + "]"; }).join(",") + "}"); o = f ? function(row, i) { return f(a(row), i); } : a; }); }; dsv.parseRows = function(text, f) { var EOL = {}, EOF = {}, rows = [], N = text.length, I = 0, n = 0, t, eol; function token() { if (I >= N) return EOF; if (eol) return eol = false, EOL; var j = I; if (text.charCodeAt(j) === 34) { var i = j; while (i++ < N) { if (text.charCodeAt(i) === 34) { if (text.charCodeAt(i + 1) !== 34) break; ++i; } } I = i + 2; var c = text.charCodeAt(i + 1); if (c === 13) { eol = true; if (text.charCodeAt(i + 2) === 10) ++I; } else if (c === 10) { eol = true; } return text.slice(j + 1, i).replace(/""/g, '"'); } while (I < N) { var c = text.charCodeAt(I++), k = 1; if (c === 10) eol = true; else if (c === 13) { eol = true; if (text.charCodeAt(I) === 10) ++I, ++k; } else if (c !== delimiterCode) continue; return text.slice(j, I - k); } return text.slice(j); } while ((t = token()) !== EOF) { var a = []; while (t !== EOL && t !== EOF) { a.push(t); t = token(); } if (f && (a = f(a, n++)) == null) continue; rows.push(a); } return rows; }; dsv.format = function(rows) { if (Array.isArray(rows[0])) return dsv.formatRows(rows); var fieldSet = new d3_Set(), fields = []; rows.forEach(function(row) { for (var field in row) { if (!fieldSet.has(field)) { fields.push(fieldSet.add(field)); } } }); return [ fields.map(formatValue).join(delimiter) ].concat(rows.map(function(row) { return fields.map(function(field) { return formatValue(row[field]); }).join(delimiter); })).join("\n"); }; dsv.formatRows = function(rows) { return rows.map(formatRow).join("\n"); }; function formatRow(row) { return row.map(formatValue).join(delimiter); } function formatValue(text) { return reFormat.test(text) ? '"' + text.replace(/\"/g, '""') + '"' : text; } return dsv; }; d3.csv = d3.dsv(",", "text/csv"); d3.tsv = d3.dsv(" ", "text/tab-separated-values"); var d3_timer_queueHead, d3_timer_queueTail, d3_timer_interval, d3_timer_timeout, d3_timer_frame = this[d3_vendorSymbol(this, "requestAnimationFrame")] || function(callback) { setTimeout(callback, 17); }; d3.timer = function() { d3_timer.apply(this, arguments); }; function d3_timer(callback, delay, then) { var n = arguments.length; if (n < 2) delay = 0; if (n < 3) then = Date.now(); var time = then + delay, timer = { c: callback, t: time, n: null }; if (d3_timer_queueTail) d3_timer_queueTail.n = timer; else d3_timer_queueHead = timer; d3_timer_queueTail = timer; if (!d3_timer_interval) { d3_timer_timeout = clearTimeout(d3_timer_timeout); d3_timer_interval = 1; d3_timer_frame(d3_timer_step); } return timer; } function d3_timer_step() { var now = d3_timer_mark(), delay = d3_timer_sweep() - now; if (delay > 24) { if (isFinite(delay)) { clearTimeout(d3_timer_timeout); d3_timer_timeout = setTimeout(d3_timer_step, delay); } d3_timer_interval = 0; } else { d3_timer_interval = 1; d3_timer_frame(d3_timer_step); } } d3.timer.flush = function() { d3_timer_mark(); d3_timer_sweep(); }; function d3_timer_mark() { var now = Date.now(), timer = d3_timer_queueHead; while (timer) { if (now >= timer.t && timer.c(now - timer.t)) timer.c = null; timer = timer.n; } return now; } function d3_timer_sweep() { var t0, t1 = d3_timer_queueHead, time = Infinity; while (t1) { if (t1.c) { if (t1.t < time) time = t1.t; t1 = (t0 = t1).n; } else { t1 = t0 ? t0.n = t1.n : d3_timer_queueHead = t1.n; } } d3_timer_queueTail = t0; return time; } function d3_format_precision(x, p) { return p - (x ? Math.ceil(Math.log(x) / Math.LN10) : 1); } d3.round = function(x, n) { return n ? Math.round(x * (n = Math.pow(10, n))) / n : Math.round(x); }; var d3_formatPrefixes = [ "y", "z", "a", "f", "p", "n", "µ", "m", "", "k", "M", "G", "T", "P", "E", "Z", "Y" ].map(d3_formatPrefix); d3.formatPrefix = function(value, precision) { var i = 0; if (value = +value) { if (value < 0) value *= -1; if (precision) value = d3.round(value, d3_format_precision(value, precision)); i = 1 + Math.floor(1e-12 + Math.log(value) / Math.LN10); i = Math.max(-24, Math.min(24, Math.floor((i - 1) / 3) * 3)); } return d3_formatPrefixes[8 + i / 3]; }; function d3_formatPrefix(d, i) { var k = Math.pow(10, abs(8 - i) * 3); return { scale: i > 8 ? function(d) { return d / k; } : function(d) { return d * k; }, symbol: d }; } function d3_locale_numberFormat(locale) { var locale_decimal = locale.decimal, locale_thousands = locale.thousands, locale_grouping = locale.grouping, locale_currency = locale.currency, formatGroup = locale_grouping && locale_thousands ? function(value, width) { var i = value.length, t = [], j = 0, g = locale_grouping[0], length = 0; while (i > 0 && g > 0) { if (length + g + 1 > width) g = Math.max(1, width - length); t.push(value.substring(i -= g, i + g)); if ((length += g + 1) > width) break; g = locale_grouping[j = (j + 1) % locale_grouping.length]; } return t.reverse().join(locale_thousands); } : d3_identity; return function(specifier) { var match = d3_format_re.exec(specifier), fill = match[1] || " ", align = match[2] || ">", sign = match[3] || "-", symbol = match[4] || "", zfill = match[5], width = +match[6], comma = match[7], precision = match[8], type = match[9], scale = 1, prefix = "", suffix = "", integer = false, exponent = true; if (precision) precision = +precision.substring(1); if (zfill || fill === "0" && align === "=") { zfill = fill = "0"; align = "="; } switch (type) { case "n": comma = true; type = "g"; break; case "%": scale = 100; suffix = "%"; type = "f"; break; case "p": scale = 100; suffix = "%"; type = "r"; break; case "b": case "o": case "x": case "X": if (symbol === "#") prefix = "0" + type.toLowerCase(); case "c": exponent = false; case "d": integer = true; precision = 0; break; case "s": scale = -1; type = "r"; break; } if (symbol === "$") prefix = locale_currency[0], suffix = locale_currency[1]; if (type == "r" && !precision) type = "g"; if (precision != null) { if (type == "g") precision = Math.max(1, Math.min(21, precision)); else if (type == "e" || type == "f") precision = Math.max(0, Math.min(20, precision)); } type = d3_format_types.get(type) || d3_format_typeDefault; var zcomma = zfill && comma; return function(value) { var fullSuffix = suffix; if (integer && value % 1) return ""; var negative = value < 0 || value === 0 && 1 / value < 0 ? (value = -value, "-") : sign === "-" ? "" : sign; if (scale < 0) { var unit = d3.formatPrefix(value, precision); value = unit.scale(value); fullSuffix = unit.symbol + suffix; } else { value *= scale; } value = type(value, precision); var i = value.lastIndexOf("."), before, after; if (i < 0) { var j = exponent ? value.lastIndexOf("e") : -1; if (j < 0) before = value, after = ""; else before = value.substring(0, j), after = value.substring(j); } else { before = value.substring(0, i); after = locale_decimal + value.substring(i + 1); } if (!zfill && comma) before = formatGroup(before, Infinity); var length = prefix.length + before.length + after.length + (zcomma ? 0 : negative.length), padding = length < width ? new Array(length = width - length + 1).join(fill) : ""; if (zcomma) before = formatGroup(padding + before, padding.length ? width - after.length : Infinity); negative += prefix; value = before + after; return (align === "<" ? negative + value + padding : align === ">" ? padding + negative + value : align === "^" ? padding.substring(0, length >>= 1) + negative + value + padding.substring(length) : negative + (zcomma ? value : padding + value)) + fullSuffix; }; }; } var d3_format_re = /(?:([^{])?([<>=^]))?([+\- ])?([$#])?(0)?(\d+)?(,)?(\.-?\d+)?([a-z%])?/i; var d3_format_types = d3.map({ b: function(x) { return x.toString(2); }, c: function(x) { return String.fromCharCode(x); }, o: function(x) { return x.toString(8); }, x: function(x) { return x.toString(16); }, X: function(x) { return x.toString(16).toUpperCase(); }, g: function(x, p) { return x.toPrecision(p); }, e: function(x, p) { return x.toExponential(p); }, f: function(x, p) { return x.toFixed(p); }, r: function(x, p) { return (x = d3.round(x, d3_format_precision(x, p))).toFixed(Math.max(0, Math.min(20, d3_format_precision(x * (1 + 1e-15), p)))); } }); function d3_format_typeDefault(x) { return x + ""; } var d3_time = d3.time = {}, d3_date = Date; function d3_date_utc() { this._ = new Date(arguments.length > 1 ? Date.UTC.apply(this, arguments) : arguments[0]); } d3_date_utc.prototype = { getDate: function() { return this._.getUTCDate(); }, getDay: function() { return this._.getUTCDay(); }, getFullYear: function() { return this._.getUTCFullYear(); }, getHours: function() { return this._.getUTCHours(); }, getMilliseconds: function() { return this._.getUTCMilliseconds(); }, getMinutes: function() { return this._.getUTCMinutes(); }, getMonth: function() { return this._.getUTCMonth(); }, getSeconds: function() { return this._.getUTCSeconds(); }, getTime: function() { return this._.getTime(); }, getTimezoneOffset: function() { return 0; }, valueOf: function() { return this._.valueOf(); }, setDate: function() { d3_time_prototype.setUTCDate.apply(this._, arguments); }, setDay: function() { d3_time_prototype.setUTCDay.apply(this._, arguments); }, setFullYear: function() { d3_time_prototype.setUTCFullYear.apply(this._, arguments); }, setHours: function() { d3_time_prototype.setUTCHours.apply(this._, arguments); }, setMilliseconds: function() { d3_time_prototype.setUTCMilliseconds.apply(this._, arguments); }, setMinutes: function() { d3_time_prototype.setUTCMinutes.apply(this._, arguments); }, setMonth: function() { d3_time_prototype.setUTCMonth.apply(this._, arguments); }, setSeconds: function() { d3_time_prototype.setUTCSeconds.apply(this._, arguments); }, setTime: function() { d3_time_prototype.setTime.apply(this._, arguments); } }; var d3_time_prototype = Date.prototype; function d3_time_interval(local, step, number) { function round(date) { var d0 = local(date), d1 = offset(d0, 1); return date - d0 < d1 - date ? d0 : d1; } function ceil(date) { step(date = local(new d3_date(date - 1)), 1); return date; } function offset(date, k) { step(date = new d3_date(+date), k); return date; } function range(t0, t1, dt) { var time = ceil(t0), times = []; if (dt > 1) { while (time < t1) { if (!(number(time) % dt)) times.push(new Date(+time)); step(time, 1); } } else { while (time < t1) times.push(new Date(+time)), step(time, 1); } return times; } function range_utc(t0, t1, dt) { try { d3_date = d3_date_utc; var utc = new d3_date_utc(); utc._ = t0; return range(utc, t1, dt); } finally { d3_date = Date; } } local.floor = local; local.round = round; local.ceil = ceil; local.offset = offset; local.range = range; var utc = local.utc = d3_time_interval_utc(local); utc.floor = utc; utc.round = d3_time_interval_utc(round); utc.ceil = d3_time_interval_utc(ceil); utc.offset = d3_time_interval_utc(offset); utc.range = range_utc; return local; } function d3_time_interval_utc(method) { return function(date, k) { try { d3_date = d3_date_utc; var utc = new d3_date_utc(); utc._ = date; return method(utc, k)._; } finally { d3_date = Date; } }; } d3_time.year = d3_time_interval(function(date) { date = d3_time.day(date); date.setMonth(0, 1); return date; }, function(date, offset) { date.setFullYear(date.getFullYear() + offset); }, function(date) { return date.getFullYear(); }); d3_time.years = d3_time.year.range; d3_time.years.utc = d3_time.year.utc.range; d3_time.day = d3_time_interval(function(date) { var day = new d3_date(2e3, 0); day.setFullYear(date.getFullYear(), date.getMonth(), date.getDate()); return day; }, function(date, offset) { date.setDate(date.getDate() + offset); }, function(date) { return date.getDate() - 1; }); d3_time.days = d3_time.day.range; d3_time.days.utc = d3_time.day.utc.range; d3_time.dayOfYear = function(date) { var year = d3_time.year(date); return Math.floor((date - year - (date.getTimezoneOffset() - year.getTimezoneOffset()) * 6e4) / 864e5); }; [ "sunday", "monday", "tuesday", "wednesday", "thursday", "friday", "saturday" ].forEach(function(day, i) { i = 7 - i; var interval = d3_time[day] = d3_time_interval(function(date) { (date = d3_time.day(date)).setDate(date.getDate() - (date.getDay() + i) % 7); return date; }, function(date, offset) { date.setDate(date.getDate() + Math.floor(offset) * 7); }, function(date) { var day = d3_time.year(date).getDay(); return Math.floor((d3_time.dayOfYear(date) + (day + i) % 7) / 7) - (day !== i); }); d3_time[day + "s"] = interval.range; d3_time[day + "s"].utc = interval.utc.range; d3_time[day + "OfYear"] = function(date) { var day = d3_time.year(date).getDay(); return Math.floor((d3_time.dayOfYear(date) + (day + i) % 7) / 7); }; }); d3_time.week = d3_time.sunday; d3_time.weeks = d3_time.sunday.range; d3_time.weeks.utc = d3_time.sunday.utc.range; d3_time.weekOfYear = d3_time.sundayOfYear; function d3_locale_timeFormat(locale) { var locale_dateTime = locale.dateTime, locale_date = locale.date, locale_time = locale.time, locale_periods = locale.periods, locale_days = locale.days, locale_shortDays = locale.shortDays, locale_months = locale.months, locale_shortMonths = locale.shortMonths; function d3_time_format(template) { var n = template.length; function format(date) { var string = [], i = -1, j = 0, c, p, f; while (++i < n) { if (template.charCodeAt(i) === 37) { string.push(template.slice(j, i)); if ((p = d3_time_formatPads[c = template.charAt(++i)]) != null) c = template.charAt(++i); if (f = d3_time_formats[c]) c = f(date, p == null ? c === "e" ? " " : "0" : p); string.push(c); j = i + 1; } } string.push(template.slice(j, i)); return string.join(""); } format.parse = function(string) { var d = { y: 1900, m: 0, d: 1, H: 0, M: 0, S: 0, L: 0, Z: null }, i = d3_time_parse(d, template, string, 0); if (i != string.length) return null; if ("p" in d) d.H = d.H % 12 + d.p * 12; var localZ = d.Z != null && d3_date !== d3_date_utc, date = new (localZ ? d3_date_utc : d3_date)(); if ("j" in d) date.setFullYear(d.y, 0, d.j); else if ("W" in d || "U" in d) { if (!("w" in d)) d.w = "W" in d ? 1 : 0; date.setFullYear(d.y, 0, 1); date.setFullYear(d.y, 0, "W" in d ? (d.w + 6) % 7 + d.W * 7 - (date.getDay() + 5) % 7 : d.w + d.U * 7 - (date.getDay() + 6) % 7); } else date.setFullYear(d.y, d.m, d.d); date.setHours(d.H + (d.Z / 100 | 0), d.M + d.Z % 100, d.S, d.L); return localZ ? date._ : date; }; format.toString = function() { return template; }; return format; } function d3_time_parse(date, template, string, j) { var c, p, t, i = 0, n = template.length, m = string.length; while (i < n) { if (j >= m) return -1; c = template.charCodeAt(i++); if (c === 37) { t = template.charAt(i++); p = d3_time_parsers[t in d3_time_formatPads ? template.charAt(i++) : t]; if (!p || (j = p(date, string, j)) < 0) return -1; } else if (c != string.charCodeAt(j++)) { return -1; } } return j; } d3_time_format.utc = function(template) { var local = d3_time_format(template); function format(date) { try { d3_date = d3_date_utc; var utc = new d3_date(); utc._ = date; return local(utc); } finally { d3_date = Date; } } format.parse = function(string) { try { d3_date = d3_date_utc; var date = local.parse(string); return date && date._; } finally { d3_date = Date; } }; format.toString = local.toString; return format; }; d3_time_format.multi = d3_time_format.utc.multi = d3_time_formatMulti; var d3_time_periodLookup = d3.map(), d3_time_dayRe = d3_time_formatRe(locale_days), d3_time_dayLookup = d3_time_formatLookup(locale_days), d3_time_dayAbbrevRe = d3_time_formatRe(locale_shortDays), d3_time_dayAbbrevLookup = d3_time_formatLookup(locale_shortDays), d3_time_monthRe = d3_time_formatRe(locale_months), d3_time_monthLookup = d3_time_formatLookup(locale_months), d3_time_monthAbbrevRe = d3_time_formatRe(locale_shortMonths), d3_time_monthAbbrevLookup = d3_time_formatLookup(locale_shortMonths); locale_periods.forEach(function(p, i) { d3_time_periodLookup.set(p.toLowerCase(), i); }); var d3_time_formats = { a: function(d) { return locale_shortDays[d.getDay()]; }, A: function(d) { return locale_days[d.getDay()]; }, b: function(d) { return locale_shortMonths[d.getMonth()]; }, B: function(d) { return locale_months[d.getMonth()]; }, c: d3_time_format(locale_dateTime), d: function(d, p) { return d3_time_formatPad(d.getDate(), p, 2); }, e: function(d, p) { return d3_time_formatPad(d.getDate(), p, 2); }, H: function(d, p) { return d3_time_formatPad(d.getHours(), p, 2); }, I: function(d, p) { return d3_time_formatPad(d.getHours() % 12 || 12, p, 2); }, j: function(d, p) { return d3_time_formatPad(1 + d3_time.dayOfYear(d), p, 3); }, L: function(d, p) { return d3_time_formatPad(d.getMilliseconds(), p, 3); }, m: function(d, p) { return d3_time_formatPad(d.getMonth() + 1, p, 2); }, M: function(d, p) { return d3_time_formatPad(d.getMinutes(), p, 2); }, p: function(d) { return locale_periods[+(d.getHours() >= 12)]; }, S: function(d, p) { return d3_time_formatPad(d.getSeconds(), p, 2); }, U: function(d, p) { return d3_time_formatPad(d3_time.sundayOfYear(d), p, 2); }, w: function(d) { return d.getDay(); }, W: function(d, p) { return d3_time_formatPad(d3_time.mondayOfYear(d), p, 2); }, x: d3_time_format(locale_date), X: d3_time_format(locale_time), y: function(d, p) { return d3_time_formatPad(d.getFullYear() % 100, p, 2); }, Y: function(d, p) { return d3_time_formatPad(d.getFullYear() % 1e4, p, 4); }, Z: d3_time_zone, "%": function() { return "%"; } }; var d3_time_parsers = { a: d3_time_parseWeekdayAbbrev, A: d3_time_parseWeekday, b: d3_time_parseMonthAbbrev, B: d3_time_parseMonth, c: d3_time_parseLocaleFull, d: d3_time_parseDay, e: d3_time_parseDay, H: d3_time_parseHour24, I: d3_time_parseHour24, j: d3_time_parseDayOfYear, L: d3_time_parseMilliseconds, m: d3_time_parseMonthNumber, M: d3_time_parseMinutes, p: d3_time_parseAmPm, S: d3_time_parseSeconds, U: d3_time_parseWeekNumberSunday, w: d3_time_parseWeekdayNumber, W: d3_time_parseWeekNumberMonday, x: d3_time_parseLocaleDate, X: d3_time_parseLocaleTime, y: d3_time_parseYear, Y: d3_time_parseFullYear, Z: d3_time_parseZone, "%": d3_time_parseLiteralPercent }; function d3_time_parseWeekdayAbbrev(date, string, i) { d3_time_dayAbbrevRe.lastIndex = 0; var n = d3_time_dayAbbrevRe.exec(string.slice(i)); return n ? (date.w = d3_time_dayAbbrevLookup.get(n[0].toLowerCase()), i + n[0].length) : -1; } function d3_time_parseWeekday(date, string, i) { d3_time_dayRe.lastIndex = 0; var n = d3_time_dayRe.exec(string.slice(i)); return n ? (date.w = d3_time_dayLookup.get(n[0].toLowerCase()), i + n[0].length) : -1; } function d3_time_parseMonthAbbrev(date, string, i) { d3_time_monthAbbrevRe.lastIndex = 0; var n = d3_time_monthAbbrevRe.exec(string.slice(i)); return n ? (date.m = d3_time_monthAbbrevLookup.get(n[0].toLowerCase()), i + n[0].length) : -1; } function d3_time_parseMonth(date, string, i) { d3_time_monthRe.lastIndex = 0; var n = d3_time_monthRe.exec(string.slice(i)); return n ? (date.m = d3_time_monthLookup.get(n[0].toLowerCase()), i + n[0].length) : -1; } function d3_time_parseLocaleFull(date, string, i) { return d3_time_parse(date, d3_time_formats.c.toString(), string, i); } function d3_time_parseLocaleDate(date, string, i) { return d3_time_parse(date, d3_time_formats.x.toString(), string, i); } function d3_time_parseLocaleTime(date, string, i) { return d3_time_parse(date, d3_time_formats.X.toString(), string, i); } function d3_time_parseAmPm(date, string, i) { var n = d3_time_periodLookup.get(string.slice(i, i += 2).toLowerCase()); return n == null ? -1 : (date.p = n, i); } return d3_time_format; } var d3_time_formatPads = { "-": "", _: " ", "0": "0" }, d3_time_numberRe = /^\s*\d+/, d3_time_percentRe = /^%/; function d3_time_formatPad(value, fill, width) { var sign = value < 0 ? "-" : "", string = (sign ? -value : value) + "", length = string.length; return sign + (length < width ? new Array(width - length + 1).join(fill) + string : string); } function d3_time_formatRe(names) { return new RegExp("^(?:" + names.map(d3.requote).join("|") + ")", "i"); } function d3_time_formatLookup(names) { var map = new d3_Map(), i = -1, n = names.length; while (++i < n) map.set(names[i].toLowerCase(), i); return map; } function d3_time_parseWeekdayNumber(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 1)); return n ? (date.w = +n[0], i + n[0].length) : -1; } function d3_time_parseWeekNumberSunday(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i)); return n ? (date.U = +n[0], i + n[0].length) : -1; } function d3_time_parseWeekNumberMonday(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i)); return n ? (date.W = +n[0], i + n[0].length) : -1; } function d3_time_parseFullYear(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 4)); return n ? (date.y = +n[0], i + n[0].length) : -1; } function d3_time_parseYear(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 2)); return n ? (date.y = d3_time_expandYear(+n[0]), i + n[0].length) : -1; } function d3_time_parseZone(date, string, i) { return /^[+-]\d{4}$/.test(string = string.slice(i, i + 5)) ? (date.Z = -string, i + 5) : -1; } function d3_time_expandYear(d) { return d + (d > 68 ? 1900 : 2e3); } function d3_time_parseMonthNumber(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 2)); return n ? (date.m = n[0] - 1, i + n[0].length) : -1; } function d3_time_parseDay(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 2)); return n ? (date.d = +n[0], i + n[0].length) : -1; } function d3_time_parseDayOfYear(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 3)); return n ? (date.j = +n[0], i + n[0].length) : -1; } function d3_time_parseHour24(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 2)); return n ? (date.H = +n[0], i + n[0].length) : -1; } function d3_time_parseMinutes(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 2)); return n ? (date.M = +n[0], i + n[0].length) : -1; } function d3_time_parseSeconds(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 2)); return n ? (date.S = +n[0], i + n[0].length) : -1; } function d3_time_parseMilliseconds(date, string, i) { d3_time_numberRe.lastIndex = 0; var n = d3_time_numberRe.exec(string.slice(i, i + 3)); return n ? (date.L = +n[0], i + n[0].length) : -1; } function d3_time_zone(d) { var z = d.getTimezoneOffset(), zs = z > 0 ? "-" : "+", zh = abs(z) / 60 | 0, zm = abs(z) % 60; return zs + d3_time_formatPad(zh, "0", 2) + d3_time_formatPad(zm, "0", 2); } function d3_time_parseLiteralPercent(date, string, i) { d3_time_percentRe.lastIndex = 0; var n = d3_time_percentRe.exec(string.slice(i, i + 1)); return n ? i + n[0].length : -1; } function d3_time_formatMulti(formats) { var n = formats.length, i = -1; while (++i < n) formats[i][0] = this(formats[i][0]); return function(date) { var i = 0, f = formats[i]; while (!f[1](date)) f = formats[++i]; return f[0](date); }; } d3.locale = function(locale) { return { numberFormat: d3_locale_numberFormat(locale), timeFormat: d3_locale_timeFormat(locale) }; }; var d3_locale_enUS = d3.locale({ decimal: ".", thousands: ",", grouping: [ 3 ], currency: [ "$", "" ], dateTime: "%a %b %e %X %Y", date: "%m/%d/%Y", time: "%H:%M:%S", periods: [ "AM", "PM" ], days: [ "Sunday", "Monday", "Tuesday", "Wednesday", "Thursday", "Friday", "Saturday" ], shortDays: [ "Sun", "Mon", "Tue", "Wed", "Thu", "Fri", "Sat" ], months: [ "January", "February", "March", "April", "May", "June", "July", "August", "September", "October", "November", "December" ], shortMonths: [ "Jan", "Feb", "Mar", "Apr", "May", "Jun", "Jul", "Aug", "Sep", "Oct", "Nov", "Dec" ] }); d3.format = d3_locale_enUS.numberFormat; d3.geo = {}; function d3_adder() {} d3_adder.prototype = { s: 0, t: 0, add: function(y) { d3_adderSum(y, this.t, d3_adderTemp); d3_adderSum(d3_adderTemp.s, this.s, this); if (this.s) this.t += d3_adderTemp.t; else this.s = d3_adderTemp.t; }, reset: function() { this.s = this.t = 0; }, valueOf: function() { return this.s; } }; var d3_adderTemp = new d3_adder(); function d3_adderSum(a, b, o) { var x = o.s = a + b, bv = x - a, av = x - bv; o.t = a - av + (b - bv); } d3.geo.stream = function(object, listener) { if (object && d3_geo_streamObjectType.hasOwnProperty(object.type)) { d3_geo_streamObjectType[object.type](object, listener); } else { d3_geo_streamGeometry(object, listener); } }; function d3_geo_streamGeometry(geometry, listener) { if (geometry && d3_geo_streamGeometryType.hasOwnProperty(geometry.type)) { d3_geo_streamGeometryType[geometry.type](geometry, listener); } } var d3_geo_streamObjectType = { Feature: function(feature, listener) { d3_geo_streamGeometry(feature.geometry, listener); }, FeatureCollection: function(object, listener) { var features = object.features, i = -1, n = features.length; while (++i < n) d3_geo_streamGeometry(features[i].geometry, listener); } }; var d3_geo_streamGeometryType = { Sphere: function(object, listener) { listener.sphere(); }, Point: function(object, listener) { object = object.coordinates; listener.point(object[0], object[1], object[2]); }, MultiPoint: function(object, listener) { var coordinates = object.coordinates, i = -1, n = coordinates.length; while (++i < n) object = coordinates[i], listener.point(object[0], object[1], object[2]); }, LineString: function(object, listener) { d3_geo_streamLine(object.coordinates, listener, 0); }, MultiLineString: function(object, listener) { var coordinates = object.coordinates, i = -1, n = coordinates.length; while (++i < n) d3_geo_streamLine(coordinates[i], listener, 0); }, Polygon: function(object, listener) { d3_geo_streamPolygon(object.coordinates, listener); }, MultiPolygon: function(object, listener) { var coordinates = object.coordinates, i = -1, n = coordinates.length; while (++i < n) d3_geo_streamPolygon(coordinates[i], listener); }, GeometryCollection: function(object, listener) { var geometries = object.geometries, i = -1, n = geometries.length; while (++i < n) d3_geo_streamGeometry(geometries[i], listener); } }; function d3_geo_streamLine(coordinates, listener, closed) { var i = -1, n = coordinates.length - closed, coordinate; listener.lineStart(); while (++i < n) coordinate = coordinates[i], listener.point(coordinate[0], coordinate[1], coordinate[2]); listener.lineEnd(); } function d3_geo_streamPolygon(coordinates, listener) { var i = -1, n = coordinates.length; listener.polygonStart(); while (++i < n) d3_geo_streamLine(coordinates[i], listener, 1); listener.polygonEnd(); } d3.geo.area = function(object) { d3_geo_areaSum = 0; d3.geo.stream(object, d3_geo_area); return d3_geo_areaSum; }; var d3_geo_areaSum, d3_geo_areaRingSum = new d3_adder(); var d3_geo_area = { sphere: function() { d3_geo_areaSum += 4 * π; }, point: d3_noop, lineStart: d3_noop, lineEnd: d3_noop, polygonStart: function() { d3_geo_areaRingSum.reset(); d3_geo_area.lineStart = d3_geo_areaRingStart; }, polygonEnd: function() { var area = 2 * d3_geo_areaRingSum; d3_geo_areaSum += area < 0 ? 4 * π + area : area; d3_geo_area.lineStart = d3_geo_area.lineEnd = d3_geo_area.point = d3_noop; } }; function d3_geo_areaRingStart() { var λ00, φ00, λ0, cosφ0, sinφ0; d3_geo_area.point = function(λ, φ) { d3_geo_area.point = nextPoint; λ0 = (λ00 = λ) * d3_radians, cosφ0 = Math.cos(φ = (φ00 = φ) * d3_radians / 2 + π / 4), sinφ0 = Math.sin(φ); }; function nextPoint(λ, φ) { λ *= d3_radians; φ = φ * d3_radians / 2 + π / 4; var dλ = λ - λ0, sdλ = dλ >= 0 ? 1 : -1, adλ = sdλ * dλ, cosφ = Math.cos(φ), sinφ = Math.sin(φ), k = sinφ0 * sinφ, u = cosφ0 * cosφ + k * Math.cos(adλ), v = k * sdλ * Math.sin(adλ); d3_geo_areaRingSum.add(Math.atan2(v, u)); λ0 = λ, cosφ0 = cosφ, sinφ0 = sinφ; } d3_geo_area.lineEnd = function() { nextPoint(λ00, φ00); }; } function d3_geo_cartesian(spherical) { var λ = spherical[0], φ = spherical[1], cosφ = Math.cos(φ); return [ cosφ * Math.cos(λ), cosφ * Math.sin(λ), Math.sin(φ) ]; } function d3_geo_cartesianDot(a, b) { return a[0] * b[0] + a[1] * b[1] + a[2] * b[2]; } function d3_geo_cartesianCross(a, b) { return [ a[1] * b[2] - a[2] * b[1], a[2] * b[0] - a[0] * b[2], a[0] * b[1] - a[1] * b[0] ]; } function d3_geo_cartesianAdd(a, b) { a[0] += b[0]; a[1] += b[1]; a[2] += b[2]; } function d3_geo_cartesianScale(vector, k) { return [ vector[0] * k, vector[1] * k, vector[2] * k ]; } function d3_geo_cartesianNormalize(d) { var l = Math.sqrt(d[0] * d[0] + d[1] * d[1] + d[2] * d[2]); d[0] /= l; d[1] /= l; d[2] /= l; } function d3_geo_spherical(cartesian) { return [ Math.atan2(cartesian[1], cartesian[0]), d3_asin(cartesian[2]) ]; } function d3_geo_sphericalEqual(a, b) { return abs(a[0] - b[0]) < ε && abs(a[1] - b[1]) < ε; } d3.geo.bounds = function() { var λ0, φ0, λ1, φ1, λ_, λ__, φ__, p0, dλSum, ranges, range; var bound = { point: point, lineStart: lineStart, lineEnd: lineEnd, polygonStart: function() { bound.point = ringPoint; bound.lineStart = ringStart; bound.lineEnd = ringEnd; dλSum = 0; d3_geo_area.polygonStart(); }, polygonEnd: function() { d3_geo_area.polygonEnd(); bound.point = point; bound.lineStart = lineStart; bound.lineEnd = lineEnd; if (d3_geo_areaRingSum < 0) λ0 = -(λ1 = 180), φ0 = -(φ1 = 90); else if (dλSum > ε) φ1 = 90; else if (dλSum < -ε) φ0 = -90; range[0] = λ0, range[1] = λ1; } }; function point(λ, φ) { ranges.push(range = [ λ0 = λ, λ1 = λ ]); if (φ < φ0) φ0 = φ; if (φ > φ1) φ1 = φ; } function linePoint(λ, φ) { var p = d3_geo_cartesian([ λ * d3_radians, φ * d3_radians ]); if (p0) { var normal = d3_geo_cartesianCross(p0, p), equatorial = [ normal[1], -normal[0], 0 ], inflection = d3_geo_cartesianCross(equatorial, normal); d3_geo_cartesianNormalize(inflection); inflection = d3_geo_spherical(inflection); var dλ = λ - λ_, s = dλ > 0 ? 1 : -1, λi = inflection[0] * d3_degrees * s, antimeridian = abs(dλ) > 180; if (antimeridian ^ (s * λ_ < λi && λi < s * λ)) { var φi = inflection[1] * d3_degrees; if (φi > φ1) φ1 = φi; } else if (λi = (λi + 360) % 360 - 180, antimeridian ^ (s * λ_ < λi && λi < s * λ)) { var φi = -inflection[1] * d3_degrees; if (φi < φ0) φ0 = φi; } else { if (φ < φ0) φ0 = φ; if (φ > φ1) φ1 = φ; } if (antimeridian) { if (λ < λ_) { if (angle(λ0, λ) > angle(λ0, λ1)) λ1 = λ; } else { if (angle(λ, λ1) > angle(λ0, λ1)) λ0 = λ; } } else { if (λ1 >= λ0) { if (λ < λ0) λ0 = λ; if (λ > λ1) λ1 = λ; } else { if (λ > λ_) { if (angle(λ0, λ) > angle(λ0, λ1)) λ1 = λ; } else { if (angle(λ, λ1) > angle(λ0, λ1)) λ0 = λ; } } } } else { point(λ, φ); } p0 = p, λ_ = λ; } function lineStart() { bound.point = linePoint; } function lineEnd() { range[0] = λ0, range[1] = λ1; bound.point = point; p0 = null; } function ringPoint(λ, φ) { if (p0) { var dλ = λ - λ_; dλSum += abs(dλ) > 180 ? dλ + (dλ > 0 ? 360 : -360) : dλ; } else λ__ = λ, φ__ = φ; d3_geo_area.point(λ, φ); linePoint(λ, φ); } function ringStart() { d3_geo_area.lineStart(); } function ringEnd() { ringPoint(λ__, φ__); d3_geo_area.lineEnd(); if (abs(dλSum) > ε) λ0 = -(λ1 = 180); range[0] = λ0, range[1] = λ1; p0 = null; } function angle(λ0, λ1) { return (λ1 -= λ0) < 0 ? λ1 + 360 : λ1; } function compareRanges(a, b) { return a[0] - b[0]; } function withinRange(x, range) { return range[0] <= range[1] ? range[0] <= x && x <= range[1] : x < range[0] || range[1] < x; } return function(feature) { φ1 = λ1 = -(λ0 = φ0 = Infinity); ranges = []; d3.geo.stream(feature, bound); var n = ranges.length; if (n) { ranges.sort(compareRanges); for (var i = 1, a = ranges[0], b, merged = [ a ]; i < n; ++i) { b = ranges[i]; if (withinRange(b[0], a) || withinRange(b[1], a)) { if (angle(a[0], b[1]) > angle(a[0], a[1])) a[1] = b[1]; if (angle(b[0], a[1]) > angle(a[0], a[1])) a[0] = b[0]; } else { merged.push(a = b); } } var best = -Infinity, dλ; for (var n = merged.length - 1, i = 0, a = merged[n], b; i <= n; a = b, ++i) { b = merged[i]; if ((dλ = angle(a[1], b[0])) > best) best = dλ, λ0 = b[0], λ1 = a[1]; } } ranges = range = null; return λ0 === Infinity || φ0 === Infinity ? [ [ NaN, NaN ], [ NaN, NaN ] ] : [ [ λ0, φ0 ], [ λ1, φ1 ] ]; }; }(); d3.geo.centroid = function(object) { d3_geo_centroidW0 = d3_geo_centroidW1 = d3_geo_centroidX0 = d3_geo_centroidY0 = d3_geo_centroidZ0 = d3_geo_centroidX1 = d3_geo_centroidY1 = d3_geo_centroidZ1 = d3_geo_centroidX2 = d3_geo_centroidY2 = d3_geo_centroidZ2 = 0; d3.geo.stream(object, d3_geo_centroid); var x = d3_geo_centroidX2, y = d3_geo_centroidY2, z = d3_geo_centroidZ2, m = x * x + y * y + z * z; if (m < ε2) { x = d3_geo_centroidX1, y = d3_geo_centroidY1, z = d3_geo_centroidZ1; if (d3_geo_centroidW1 < ε) x = d3_geo_centroidX0, y = d3_geo_centroidY0, z = d3_geo_centroidZ0; m = x * x + y * y + z * z; if (m < ε2) return [ NaN, NaN ]; } return [ Math.atan2(y, x) * d3_degrees, d3_asin(z / Math.sqrt(m)) * d3_degrees ]; }; var d3_geo_centroidW0, d3_geo_centroidW1, d3_geo_centroidX0, d3_geo_centroidY0, d3_geo_centroidZ0, d3_geo_centroidX1, d3_geo_centroidY1, d3_geo_centroidZ1, d3_geo_centroidX2, d3_geo_centroidY2, d3_geo_centroidZ2; var d3_geo_centroid = { sphere: d3_noop, point: d3_geo_centroidPoint, lineStart: d3_geo_centroidLineStart, lineEnd: d3_geo_centroidLineEnd, polygonStart: function() { d3_geo_centroid.lineStart = d3_geo_centroidRingStart; }, polygonEnd: function() { d3_geo_centroid.lineStart = d3_geo_centroidLineStart; } }; function d3_geo_centroidPoint(λ, φ) { λ *= d3_radians; var cosφ = Math.cos(φ *= d3_radians); d3_geo_centroidPointXYZ(cosφ * Math.cos(λ), cosφ * Math.sin(λ), Math.sin(φ)); } function d3_geo_centroidPointXYZ(x, y, z) { ++d3_geo_centroidW0; d3_geo_centroidX0 += (x - d3_geo_centroidX0) / d3_geo_centroidW0; d3_geo_centroidY0 += (y - d3_geo_centroidY0) / d3_geo_centroidW0; d3_geo_centroidZ0 += (z - d3_geo_centroidZ0) / d3_geo_centroidW0; } function d3_geo_centroidLineStart() { var x0, y0, z0; d3_geo_centroid.point = function(λ, φ) { λ *= d3_radians; var cosφ = Math.cos(φ *= d3_radians); x0 = cosφ * Math.cos(λ); y0 = cosφ * Math.sin(λ); z0 = Math.sin(φ); d3_geo_centroid.point = nextPoint; d3_geo_centroidPointXYZ(x0, y0, z0); }; function nextPoint(λ, φ) { λ *= d3_radians; var cosφ = Math.cos(φ *= d3_radians), x = cosφ * Math.cos(λ), y = cosφ * Math.sin(λ), z = Math.sin(φ), w = Math.atan2(Math.sqrt((w = y0 * z - z0 * y) * w + (w = z0 * x - x0 * z) * w + (w = x0 * y - y0 * x) * w), x0 * x + y0 * y + z0 * z); d3_geo_centroidW1 += w; d3_geo_centroidX1 += w * (x0 + (x0 = x)); d3_geo_centroidY1 += w * (y0 + (y0 = y)); d3_geo_centroidZ1 += w * (z0 + (z0 = z)); d3_geo_centroidPointXYZ(x0, y0, z0); } } function d3_geo_centroidLineEnd() { d3_geo_centroid.point = d3_geo_centroidPoint; } function d3_geo_centroidRingStart() { var λ00, φ00, x0, y0, z0; d3_geo_centroid.point = function(λ, φ) { λ00 = λ, φ00 = φ; d3_geo_centroid.point = nextPoint; λ *= d3_radians; var cosφ = Math.cos(φ *= d3_radians); x0 = cosφ * Math.cos(λ); y0 = cosφ * Math.sin(λ); z0 = Math.sin(φ); d3_geo_centroidPointXYZ(x0, y0, z0); }; d3_geo_centroid.lineEnd = function() { nextPoint(λ00, φ00); d3_geo_centroid.lineEnd = d3_geo_centroidLineEnd; d3_geo_centroid.point = d3_geo_centroidPoint; }; function nextPoint(λ, φ) { λ *= d3_radians; var cosφ = Math.cos(φ *= d3_radians), x = cosφ * Math.cos(λ), y = cosφ * Math.sin(λ), z = Math.sin(φ), cx = y0 * z - z0 * y, cy = z0 * x - x0 * z, cz = x0 * y - y0 * x, m = Math.sqrt(cx * cx + cy * cy + cz * cz), u = x0 * x + y0 * y + z0 * z, v = m && -d3_acos(u) / m, w = Math.atan2(m, u); d3_geo_centroidX2 += v * cx; d3_geo_centroidY2 += v * cy; d3_geo_centroidZ2 += v * cz; d3_geo_centroidW1 += w; d3_geo_centroidX1 += w * (x0 + (x0 = x)); d3_geo_centroidY1 += w * (y0 + (y0 = y)); d3_geo_centroidZ1 += w * (z0 + (z0 = z)); d3_geo_centroidPointXYZ(x0, y0, z0); } } function d3_geo_compose(a, b) { function compose(x, y) { return x = a(x, y), b(x[0], x[1]); } if (a.invert && b.invert) compose.invert = function(x, y) { return x = b.invert(x, y), x && a.invert(x[0], x[1]); }; return compose; } function d3_true() { return true; } function d3_geo_clipPolygon(segments, compare, clipStartInside, interpolate, listener) { var subject = [], clip = []; segments.forEach(function(segment) { if ((n = segment.length - 1) <= 0) return; var n, p0 = segment[0], p1 = segment[n]; if (d3_geo_sphericalEqual(p0, p1)) { listener.lineStart(); for (var i = 0; i < n; ++i) listener.point((p0 = segment[i])[0], p0[1]); listener.lineEnd(); return; } var a = new d3_geo_clipPolygonIntersection(p0, segment, null, true), b = new d3_geo_clipPolygonIntersection(p0, null, a, false); a.o = b; subject.push(a); clip.push(b); a = new d3_geo_clipPolygonIntersection(p1, segment, null, false); b = new d3_geo_clipPolygonIntersection(p1, null, a, true); a.o = b; subject.push(a); clip.push(b); }); clip.sort(compare); d3_geo_clipPolygonLinkCircular(subject); d3_geo_clipPolygonLinkCircular(clip); if (!subject.length) return; for (var i = 0, entry = clipStartInside, n = clip.length; i < n; ++i) { clip[i].e = entry = !entry; } var start = subject[0], points, point; while (1) { var current = start, isSubject = true; while (current.v) if ((current = current.n) === start) return; points = current.z; listener.lineStart(); do { current.v = current.o.v = true; if (current.e) { if (isSubject) { for (var i = 0, n = points.length; i < n; ++i) listener.point((point = points[i])[0], point[1]); } else { interpolate(current.x, current.n.x, 1, listener); } current = current.n; } else { if (isSubject) { points = current.p.z; for (var i = points.length - 1; i >= 0; --i) listener.point((point = points[i])[0], point[1]); } else { interpolate(current.x, current.p.x, -1, listener); } current = current.p; } current = current.o; points = current.z; isSubject = !isSubject; } while (!current.v); listener.lineEnd(); } } function d3_geo_clipPolygonLinkCircular(array) { if (!(n = array.length)) return; var n, i = 0, a = array[0], b; while (++i < n) { a.n = b = array[i]; b.p = a; a = b; } a.n = b = array[0]; b.p = a; } function d3_geo_clipPolygonIntersection(point, points, other, entry) { this.x = point; this.z = points; this.o = other; this.e = entry; this.v = false; this.n = this.p = null; } function d3_geo_clip(pointVisible, clipLine, interpolate, clipStart) { return function(rotate, listener) { var line = clipLine(listener), rotatedClipStart = rotate.invert(clipStart[0], clipStart[1]); var clip = { point: point, lineStart: lineStart, lineEnd: lineEnd, polygonStart: function() { clip.point = pointRing; clip.lineStart = ringStart; clip.lineEnd = ringEnd; segments = []; polygon = []; }, polygonEnd: function() { clip.point = point; clip.lineStart = lineStart; clip.lineEnd = lineEnd; segments = d3.merge(segments); var clipStartInside = d3_geo_pointInPolygon(rotatedClipStart, polygon); if (segments.length) { if (!polygonStarted) listener.polygonStart(), polygonStarted = true; d3_geo_clipPolygon(segments, d3_geo_clipSort, clipStartInside, interpolate, listener); } else if (clipStartInside) { if (!polygonStarted) listener.polygonStart(), polygonStarted = true; listener.lineStart(); interpolate(null, null, 1, listener); listener.lineEnd(); } if (polygonStarted) listener.polygonEnd(), polygonStarted = false; segments = polygon = null; }, sphere: function() { listener.polygonStart(); listener.lineStart(); interpolate(null, null, 1, listener); listener.lineEnd(); listener.polygonEnd(); } }; function point(λ, φ) { var point = rotate(λ, φ); if (pointVisible(λ = point[0], φ = point[1])) listener.point(λ, φ); } function pointLine(λ, φ) { var point = rotate(λ, φ); line.point(point[0], point[1]); } function lineStart() { clip.point = pointLine; line.lineStart(); } function lineEnd() { clip.point = point; line.lineEnd(); } var segments; var buffer = d3_geo_clipBufferListener(), ringListener = clipLine(buffer), polygonStarted = false, polygon, ring; function pointRing(λ, φ) { ring.push([ λ, φ ]); var point = rotate(λ, φ); ringListener.point(point[0], point[1]); } function ringStart() { ringListener.lineStart(); ring = []; } function ringEnd() { pointRing(ring[0][0], ring[0][1]); ringListener.lineEnd(); var clean = ringListener.clean(), ringSegments = buffer.buffer(), segment, n = ringSegments.length; ring.pop(); polygon.push(ring); ring = null; if (!n) return; if (clean & 1) { segment = ringSegments[0]; var n = segment.length - 1, i = -1, point; if (n > 0) { if (!polygonStarted) listener.polygonStart(), polygonStarted = true; listener.lineStart(); while (++i < n) listener.point((point = segment[i])[0], point[1]); listener.lineEnd(); } return; } if (n > 1 && clean & 2) ringSegments.push(ringSegments.pop().concat(ringSegments.shift())); segments.push(ringSegments.filter(d3_geo_clipSegmentLength1)); } return clip; }; } function d3_geo_clipSegmentLength1(segment) { return segment.length > 1; } function d3_geo_clipBufferListener() { var lines = [], line; return { lineStart: function() { lines.push(line = []); }, point: function(λ, φ) { line.push([ λ, φ ]); }, lineEnd: d3_noop, buffer: function() { var buffer = lines; lines = []; line = null; return buffer; }, rejoin: function() { if (lines.length > 1) lines.push(lines.pop().concat(lines.shift())); } }; } function d3_geo_clipSort(a, b) { return ((a = a.x)[0] < 0 ? a[1] - halfπ - ε : halfπ - a[1]) - ((b = b.x)[0] < 0 ? b[1] - halfπ - ε : halfπ - b[1]); } var d3_geo_clipAntimeridian = d3_geo_clip(d3_true, d3_geo_clipAntimeridianLine, d3_geo_clipAntimeridianInterpolate, [ -π, -π / 2 ]); function d3_geo_clipAntimeridianLine(listener) { var λ0 = NaN, φ0 = NaN, sλ0 = NaN, clean; return { lineStart: function() { listener.lineStart(); clean = 1; }, point: function(λ1, φ1) { var sλ1 = λ1 > 0 ? π : -π, dλ = abs(λ1 - λ0); if (abs(dλ - π) < ε) { listener.point(λ0, φ0 = (φ0 + φ1) / 2 > 0 ? halfπ : -halfπ); listener.point(sλ0, φ0); listener.lineEnd(); listener.lineStart(); listener.point(sλ1, φ0); listener.point(λ1, φ0); clean = 0; } else if (sλ0 !== sλ1 && dλ >= π) { if (abs(λ0 - sλ0) < ε) λ0 -= sλ0 * ε; if (abs(λ1 - sλ1) < ε) λ1 -= sλ1 * ε; φ0 = d3_geo_clipAntimeridianIntersect(λ0, φ0, λ1, φ1); listener.point(sλ0, φ0); listener.lineEnd(); listener.lineStart(); listener.point(sλ1, φ0); clean = 0; } listener.point(λ0 = λ1, φ0 = φ1); sλ0 = sλ1; }, lineEnd: function() { listener.lineEnd(); λ0 = φ0 = NaN; }, clean: function() { return 2 - clean; } }; } function d3_geo_clipAntimeridianIntersect(λ0, φ0, λ1, φ1) { var cosφ0, cosφ1, sinλ0_λ1 = Math.sin(λ0 - λ1); return abs(sinλ0_λ1) > ε ? Math.atan((Math.sin(φ0) * (cosφ1 = Math.cos(φ1)) * Math.sin(λ1) - Math.sin(φ1) * (cosφ0 = Math.cos(φ0)) * Math.sin(λ0)) / (cosφ0 * cosφ1 * sinλ0_λ1)) : (φ0 + φ1) / 2; } function d3_geo_clipAntimeridianInterpolate(from, to, direction, listener) { var φ; if (from == null) { φ = direction * halfπ; listener.point(-π, φ); listener.point(0, φ); listener.point(π, φ); listener.point(π, 0); listener.point(π, -φ); listener.point(0, -φ); listener.point(-π, -φ); listener.point(-π, 0); listener.point(-π, φ); } else if (abs(from[0] - to[0]) > ε) { var s = from[0] < to[0] ? π : -π; φ = direction * s / 2; listener.point(-s, φ); listener.point(0, φ); listener.point(s, φ); } else { listener.point(to[0], to[1]); } } function d3_geo_pointInPolygon(point, polygon) { var meridian = point[0], parallel = point[1], meridianNormal = [ Math.sin(meridian), -Math.cos(meridian), 0 ], polarAngle = 0, winding = 0; d3_geo_areaRingSum.reset(); for (var i = 0, n = polygon.length; i < n; ++i) { var ring = polygon[i], m = ring.length; if (!m) continue; var point0 = ring[0], λ0 = point0[0], φ0 = point0[1] / 2 + π / 4, sinφ0 = Math.sin(φ0), cosφ0 = Math.cos(φ0), j = 1; while (true) { if (j === m) j = 0; point = ring[j]; var λ = point[0], φ = point[1] / 2 + π / 4, sinφ = Math.sin(φ), cosφ = Math.cos(φ), dλ = λ - λ0, sdλ = dλ >= 0 ? 1 : -1, adλ = sdλ * dλ, antimeridian = adλ > π, k = sinφ0 * sinφ; d3_geo_areaRingSum.add(Math.atan2(k * sdλ * Math.sin(adλ), cosφ0 * cosφ + k * Math.cos(adλ))); polarAngle += antimeridian ? dλ + sdλ * τ : dλ; if (antimeridian ^ λ0 >= meridian ^ λ >= meridian) { var arc = d3_geo_cartesianCross(d3_geo_cartesian(point0), d3_geo_cartesian(point)); d3_geo_cartesianNormalize(arc); var intersection = d3_geo_cartesianCross(meridianNormal, arc); d3_geo_cartesianNormalize(intersection); var φarc = (antimeridian ^ dλ >= 0 ? -1 : 1) * d3_asin(intersection[2]); if (parallel > φarc || parallel === φarc && (arc[0] || arc[1])) { winding += antimeridian ^ dλ >= 0 ? 1 : -1; } } if (!j++) break; λ0 = λ, sinφ0 = sinφ, cosφ0 = cosφ, point0 = point; } } return (polarAngle < -ε || polarAngle < ε && d3_geo_areaRingSum < 0) ^ winding & 1; } function d3_geo_clipCircle(radius) { var cr = Math.cos(radius), smallRadius = cr > 0, notHemisphere = abs(cr) > ε, interpolate = d3_geo_circleInterpolate(radius, 6 * d3_radians); return d3_geo_clip(visible, clipLine, interpolate, smallRadius ? [ 0, -radius ] : [ -π, radius - π ]); function visible(λ, φ) { return Math.cos(λ) * Math.cos(φ) > cr; } function clipLine(listener) { var point0, c0, v0, v00, clean; return { lineStart: function() { v00 = v0 = false; clean = 1; }, point: function(λ, φ) { var point1 = [ λ, φ ], point2, v = visible(λ, φ), c = smallRadius ? v ? 0 : code(λ, φ) : v ? code(λ + (λ < 0 ? π : -π), φ) : 0; if (!point0 && (v00 = v0 = v)) listener.lineStart(); if (v !== v0) { point2 = intersect(point0, point1); if (d3_geo_sphericalEqual(point0, point2) || d3_geo_sphericalEqual(point1, point2)) { point1[0] += ε; point1[1] += ε; v = visible(point1[0], point1[1]); } } if (v !== v0) { clean = 0; if (v) { listener.lineStart(); point2 = intersect(point1, point0); listener.point(point2[0], point2[1]); } else { point2 = intersect(point0, point1); listener.point(point2[0], point2[1]); listener.lineEnd(); } point0 = point2; } else if (notHemisphere && point0 && smallRadius ^ v) { var t; if (!(c & c0) && (t = intersect(point1, point0, true))) { clean = 0; if (smallRadius) { listener.lineStart(); listener.point(t[0][0], t[0][1]); listener.point(t[1][0], t[1][1]); listener.lineEnd(); } else { listener.point(t[1][0], t[1][1]); listener.lineEnd(); listener.lineStart(); listener.point(t[0][0], t[0][1]); } } } if (v && (!point0 || !d3_geo_sphericalEqual(point0, point1))) { listener.point(point1[0], point1[1]); } point0 = point1, v0 = v, c0 = c; }, lineEnd: function() { if (v0) listener.lineEnd(); point0 = null; }, clean: function() { return clean | (v00 && v0) << 1; } }; } function intersect(a, b, two) { var pa = d3_geo_cartesian(a), pb = d3_geo_cartesian(b); var n1 = [ 1, 0, 0 ], n2 = d3_geo_cartesianCross(pa, pb), n2n2 = d3_geo_cartesianDot(n2, n2), n1n2 = n2[0], determinant = n2n2 - n1n2 * n1n2; if (!determinant) return !two && a; var c1 = cr * n2n2 / determinant, c2 = -cr * n1n2 / determinant, n1xn2 = d3_geo_cartesianCross(n1, n2), A = d3_geo_cartesianScale(n1, c1), B = d3_geo_cartesianScale(n2, c2); d3_geo_cartesianAdd(A, B); var u = n1xn2, w = d3_geo_cartesianDot(A, u), uu = d3_geo_cartesianDot(u, u), t2 = w * w - uu * (d3_geo_cartesianDot(A, A) - 1); if (t2 < 0) return; var t = Math.sqrt(t2), q = d3_geo_cartesianScale(u, (-w - t) / uu); d3_geo_cartesianAdd(q, A); q = d3_geo_spherical(q); if (!two) return q; var λ0 = a[0], λ1 = b[0], φ0 = a[1], φ1 = b[1], z; if (λ1 < λ0) z = λ0, λ0 = λ1, λ1 = z; var δλ = λ1 - λ0, polar = abs(δλ - π) < ε, meridian = polar || δλ < ε; if (!polar && φ1 < φ0) z = φ0, φ0 = φ1, φ1 = z; if (meridian ? polar ? φ0 + φ1 > 0 ^ q[1] < (abs(q[0] - λ0) < ε ? φ0 : φ1) : φ0 <= q[1] && q[1] <= φ1 : δλ > π ^ (λ0 <= q[0] && q[0] <= λ1)) { var q1 = d3_geo_cartesianScale(u, (-w + t) / uu); d3_geo_cartesianAdd(q1, A); return [ q, d3_geo_spherical(q1) ]; } } function code(λ, φ) { var r = smallRadius ? radius : π - radius, code = 0; if (λ < -r) code |= 1; else if (λ > r) code |= 2; if (φ < -r) code |= 4; else if (φ > r) code |= 8; return code; } } function d3_geom_clipLine(x0, y0, x1, y1) { return function(line) { var a = line.a, b = line.b, ax = a.x, ay = a.y, bx = b.x, by = b.y, t0 = 0, t1 = 1, dx = bx - ax, dy = by - ay, r; r = x0 - ax; if (!dx && r > 0) return; r /= dx; if (dx < 0) { if (r < t0) return; if (r < t1) t1 = r; } else if (dx > 0) { if (r > t1) return; if (r > t0) t0 = r; } r = x1 - ax; if (!dx && r < 0) return; r /= dx; if (dx < 0) { if (r > t1) return; if (r > t0) t0 = r; } else if (dx > 0) { if (r < t0) return; if (r < t1) t1 = r; } r = y0 - ay; if (!dy && r > 0) return; r /= dy; if (dy < 0) { if (r < t0) return; if (r < t1) t1 = r; } else if (dy > 0) { if (r > t1) return; if (r > t0) t0 = r; } r = y1 - ay; if (!dy && r < 0) return; r /= dy; if (dy < 0) { if (r > t1) return; if (r > t0) t0 = r; } else if (dy > 0) { if (r < t0) return; if (r < t1) t1 = r; } if (t0 > 0) line.a = { x: ax + t0 * dx, y: ay + t0 * dy }; if (t1 < 1) line.b = { x: ax + t1 * dx, y: ay + t1 * dy }; return line; }; } var d3_geo_clipExtentMAX = 1e9; d3.geo.clipExtent = function() { var x0, y0, x1, y1, stream, clip, clipExtent = { stream: function(output) { if (stream) stream.valid = false; stream = clip(output); stream.valid = true; return stream; }, extent: function(_) { if (!arguments.length) return [ [ x0, y0 ], [ x1, y1 ] ]; clip = d3_geo_clipExtent(x0 = +_[0][0], y0 = +_[0][1], x1 = +_[1][0], y1 = +_[1][1]); if (stream) stream.valid = false, stream = null; return clipExtent; } }; return clipExtent.extent([ [ 0, 0 ], [ 960, 500 ] ]); }; function d3_geo_clipExtent(x0, y0, x1, y1) { return function(listener) { var listener_ = listener, bufferListener = d3_geo_clipBufferListener(), clipLine = d3_geom_clipLine(x0, y0, x1, y1), segments, polygon, ring; var clip = { point: point, lineStart: lineStart, lineEnd: lineEnd, polygonStart: function() { listener = bufferListener; segments = []; polygon = []; clean = true; }, polygonEnd: function() { listener = listener_; segments = d3.merge(segments); var clipStartInside = insidePolygon([ x0, y1 ]), inside = clean && clipStartInside, visible = segments.length; if (inside || visible) { listener.polygonStart(); if (inside) { listener.lineStart(); interpolate(null, null, 1, listener); listener.lineEnd(); } if (visible) { d3_geo_clipPolygon(segments, compare, clipStartInside, interpolate, listener); } listener.polygonEnd(); } segments = polygon = ring = null; } }; function insidePolygon(p) { var wn = 0, n = polygon.length, y = p[1]; for (var i = 0; i < n; ++i) { for (var j = 1, v = polygon[i], m = v.length, a = v[0], b; j < m; ++j) { b = v[j]; if (a[1] <= y) { if (b[1] > y && d3_cross2d(a, b, p) > 0) ++wn; } else { if (b[1] <= y && d3_cross2d(a, b, p) < 0) --wn; } a = b; } } return wn !== 0; } function interpolate(from, to, direction, listener) { var a = 0, a1 = 0; if (from == null || (a = corner(from, direction)) !== (a1 = corner(to, direction)) || comparePoints(from, to) < 0 ^ direction > 0) { do { listener.point(a === 0 || a === 3 ? x0 : x1, a > 1 ? y1 : y0); } while ((a = (a + direction + 4) % 4) !== a1); } else { listener.point(to[0], to[1]); } } function pointVisible(x, y) { return x0 <= x && x <= x1 && y0 <= y && y <= y1; } function point(x, y) { if (pointVisible(x, y)) listener.point(x, y); } var x__, y__, v__, x_, y_, v_, first, clean; function lineStart() { clip.point = linePoint; if (polygon) polygon.push(ring = []); first = true; v_ = false; x_ = y_ = NaN; } function lineEnd() { if (segments) { linePoint(x__, y__); if (v__ && v_) bufferListener.rejoin(); segments.push(bufferListener.buffer()); } clip.point = point; if (v_) listener.lineEnd(); } function linePoint(x, y) { x = Math.max(-d3_geo_clipExtentMAX, Math.min(d3_geo_clipExtentMAX, x)); y = Math.max(-d3_geo_clipExtentMAX, Math.min(d3_geo_clipExtentMAX, y)); var v = pointVisible(x, y); if (polygon) ring.push([ x, y ]); if (first) { x__ = x, y__ = y, v__ = v; first = false; if (v) { listener.lineStart(); listener.point(x, y); } } else { if (v && v_) listener.point(x, y); else { var l = { a: { x: x_, y: y_ }, b: { x: x, y: y } }; if (clipLine(l)) { if (!v_) { listener.lineStart(); listener.point(l.a.x, l.a.y); } listener.point(l.b.x, l.b.y); if (!v) listener.lineEnd(); clean = false; } else if (v) { listener.lineStart(); listener.point(x, y); clean = false; } } } x_ = x, y_ = y, v_ = v; } return clip; }; function corner(p, direction) { return abs(p[0] - x0) < ε ? direction > 0 ? 0 : 3 : abs(p[0] - x1) < ε ? direction > 0 ? 2 : 1 : abs(p[1] - y0) < ε ? direction > 0 ? 1 : 0 : direction > 0 ? 3 : 2; } function compare(a, b) { return comparePoints(a.x, b.x); } function comparePoints(a, b) { var ca = corner(a, 1), cb = corner(b, 1); return ca !== cb ? ca - cb : ca === 0 ? b[1] - a[1] : ca === 1 ? a[0] - b[0] : ca === 2 ? a[1] - b[1] : b[0] - a[0]; } } function d3_geo_conic(projectAt) { var φ0 = 0, φ1 = π / 3, m = d3_geo_projectionMutator(projectAt), p = m(φ0, φ1); p.parallels = function(_) { if (!arguments.length) return [ φ0 / π * 180, φ1 / π * 180 ]; return m(φ0 = _[0] * π / 180, φ1 = _[1] * π / 180); }; return p; } function d3_geo_conicEqualArea(φ0, φ1) { var sinφ0 = Math.sin(φ0), n = (sinφ0 + Math.sin(φ1)) / 2, C = 1 + sinφ0 * (2 * n - sinφ0), ρ0 = Math.sqrt(C) / n; function forward(λ, φ) { var ρ = Math.sqrt(C - 2 * n * Math.sin(φ)) / n; return [ ρ * Math.sin(λ *= n), ρ0 - ρ * Math.cos(λ) ]; } forward.invert = function(x, y) { var ρ0_y = ρ0 - y; return [ Math.atan2(x, ρ0_y) / n, d3_asin((C - (x * x + ρ0_y * ρ0_y) * n * n) / (2 * n)) ]; }; return forward; } (d3.geo.conicEqualArea = function() { return d3_geo_conic(d3_geo_conicEqualArea); }).raw = d3_geo_conicEqualArea; d3.geo.albers = function() { return d3.geo.conicEqualArea().rotate([ 96, 0 ]).center([ -.6, 38.7 ]).parallels([ 29.5, 45.5 ]).scale(1070); }; d3.geo.albersUsa = function() { var lower48 = d3.geo.albers(); var alaska = d3.geo.conicEqualArea().rotate([ 154, 0 ]).center([ -2, 58.5 ]).parallels([ 55, 65 ]); var hawaii = d3.geo.conicEqualArea().rotate([ 157, 0 ]).center([ -3, 19.9 ]).parallels([ 8, 18 ]); var point, pointStream = { point: function(x, y) { point = [ x, y ]; } }, lower48Point, alaskaPoint, hawaiiPoint; function albersUsa(coordinates) { var x = coordinates[0], y = coordinates[1]; point = null; (lower48Point(x, y), point) || (alaskaPoint(x, y), point) || hawaiiPoint(x, y); return point; } albersUsa.invert = function(coordinates) { var k = lower48.scale(), t = lower48.translate(), x = (coordinates[0] - t[0]) / k, y = (coordinates[1] - t[1]) / k; return (y >= .12 && y < .234 && x >= -.425 && x < -.214 ? alaska : y >= .166 && y < .234 && x >= -.214 && x < -.115 ? hawaii : lower48).invert(coordinates); }; albersUsa.stream = function(stream) { var lower48Stream = lower48.stream(stream), alaskaStream = alaska.stream(stream), hawaiiStream = hawaii.stream(stream); return { point: function(x, y) { lower48Stream.point(x, y); alaskaStream.point(x, y); hawaiiStream.point(x, y); }, sphere: function() { lower48Stream.sphere(); alaskaStream.sphere(); hawaiiStream.sphere(); }, lineStart: function() { lower48Stream.lineStart(); alaskaStream.lineStart(); hawaiiStream.lineStart(); }, lineEnd: function() { lower48Stream.lineEnd(); alaskaStream.lineEnd(); hawaiiStream.lineEnd(); }, polygonStart: function() { lower48Stream.polygonStart(); alaskaStream.polygonStart(); hawaiiStream.polygonStart(); }, polygonEnd: function() { lower48Stream.polygonEnd(); alaskaStream.polygonEnd(); hawaiiStream.polygonEnd(); } }; }; albersUsa.precision = function(_) { if (!arguments.length) return lower48.precision(); lower48.precision(_); alaska.precision(_); hawaii.precision(_); return albersUsa; }; albersUsa.scale = function(_) { if (!arguments.length) return lower48.scale(); lower48.scale(_); alaska.scale(_ * .35); hawaii.scale(_); return albersUsa.translate(lower48.translate()); }; albersUsa.translate = function(_) { if (!arguments.length) return lower48.translate(); var k = lower48.scale(), x = +_[0], y = +_[1]; lower48Point = lower48.translate(_).clipExtent([ [ x - .455 * k, y - .238 * k ], [ x + .455 * k, y + .238 * k ] ]).stream(pointStream).point; alaskaPoint = alaska.translate([ x - .307 * k, y + .201 * k ]).clipExtent([ [ x - .425 * k + ε, y + .12 * k + ε ], [ x - .214 * k - ε, y + .234 * k - ε ] ]).stream(pointStream).point; hawaiiPoint = hawaii.translate([ x - .205 * k, y + .212 * k ]).clipExtent([ [ x - .214 * k + ε, y + .166 * k + ε ], [ x - .115 * k - ε, y + .234 * k - ε ] ]).stream(pointStream).point; return albersUsa; }; return albersUsa.scale(1070); }; var d3_geo_pathAreaSum, d3_geo_pathAreaPolygon, d3_geo_pathArea = { point: d3_noop, lineStart: d3_noop, lineEnd: d3_noop, polygonStart: function() { d3_geo_pathAreaPolygon = 0; d3_geo_pathArea.lineStart = d3_geo_pathAreaRingStart; }, polygonEnd: function() { d3_geo_pathArea.lineStart = d3_geo_pathArea.lineEnd = d3_geo_pathArea.point = d3_noop; d3_geo_pathAreaSum += abs(d3_geo_pathAreaPolygon / 2); } }; function d3_geo_pathAreaRingStart() { var x00, y00, x0, y0; d3_geo_pathArea.point = function(x, y) { d3_geo_pathArea.point = nextPoint; x00 = x0 = x, y00 = y0 = y; }; function nextPoint(x, y) { d3_geo_pathAreaPolygon += y0 * x - x0 * y; x0 = x, y0 = y; } d3_geo_pathArea.lineEnd = function() { nextPoint(x00, y00); }; } var d3_geo_pathBoundsX0, d3_geo_pathBoundsY0, d3_geo_pathBoundsX1, d3_geo_pathBoundsY1; var d3_geo_pathBounds = { point: d3_geo_pathBoundsPoint, lineStart: d3_noop, lineEnd: d3_noop, polygonStart: d3_noop, polygonEnd: d3_noop }; function d3_geo_pathBoundsPoint(x, y) { if (x < d3_geo_pathBoundsX0) d3_geo_pathBoundsX0 = x; if (x > d3_geo_pathBoundsX1) d3_geo_pathBoundsX1 = x; if (y < d3_geo_pathBoundsY0) d3_geo_pathBoundsY0 = y; if (y > d3_geo_pathBoundsY1) d3_geo_pathBoundsY1 = y; } function d3_geo_pathBuffer() { var pointCircle = d3_geo_pathBufferCircle(4.5), buffer = []; var stream = { point: point, lineStart: function() { stream.point = pointLineStart; }, lineEnd: lineEnd, polygonStart: function() { stream.lineEnd = lineEndPolygon; }, polygonEnd: function() { stream.lineEnd = lineEnd; stream.point = point; }, pointRadius: function(_) { pointCircle = d3_geo_pathBufferCircle(_); return stream; }, result: function() { if (buffer.length) { var result = buffer.join(""); buffer = []; return result; } } }; function point(x, y) { buffer.push("M", x, ",", y, pointCircle); } function pointLineStart(x, y) { buffer.push("M", x, ",", y); stream.point = pointLine; } function pointLine(x, y) { buffer.push("L", x, ",", y); } function lineEnd() { stream.point = point; } function lineEndPolygon() { buffer.push("Z"); } return stream; } function d3_geo_pathBufferCircle(radius) { return "m0," + radius + "a" + radius + "," + radius + " 0 1,1 0," + -2 * radius + "a" + radius + "," + radius + " 0 1,1 0," + 2 * radius + "z"; } var d3_geo_pathCentroid = { point: d3_geo_pathCentroidPoint, lineStart: d3_geo_pathCentroidLineStart, lineEnd: d3_geo_pathCentroidLineEnd, polygonStart: function() { d3_geo_pathCentroid.lineStart = d3_geo_pathCentroidRingStart; }, polygonEnd: function() { d3_geo_pathCentroid.point = d3_geo_pathCentroidPoint; d3_geo_pathCentroid.lineStart = d3_geo_pathCentroidLineStart; d3_geo_pathCentroid.lineEnd = d3_geo_pathCentroidLineEnd; } }; function d3_geo_pathCentroidPoint(x, y) { d3_geo_centroidX0 += x; d3_geo_centroidY0 += y; ++d3_geo_centroidZ0; } function d3_geo_pathCentroidLineStart() { var x0, y0; d3_geo_pathCentroid.point = function(x, y) { d3_geo_pathCentroid.point = nextPoint; d3_geo_pathCentroidPoint(x0 = x, y0 = y); }; function nextPoint(x, y) { var dx = x - x0, dy = y - y0, z = Math.sqrt(dx * dx + dy * dy); d3_geo_centroidX1 += z * (x0 + x) / 2; d3_geo_centroidY1 += z * (y0 + y) / 2; d3_geo_centroidZ1 += z; d3_geo_pathCentroidPoint(x0 = x, y0 = y); } } function d3_geo_pathCentroidLineEnd() { d3_geo_pathCentroid.point = d3_geo_pathCentroidPoint; } function d3_geo_pathCentroidRingStart() { var x00, y00, x0, y0; d3_geo_pathCentroid.point = function(x, y) { d3_geo_pathCentroid.point = nextPoint; d3_geo_pathCentroidPoint(x00 = x0 = x, y00 = y0 = y); }; function nextPoint(x, y) { var dx = x - x0, dy = y - y0, z = Math.sqrt(dx * dx + dy * dy); d3_geo_centroidX1 += z * (x0 + x) / 2; d3_geo_centroidY1 += z * (y0 + y) / 2; d3_geo_centroidZ1 += z; z = y0 * x - x0 * y; d3_geo_centroidX2 += z * (x0 + x); d3_geo_centroidY2 += z * (y0 + y); d3_geo_centroidZ2 += z * 3; d3_geo_pathCentroidPoint(x0 = x, y0 = y); } d3_geo_pathCentroid.lineEnd = function() { nextPoint(x00, y00); }; } function d3_geo_pathContext(context) { var pointRadius = 4.5; var stream = { point: point, lineStart: function() { stream.point = pointLineStart; }, lineEnd: lineEnd, polygonStart: function() { stream.lineEnd = lineEndPolygon; }, polygonEnd: function() { stream.lineEnd = lineEnd; stream.point = point; }, pointRadius: function(_) { pointRadius = _; return stream; }, result: d3_noop }; function point(x, y) { context.moveTo(x + pointRadius, y); context.arc(x, y, pointRadius, 0, τ); } function pointLineStart(x, y) { context.moveTo(x, y); stream.point = pointLine; } function pointLine(x, y) { context.lineTo(x, y); } function lineEnd() { stream.point = point; } function lineEndPolygon() { context.closePath(); } return stream; } function d3_geo_resample(project) { var δ2 = .5, cosMinDistance = Math.cos(30 * d3_radians), maxDepth = 16; function resample(stream) { return (maxDepth ? resampleRecursive : resampleNone)(stream); } function resampleNone(stream) { return d3_geo_transformPoint(stream, function(x, y) { x = project(x, y); stream.point(x[0], x[1]); }); } function resampleRecursive(stream) { var λ00, φ00, x00, y00, a00, b00, c00, λ0, x0, y0, a0, b0, c0; var resample = { point: point, lineStart: lineStart, lineEnd: lineEnd, polygonStart: function() { stream.polygonStart(); resample.lineStart = ringStart; }, polygonEnd: function() { stream.polygonEnd(); resample.lineStart = lineStart; } }; function point(x, y) { x = project(x, y); stream.point(x[0], x[1]); } function lineStart() { x0 = NaN; resample.point = linePoint; stream.lineStart(); } function linePoint(λ, φ) { var c = d3_geo_cartesian([ λ, φ ]), p = project(λ, φ); resampleLineTo(x0, y0, λ0, a0, b0, c0, x0 = p[0], y0 = p[1], λ0 = λ, a0 = c[0], b0 = c[1], c0 = c[2], maxDepth, stream); stream.point(x0, y0); } function lineEnd() { resample.point = point; stream.lineEnd(); } function ringStart() { lineStart(); resample.point = ringPoint; resample.lineEnd = ringEnd; } function ringPoint(λ, φ) { linePoint(λ00 = λ, φ00 = φ), x00 = x0, y00 = y0, a00 = a0, b00 = b0, c00 = c0; resample.point = linePoint; } function ringEnd() { resampleLineTo(x0, y0, λ0, a0, b0, c0, x00, y00, λ00, a00, b00, c00, maxDepth, stream); resample.lineEnd = lineEnd; lineEnd(); } return resample; } function resampleLineTo(x0, y0, λ0, a0, b0, c0, x1, y1, λ1, a1, b1, c1, depth, stream) { var dx = x1 - x0, dy = y1 - y0, d2 = dx * dx + dy * dy; if (d2 > 4 * δ2 && depth--) { var a = a0 + a1, b = b0 + b1, c = c0 + c1, m = Math.sqrt(a * a + b * b + c * c), φ2 = Math.asin(c /= m), λ2 = abs(abs(c) - 1) < ε || abs(λ0 - λ1) < ε ? (λ0 + λ1) / 2 : Math.atan2(b, a), p = project(λ2, φ2), x2 = p[0], y2 = p[1], dx2 = x2 - x0, dy2 = y2 - y0, dz = dy * dx2 - dx * dy2; if (dz * dz / d2 > δ2 || abs((dx * dx2 + dy * dy2) / d2 - .5) > .3 || a0 * a1 + b0 * b1 + c0 * c1 < cosMinDistance) { resampleLineTo(x0, y0, λ0, a0, b0, c0, x2, y2, λ2, a /= m, b /= m, c, depth, stream); stream.point(x2, y2); resampleLineTo(x2, y2, λ2, a, b, c, x1, y1, λ1, a1, b1, c1, depth, stream); } } } resample.precision = function(_) { if (!arguments.length) return Math.sqrt(δ2); maxDepth = (δ2 = _ * _) > 0 && 16; return resample; }; return resample; } d3.geo.path = function() { var pointRadius = 4.5, projection, context, projectStream, contextStream, cacheStream; function path(object) { if (object) { if (typeof pointRadius === "function") contextStream.pointRadius(+pointRadius.apply(this, arguments)); if (!cacheStream || !cacheStream.valid) cacheStream = projectStream(contextStream); d3.geo.stream(object, cacheStream); } return contextStream.result(); } path.area = function(object) { d3_geo_pathAreaSum = 0; d3.geo.stream(object, projectStream(d3_geo_pathArea)); return d3_geo_pathAreaSum; }; path.centroid = function(object) { d3_geo_centroidX0 = d3_geo_centroidY0 = d3_geo_centroidZ0 = d3_geo_centroidX1 = d3_geo_centroidY1 = d3_geo_centroidZ1 = d3_geo_centroidX2 = d3_geo_centroidY2 = d3_geo_centroidZ2 = 0; d3.geo.stream(object, projectStream(d3_geo_pathCentroid)); return d3_geo_centroidZ2 ? [ d3_geo_centroidX2 / d3_geo_centroidZ2, d3_geo_centroidY2 / d3_geo_centroidZ2 ] : d3_geo_centroidZ1 ? [ d3_geo_centroidX1 / d3_geo_centroidZ1, d3_geo_centroidY1 / d3_geo_centroidZ1 ] : d3_geo_centroidZ0 ? [ d3_geo_centroidX0 / d3_geo_centroidZ0, d3_geo_centroidY0 / d3_geo_centroidZ0 ] : [ NaN, NaN ]; }; path.bounds = function(object) { d3_geo_pathBoundsX1 = d3_geo_pathBoundsY1 = -(d3_geo_pathBoundsX0 = d3_geo_pathBoundsY0 = Infinity); d3.geo.stream(object, projectStream(d3_geo_pathBounds)); return [ [ d3_geo_pathBoundsX0, d3_geo_pathBoundsY0 ], [ d3_geo_pathBoundsX1, d3_geo_pathBoundsY1 ] ]; }; path.projection = function(_) { if (!arguments.length) return projection; projectStream = (projection = _) ? _.stream || d3_geo_pathProjectStream(_) : d3_identity; return reset(); }; path.context = function(_) { if (!arguments.length) return context; contextStream = (context = _) == null ? new d3_geo_pathBuffer() : new d3_geo_pathContext(_); if (typeof pointRadius !== "function") contextStream.pointRadius(pointRadius); return reset(); }; path.pointRadius = function(_) { if (!arguments.length) return pointRadius; pointRadius = typeof _ === "function" ? _ : (contextStream.pointRadius(+_), +_); return path; }; function reset() { cacheStream = null; return path; } return path.projection(d3.geo.albersUsa()).context(null); }; function d3_geo_pathProjectStream(project) { var resample = d3_geo_resample(function(x, y) { return project([ x * d3_degrees, y * d3_degrees ]); }); return function(stream) { return d3_geo_projectionRadians(resample(stream)); }; } d3.geo.transform = function(methods) { return { stream: function(stream) { var transform = new d3_geo_transform(stream); for (var k in methods) transform[k] = methods[k]; return transform; } }; }; function d3_geo_transform(stream) { this.stream = stream; } d3_geo_transform.prototype = { point: function(x, y) { this.stream.point(x, y); }, sphere: function() { this.stream.sphere(); }, lineStart: function() { this.stream.lineStart(); }, lineEnd: function() { this.stream.lineEnd(); }, polygonStart: function() { this.stream.polygonStart(); }, polygonEnd: function() { this.stream.polygonEnd(); } }; function d3_geo_transformPoint(stream, point) { return { point: point, sphere: function() { stream.sphere(); }, lineStart: function() { stream.lineStart(); }, lineEnd: function() { stream.lineEnd(); }, polygonStart: function() { stream.polygonStart(); }, polygonEnd: function() { stream.polygonEnd(); } }; } d3.geo.projection = d3_geo_projection; d3.geo.projectionMutator = d3_geo_projectionMutator; function d3_geo_projection(project) { return d3_geo_projectionMutator(function() { return project; })(); } function d3_geo_projectionMutator(projectAt) { var project, rotate, projectRotate, projectResample = d3_geo_resample(function(x, y) { x = project(x, y); return [ x[0] * k + δx, δy - x[1] * k ]; }), k = 150, x = 480, y = 250, λ = 0, φ = 0, δλ = 0, δφ = 0, δγ = 0, δx, δy, preclip = d3_geo_clipAntimeridian, postclip = d3_identity, clipAngle = null, clipExtent = null, stream; function projection(point) { point = projectRotate(point[0] * d3_radians, point[1] * d3_radians); return [ point[0] * k + δx, δy - point[1] * k ]; } function invert(point) { point = projectRotate.invert((point[0] - δx) / k, (δy - point[1]) / k); return point && [ point[0] * d3_degrees, point[1] * d3_degrees ]; } projection.stream = function(output) { if (stream) stream.valid = false; stream = d3_geo_projectionRadians(preclip(rotate, projectResample(postclip(output)))); stream.valid = true; return stream; }; projection.clipAngle = function(_) { if (!arguments.length) return clipAngle; preclip = _ == null ? (clipAngle = _, d3_geo_clipAntimeridian) : d3_geo_clipCircle((clipAngle = +_) * d3_radians); return invalidate(); }; projection.clipExtent = function(_) { if (!arguments.length) return clipExtent; clipExtent = _; postclip = _ ? d3_geo_clipExtent(_[0][0], _[0][1], _[1][0], _[1][1]) : d3_identity; return invalidate(); }; projection.scale = function(_) { if (!arguments.length) return k; k = +_; return reset(); }; projection.translate = function(_) { if (!arguments.length) return [ x, y ]; x = +_[0]; y = +_[1]; return reset(); }; projection.center = function(_) { if (!arguments.length) return [ λ * d3_degrees, φ * d3_degrees ]; λ = _[0] % 360 * d3_radians; φ = _[1] % 360 * d3_radians; return reset(); }; projection.rotate = function(_) { if (!arguments.length) return [ δλ * d3_degrees, δφ * d3_degrees, δγ * d3_degrees ]; δλ = _[0] % 360 * d3_radians; δφ = _[1] % 360 * d3_radians; δγ = _.length > 2 ? _[2] % 360 * d3_radians : 0; return reset(); }; d3.rebind(projection, projectResample, "precision"); function reset() { projectRotate = d3_geo_compose(rotate = d3_geo_rotation(δλ, δφ, δγ), project); var center = project(λ, φ); δx = x - center[0] * k; δy = y + center[1] * k; return invalidate(); } function invalidate() { if (stream) stream.valid = false, stream = null; return projection; } return function() { project = projectAt.apply(this, arguments); projection.invert = project.invert && invert; return reset(); }; } function d3_geo_projectionRadians(stream) { return d3_geo_transformPoint(stream, function(x, y) { stream.point(x * d3_radians, y * d3_radians); }); } function d3_geo_equirectangular(λ, φ) { return [ λ, φ ]; } (d3.geo.equirectangular = function() { return d3_geo_projection(d3_geo_equirectangular); }).raw = d3_geo_equirectangular.invert = d3_geo_equirectangular; d3.geo.rotation = function(rotate) { rotate = d3_geo_rotation(rotate[0] % 360 * d3_radians, rotate[1] * d3_radians, rotate.length > 2 ? rotate[2] * d3_radians : 0); function forward(coordinates) { coordinates = rotate(coordinates[0] * d3_radians, coordinates[1] * d3_radians); return coordinates[0] *= d3_degrees, coordinates[1] *= d3_degrees, coordinates; } forward.invert = function(coordinates) { coordinates = rotate.invert(coordinates[0] * d3_radians, coordinates[1] * d3_radians); return coordinates[0] *= d3_degrees, coordinates[1] *= d3_degrees, coordinates; }; return forward; }; function d3_geo_identityRotation(λ, φ) { return [ λ > π ? λ - τ : λ < -π ? λ + τ : λ, φ ]; } d3_geo_identityRotation.invert = d3_geo_equirectangular; function d3_geo_rotation(δλ, δφ, δγ) { return δλ ? δφ || δγ ? d3_geo_compose(d3_geo_rotationλ(δλ), d3_geo_rotationφγ(δφ, δγ)) : d3_geo_rotationλ(δλ) : δφ || δγ ? d3_geo_rotationφγ(δφ, δγ) : d3_geo_identityRotation; } function d3_geo_forwardRotationλ(δλ) { return function(λ, φ) { return λ += δλ, [ λ > π ? λ - τ : λ < -π ? λ + τ : λ, φ ]; }; } function d3_geo_rotationλ(δλ) { var rotation = d3_geo_forwardRotationλ(δλ); rotation.invert = d3_geo_forwardRotationλ(-δλ); return rotation; } function d3_geo_rotationφγ(δφ, δγ) { var cosδφ = Math.cos(δφ), sinδφ = Math.sin(δφ), cosδγ = Math.cos(δγ), sinδγ = Math.sin(δγ); function rotation(λ, φ) { var cosφ = Math.cos(φ), x = Math.cos(λ) * cosφ, y = Math.sin(λ) * cosφ, z = Math.sin(φ), k = z * cosδφ + x * sinδφ; return [ Math.atan2(y * cosδγ - k * sinδγ, x * cosδφ - z * sinδφ), d3_asin(k * cosδγ + y * sinδγ) ]; } rotation.invert = function(λ, φ) { var cosφ = Math.cos(φ), x = Math.cos(λ) * cosφ, y = Math.sin(λ) * cosφ, z = Math.sin(φ), k = z * cosδγ - y * sinδγ; return [ Math.atan2(y * cosδγ + z * sinδγ, x * cosδφ + k * sinδφ), d3_asin(k * cosδφ - x * sinδφ) ]; }; return rotation; } d3.geo.circle = function() { var origin = [ 0, 0 ], angle, precision = 6, interpolate; function circle() { var center = typeof origin === "function" ? origin.apply(this, arguments) : origin, rotate = d3_geo_rotation(-center[0] * d3_radians, -center[1] * d3_radians, 0).invert, ring = []; interpolate(null, null, 1, { point: function(x, y) { ring.push(x = rotate(x, y)); x[0] *= d3_degrees, x[1] *= d3_degrees; } }); return { type: "Polygon", coordinates: [ ring ] }; } circle.origin = function(x) { if (!arguments.length) return origin; origin = x; return circle; }; circle.angle = function(x) { if (!arguments.length) return angle; interpolate = d3_geo_circleInterpolate((angle = +x) * d3_radians, precision * d3_radians); return circle; }; circle.precision = function(_) { if (!arguments.length) return precision; interpolate = d3_geo_circleInterpolate(angle * d3_radians, (precision = +_) * d3_radians); return circle; }; return circle.angle(90); }; function d3_geo_circleInterpolate(radius, precision) { var cr = Math.cos(radius), sr = Math.sin(radius); return function(from, to, direction, listener) { var step = direction * precision; if (from != null) { from = d3_geo_circleAngle(cr, from); to = d3_geo_circleAngle(cr, to); if (direction > 0 ? from < to : from > to) from += direction * τ; } else { from = radius + direction * τ; to = radius - .5 * step; } for (var point, t = from; direction > 0 ? t > to : t < to; t -= step) { listener.point((point = d3_geo_spherical([ cr, -sr * Math.cos(t), -sr * Math.sin(t) ]))[0], point[1]); } }; } function d3_geo_circleAngle(cr, point) { var a = d3_geo_cartesian(point); a[0] -= cr; d3_geo_cartesianNormalize(a); var angle = d3_acos(-a[1]); return ((-a[2] < 0 ? -angle : angle) + 2 * Math.PI - ε) % (2 * Math.PI); } d3.geo.distance = function(a, b) { var Δλ = (b[0] - a[0]) * d3_radians, φ0 = a[1] * d3_radians, φ1 = b[1] * d3_radians, sinΔλ = Math.sin(Δλ), cosΔλ = Math.cos(Δλ), sinφ0 = Math.sin(φ0), cosφ0 = Math.cos(φ0), sinφ1 = Math.sin(φ1), cosφ1 = Math.cos(φ1), t; return Math.atan2(Math.sqrt((t = cosφ1 * sinΔλ) * t + (t = cosφ0 * sinφ1 - sinφ0 * cosφ1 * cosΔλ) * t), sinφ0 * sinφ1 + cosφ0 * cosφ1 * cosΔλ); }; d3.geo.graticule = function() { var x1, x0, X1, X0, y1, y0, Y1, Y0, dx = 10, dy = dx, DX = 90, DY = 360, x, y, X, Y, precision = 2.5; function graticule() { return { type: "MultiLineString", coordinates: lines() }; } function lines() { return d3.range(Math.ceil(X0 / DX) * DX, X1, DX).map(X).concat(d3.range(Math.ceil(Y0 / DY) * DY, Y1, DY).map(Y)).concat(d3.range(Math.ceil(x0 / dx) * dx, x1, dx).filter(function(x) { return abs(x % DX) > ε; }).map(x)).concat(d3.range(Math.ceil(y0 / dy) * dy, y1, dy).filter(function(y) { return abs(y % DY) > ε; }).map(y)); } graticule.lines = function() { return lines().map(function(coordinates) { return { type: "LineString", coordinates: coordinates }; }); }; graticule.outline = function() { return { type: "Polygon", coordinates: [ X(X0).concat(Y(Y1).slice(1), X(X1).reverse().slice(1), Y(Y0).reverse().slice(1)) ] }; }; graticule.extent = function(_) { if (!arguments.length) return graticule.minorExtent(); return graticule.majorExtent(_).minorExtent(_); }; graticule.majorExtent = function(_) { if (!arguments.length) return [ [ X0, Y0 ], [ X1, Y1 ] ]; X0 = +_[0][0], X1 = +_[1][0]; Y0 = +_[0][1], Y1 = +_[1][1]; if (X0 > X1) _ = X0, X0 = X1, X1 = _; if (Y0 > Y1) _ = Y0, Y0 = Y1, Y1 = _; return graticule.precision(precision); }; graticule.minorExtent = function(_) { if (!arguments.length) return [ [ x0, y0 ], [ x1, y1 ] ]; x0 = +_[0][0], x1 = +_[1][0]; y0 = +_[0][1], y1 = +_[1][1]; if (x0 > x1) _ = x0, x0 = x1, x1 = _; if (y0 > y1) _ = y0, y0 = y1, y1 = _; return graticule.precision(precision); }; graticule.step = function(_) { if (!arguments.length) return graticule.minorStep(); return graticule.majorStep(_).minorStep(_); }; graticule.majorStep = function(_) { if (!arguments.length) return [ DX, DY ]; DX = +_[0], DY = +_[1]; return graticule; }; graticule.minorStep = function(_) { if (!arguments.length) return [ dx, dy ]; dx = +_[0], dy = +_[1]; return graticule; }; graticule.precision = function(_) { if (!arguments.length) return precision; precision = +_; x = d3_geo_graticuleX(y0, y1, 90); y = d3_geo_graticuleY(x0, x1, precision); X = d3_geo_graticuleX(Y0, Y1, 90); Y = d3_geo_graticuleY(X0, X1, precision); return graticule; }; return graticule.majorExtent([ [ -180, -90 + ε ], [ 180, 90 - ε ] ]).minorExtent([ [ -180, -80 - ε ], [ 180, 80 + ε ] ]); }; function d3_geo_graticuleX(y0, y1, dy) { var y = d3.range(y0, y1 - ε, dy).concat(y1); return function(x) { return y.map(function(y) { return [ x, y ]; }); }; } function d3_geo_graticuleY(x0, x1, dx) { var x = d3.range(x0, x1 - ε, dx).concat(x1); return function(y) { return x.map(function(x) { return [ x, y ]; }); }; } function d3_source(d) { return d.source; } function d3_target(d) { return d.target; } d3.geo.greatArc = function() { var source = d3_source, source_, target = d3_target, target_; function greatArc() { return { type: "LineString", coordinates: [ source_ || source.apply(this, arguments), target_ || target.apply(this, arguments) ] }; } greatArc.distance = function() { return d3.geo.distance(source_ || source.apply(this, arguments), target_ || target.apply(this, arguments)); }; greatArc.source = function(_) { if (!arguments.length) return source; source = _, source_ = typeof _ === "function" ? null : _; return greatArc; }; greatArc.target = function(_) { if (!arguments.length) return target; target = _, target_ = typeof _ === "function" ? null : _; return greatArc; }; greatArc.precision = function() { return arguments.length ? greatArc : 0; }; return greatArc; }; d3.geo.interpolate = function(source, target) { return d3_geo_interpolate(source[0] * d3_radians, source[1] * d3_radians, target[0] * d3_radians, target[1] * d3_radians); }; function d3_geo_interpolate(x0, y0, x1, y1) { var cy0 = Math.cos(y0), sy0 = Math.sin(y0), cy1 = Math.cos(y1), sy1 = Math.sin(y1), kx0 = cy0 * Math.cos(x0), ky0 = cy0 * Math.sin(x0), kx1 = cy1 * Math.cos(x1), ky1 = cy1 * Math.sin(x1), d = 2 * Math.asin(Math.sqrt(d3_haversin(y1 - y0) + cy0 * cy1 * d3_haversin(x1 - x0))), k = 1 / Math.sin(d); var interpolate = d ? function(t) { var B = Math.sin(t *= d) * k, A = Math.sin(d - t) * k, x = A * kx0 + B * kx1, y = A * ky0 + B * ky1, z = A * sy0 + B * sy1; return [ Math.atan2(y, x) * d3_degrees, Math.atan2(z, Math.sqrt(x * x + y * y)) * d3_degrees ]; } : function() { return [ x0 * d3_degrees, y0 * d3_degrees ]; }; interpolate.distance = d; return interpolate; } d3.geo.length = function(object) { d3_geo_lengthSum = 0; d3.geo.stream(object, d3_geo_length); return d3_geo_lengthSum; }; var d3_geo_lengthSum; var d3_geo_length = { sphere: d3_noop, point: d3_noop, lineStart: d3_geo_lengthLineStart, lineEnd: d3_noop, polygonStart: d3_noop, polygonEnd: d3_noop }; function d3_geo_lengthLineStart() { var λ0, sinφ0, cosφ0; d3_geo_length.point = function(λ, φ) { λ0 = λ * d3_radians, sinφ0 = Math.sin(φ *= d3_radians), cosφ0 = Math.cos(φ); d3_geo_length.point = nextPoint; }; d3_geo_length.lineEnd = function() { d3_geo_length.point = d3_geo_length.lineEnd = d3_noop; }; function nextPoint(λ, φ) { var sinφ = Math.sin(φ *= d3_radians), cosφ = Math.cos(φ), t = abs((λ *= d3_radians) - λ0), cosΔλ = Math.cos(t); d3_geo_lengthSum += Math.atan2(Math.sqrt((t = cosφ * Math.sin(t)) * t + (t = cosφ0 * sinφ - sinφ0 * cosφ * cosΔλ) * t), sinφ0 * sinφ + cosφ0 * cosφ * cosΔλ); λ0 = λ, sinφ0 = sinφ, cosφ0 = cosφ; } } function d3_geo_azimuthal(scale, angle) { function azimuthal(λ, φ) { var cosλ = Math.cos(λ), cosφ = Math.cos(φ), k = scale(cosλ * cosφ); return [ k * cosφ * Math.sin(λ), k * Math.sin(φ) ]; } azimuthal.invert = function(x, y) { var ρ = Math.sqrt(x * x + y * y), c = angle(ρ), sinc = Math.sin(c), cosc = Math.cos(c); return [ Math.atan2(x * sinc, ρ * cosc), Math.asin(ρ && y * sinc / ρ) ]; }; return azimuthal; } var d3_geo_azimuthalEqualArea = d3_geo_azimuthal(function(cosλcosφ) { return Math.sqrt(2 / (1 + cosλcosφ)); }, function(ρ) { return 2 * Math.asin(ρ / 2); }); (d3.geo.azimuthalEqualArea = function() { return d3_geo_projection(d3_geo_azimuthalEqualArea); }).raw = d3_geo_azimuthalEqualArea; var d3_geo_azimuthalEquidistant = d3_geo_azimuthal(function(cosλcosφ) { var c = Math.acos(cosλcosφ); return c && c / Math.sin(c); }, d3_identity); (d3.geo.azimuthalEquidistant = function() { return d3_geo_projection(d3_geo_azimuthalEquidistant); }).raw = d3_geo_azimuthalEquidistant; function d3_geo_conicConformal(φ0, φ1) { var cosφ0 = Math.cos(φ0), t = function(φ) { return Math.tan(π / 4 + φ / 2); }, n = φ0 === φ1 ? Math.sin(φ0) : Math.log(cosφ0 / Math.cos(φ1)) / Math.log(t(φ1) / t(φ0)), F = cosφ0 * Math.pow(t(φ0), n) / n; if (!n) return d3_geo_mercator; function forward(λ, φ) { if (F > 0) { if (φ < -halfπ + ε) φ = -halfπ + ε; } else { if (φ > halfπ - ε) φ = halfπ - ε; } var ρ = F / Math.pow(t(φ), n); return [ ρ * Math.sin(n * λ), F - ρ * Math.cos(n * λ) ]; } forward.invert = function(x, y) { var ρ0_y = F - y, ρ = d3_sgn(n) * Math.sqrt(x * x + ρ0_y * ρ0_y); return [ Math.atan2(x, ρ0_y) / n, 2 * Math.atan(Math.pow(F / ρ, 1 / n)) - halfπ ]; }; return forward; } (d3.geo.conicConformal = function() { return d3_geo_conic(d3_geo_conicConformal); }).raw = d3_geo_conicConformal; function d3_geo_conicEquidistant(φ0, φ1) { var cosφ0 = Math.cos(φ0), n = φ0 === φ1 ? Math.sin(φ0) : (cosφ0 - Math.cos(φ1)) / (φ1 - φ0), G = cosφ0 / n + φ0; if (abs(n) < ε) return d3_geo_equirectangular; function forward(λ, φ) { var ρ = G - φ; return [ ρ * Math.sin(n * λ), G - ρ * Math.cos(n * λ) ]; } forward.invert = function(x, y) { var ρ0_y = G - y; return [ Math.atan2(x, ρ0_y) / n, G - d3_sgn(n) * Math.sqrt(x * x + ρ0_y * ρ0_y) ]; }; return forward; } (d3.geo.conicEquidistant = function() { return d3_geo_conic(d3_geo_conicEquidistant); }).raw = d3_geo_conicEquidistant; var d3_geo_gnomonic = d3_geo_azimuthal(function(cosλcosφ) { return 1 / cosλcosφ; }, Math.atan); (d3.geo.gnomonic = function() { return d3_geo_projection(d3_geo_gnomonic); }).raw = d3_geo_gnomonic; function d3_geo_mercator(λ, φ) { return [ λ, Math.log(Math.tan(π / 4 + φ / 2)) ]; } d3_geo_mercator.invert = function(x, y) { return [ x, 2 * Math.atan(Math.exp(y)) - halfπ ]; }; function d3_geo_mercatorProjection(project) { var m = d3_geo_projection(project), scale = m.scale, translate = m.translate, clipExtent = m.clipExtent, clipAuto; m.scale = function() { var v = scale.apply(m, arguments); return v === m ? clipAuto ? m.clipExtent(null) : m : v; }; m.translate = function() { var v = translate.apply(m, arguments); return v === m ? clipAuto ? m.clipExtent(null) : m : v; }; m.clipExtent = function(_) { var v = clipExtent.apply(m, arguments); if (v === m) { if (clipAuto = _ == null) { var k = π * scale(), t = translate(); clipExtent([ [ t[0] - k, t[1] - k ], [ t[0] + k, t[1] + k ] ]); } } else if (clipAuto) { v = null; } return v; }; return m.clipExtent(null); } (d3.geo.mercator = function() { return d3_geo_mercatorProjection(d3_geo_mercator); }).raw = d3_geo_mercator; var d3_geo_orthographic = d3_geo_azimuthal(function() { return 1; }, Math.asin); (d3.geo.orthographic = function() { return d3_geo_projection(d3_geo_orthographic); }).raw = d3_geo_orthographic; var d3_geo_stereographic = d3_geo_azimuthal(function(cosλcosφ) { return 1 / (1 + cosλcosφ); }, function(ρ) { return 2 * Math.atan(ρ); }); (d3.geo.stereographic = function() { return d3_geo_projection(d3_geo_stereographic); }).raw = d3_geo_stereographic; function d3_geo_transverseMercator(λ, φ) { return [ Math.log(Math.tan(π / 4 + φ / 2)), -λ ]; } d3_geo_transverseMercator.invert = function(x, y) { return [ -y, 2 * Math.atan(Math.exp(x)) - halfπ ]; }; (d3.geo.transverseMercator = function() { var projection = d3_geo_mercatorProjection(d3_geo_transverseMercator), center = projection.center, rotate = projection.rotate; projection.center = function(_) { return _ ? center([ -_[1], _[0] ]) : (_ = center(), [ _[1], -_[0] ]); }; projection.rotate = function(_) { return _ ? rotate([ _[0], _[1], _.length > 2 ? _[2] + 90 : 90 ]) : (_ = rotate(), [ _[0], _[1], _[2] - 90 ]); }; return rotate([ 0, 0, 90 ]); }).raw = d3_geo_transverseMercator; d3.geom = {}; function d3_geom_pointX(d) { return d[0]; } function d3_geom_pointY(d) { return d[1]; } d3.geom.hull = function(vertices) { var x = d3_geom_pointX, y = d3_geom_pointY; if (arguments.length) return hull(vertices); function hull(data) { if (data.length < 3) return []; var fx = d3_functor(x), fy = d3_functor(y), i, n = data.length, points = [], flippedPoints = []; for (i = 0; i < n; i++) { points.push([ +fx.call(this, data[i], i), +fy.call(this, data[i], i), i ]); } points.sort(d3_geom_hullOrder); for (i = 0; i < n; i++) flippedPoints.push([ points[i][0], -points[i][1] ]); var upper = d3_geom_hullUpper(points), lower = d3_geom_hullUpper(flippedPoints); var skipLeft = lower[0] === upper[0], skipRight = lower[lower.length - 1] === upper[upper.length - 1], polygon = []; for (i = upper.length - 1; i >= 0; --i) polygon.push(data[points[upper[i]][2]]); for (i = +skipLeft; i < lower.length - skipRight; ++i) polygon.push(data[points[lower[i]][2]]); return polygon; } hull.x = function(_) { return arguments.length ? (x = _, hull) : x; }; hull.y = function(_) { return arguments.length ? (y = _, hull) : y; }; return hull; }; function d3_geom_hullUpper(points) { var n = points.length, hull = [ 0, 1 ], hs = 2; for (var i = 2; i < n; i++) { while (hs > 1 && d3_cross2d(points[hull[hs - 2]], points[hull[hs - 1]], points[i]) <= 0) --hs; hull[hs++] = i; } return hull.slice(0, hs); } function d3_geom_hullOrder(a, b) { return a[0] - b[0] || a[1] - b[1]; } d3.geom.polygon = function(coordinates) { d3_subclass(coordinates, d3_geom_polygonPrototype); return coordinates; }; var d3_geom_polygonPrototype = d3.geom.polygon.prototype = []; d3_geom_polygonPrototype.area = function() { var i = -1, n = this.length, a, b = this[n - 1], area = 0; while (++i < n) { a = b; b = this[i]; area += a[1] * b[0] - a[0] * b[1]; } return area * .5; }; d3_geom_polygonPrototype.centroid = function(k) { var i = -1, n = this.length, x = 0, y = 0, a, b = this[n - 1], c; if (!arguments.length) k = -1 / (6 * this.area()); while (++i < n) { a = b; b = this[i]; c = a[0] * b[1] - b[0] * a[1]; x += (a[0] + b[0]) * c; y += (a[1] + b[1]) * c; } return [ x * k, y * k ]; }; d3_geom_polygonPrototype.clip = function(subject) { var input, closed = d3_geom_polygonClosed(subject), i = -1, n = this.length - d3_geom_polygonClosed(this), j, m, a = this[n - 1], b, c, d; while (++i < n) { input = subject.slice(); subject.length = 0; b = this[i]; c = input[(m = input.length - closed) - 1]; j = -1; while (++j < m) { d = input[j]; if (d3_geom_polygonInside(d, a, b)) { if (!d3_geom_polygonInside(c, a, b)) { subject.push(d3_geom_polygonIntersect(c, d, a, b)); } subject.push(d); } else if (d3_geom_polygonInside(c, a, b)) { subject.push(d3_geom_polygonIntersect(c, d, a, b)); } c = d; } if (closed) subject.push(subject[0]); a = b; } return subject; }; function d3_geom_polygonInside(p, a, b) { return (b[0] - a[0]) * (p[1] - a[1]) < (b[1] - a[1]) * (p[0] - a[0]); } function d3_geom_polygonIntersect(c, d, a, b) { var x1 = c[0], x3 = a[0], x21 = d[0] - x1, x43 = b[0] - x3, y1 = c[1], y3 = a[1], y21 = d[1] - y1, y43 = b[1] - y3, ua = (x43 * (y1 - y3) - y43 * (x1 - x3)) / (y43 * x21 - x43 * y21); return [ x1 + ua * x21, y1 + ua * y21 ]; } function d3_geom_polygonClosed(coordinates) { var a = coordinates[0], b = coordinates[coordinates.length - 1]; return !(a[0] - b[0] || a[1] - b[1]); } var d3_geom_voronoiEdges, d3_geom_voronoiCells, d3_geom_voronoiBeaches, d3_geom_voronoiBeachPool = [], d3_geom_voronoiFirstCircle, d3_geom_voronoiCircles, d3_geom_voronoiCirclePool = []; function d3_geom_voronoiBeach() { d3_geom_voronoiRedBlackNode(this); this.edge = this.site = this.circle = null; } function d3_geom_voronoiCreateBeach(site) { var beach = d3_geom_voronoiBeachPool.pop() || new d3_geom_voronoiBeach(); beach.site = site; return beach; } function d3_geom_voronoiDetachBeach(beach) { d3_geom_voronoiDetachCircle(beach); d3_geom_voronoiBeaches.remove(beach); d3_geom_voronoiBeachPool.push(beach); d3_geom_voronoiRedBlackNode(beach); } function d3_geom_voronoiRemoveBeach(beach) { var circle = beach.circle, x = circle.x, y = circle.cy, vertex = { x: x, y: y }, previous = beach.P, next = beach.N, disappearing = [ beach ]; d3_geom_voronoiDetachBeach(beach); var lArc = previous; while (lArc.circle && abs(x - lArc.circle.x) < ε && abs(y - lArc.circle.cy) < ε) { previous = lArc.P; disappearing.unshift(lArc); d3_geom_voronoiDetachBeach(lArc); lArc = previous; } disappearing.unshift(lArc); d3_geom_voronoiDetachCircle(lArc); var rArc = next; while (rArc.circle && abs(x - rArc.circle.x) < ε && abs(y - rArc.circle.cy) < ε) { next = rArc.N; disappearing.push(rArc); d3_geom_voronoiDetachBeach(rArc); rArc = next; } disappearing.push(rArc); d3_geom_voronoiDetachCircle(rArc); var nArcs = disappearing.length, iArc; for (iArc = 1; iArc < nArcs; ++iArc) { rArc = disappearing[iArc]; lArc = disappearing[iArc - 1]; d3_geom_voronoiSetEdgeEnd(rArc.edge, lArc.site, rArc.site, vertex); } lArc = disappearing[0]; rArc = disappearing[nArcs - 1]; rArc.edge = d3_geom_voronoiCreateEdge(lArc.site, rArc.site, null, vertex); d3_geom_voronoiAttachCircle(lArc); d3_geom_voronoiAttachCircle(rArc); } function d3_geom_voronoiAddBeach(site) { var x = site.x, directrix = site.y, lArc, rArc, dxl, dxr, node = d3_geom_voronoiBeaches._; while (node) { dxl = d3_geom_voronoiLeftBreakPoint(node, directrix) - x; if (dxl > ε) node = node.L; else { dxr = x - d3_geom_voronoiRightBreakPoint(node, directrix); if (dxr > ε) { if (!node.R) { lArc = node; break; } node = node.R; } else { if (dxl > -ε) { lArc = node.P; rArc = node; } else if (dxr > -ε) { lArc = node; rArc = node.N; } else { lArc = rArc = node; } break; } } } var newArc = d3_geom_voronoiCreateBeach(site); d3_geom_voronoiBeaches.insert(lArc, newArc); if (!lArc && !rArc) return; if (lArc === rArc) { d3_geom_voronoiDetachCircle(lArc); rArc = d3_geom_voronoiCreateBeach(lArc.site); d3_geom_voronoiBeaches.insert(newArc, rArc); newArc.edge = rArc.edge = d3_geom_voronoiCreateEdge(lArc.site, newArc.site); d3_geom_voronoiAttachCircle(lArc); d3_geom_voronoiAttachCircle(rArc); return; } if (!rArc) { newArc.edge = d3_geom_voronoiCreateEdge(lArc.site, newArc.site); return; } d3_geom_voronoiDetachCircle(lArc); d3_geom_voronoiDetachCircle(rArc); var lSite = lArc.site, ax = lSite.x, ay = lSite.y, bx = site.x - ax, by = site.y - ay, rSite = rArc.site, cx = rSite.x - ax, cy = rSite.y - ay, d = 2 * (bx * cy - by * cx), hb = bx * bx + by * by, hc = cx * cx + cy * cy, vertex = { x: (cy * hb - by * hc) / d + ax, y: (bx * hc - cx * hb) / d + ay }; d3_geom_voronoiSetEdgeEnd(rArc.edge, lSite, rSite, vertex); newArc.edge = d3_geom_voronoiCreateEdge(lSite, site, null, vertex); rArc.edge = d3_geom_voronoiCreateEdge(site, rSite, null, vertex); d3_geom_voronoiAttachCircle(lArc); d3_geom_voronoiAttachCircle(rArc); } function d3_geom_voronoiLeftBreakPoint(arc, directrix) { var site = arc.site, rfocx = site.x, rfocy = site.y, pby2 = rfocy - directrix; if (!pby2) return rfocx; var lArc = arc.P; if (!lArc) return -Infinity; site = lArc.site; var lfocx = site.x, lfocy = site.y, plby2 = lfocy - directrix; if (!plby2) return lfocx; var hl = lfocx - rfocx, aby2 = 1 / pby2 - 1 / plby2, b = hl / plby2; if (aby2) return (-b + Math.sqrt(b * b - 2 * aby2 * (hl * hl / (-2 * plby2) - lfocy + plby2 / 2 + rfocy - pby2 / 2))) / aby2 + rfocx; return (rfocx + lfocx) / 2; } function d3_geom_voronoiRightBreakPoint(arc, directrix) { var rArc = arc.N; if (rArc) return d3_geom_voronoiLeftBreakPoint(rArc, directrix); var site = arc.site; return site.y === directrix ? site.x : Infinity; } function d3_geom_voronoiCell(site) { this.site = site; this.edges = []; } d3_geom_voronoiCell.prototype.prepare = function() { var halfEdges = this.edges, iHalfEdge = halfEdges.length, edge; while (iHalfEdge--) { edge = halfEdges[iHalfEdge].edge; if (!edge.b || !edge.a) halfEdges.splice(iHalfEdge, 1); } halfEdges.sort(d3_geom_voronoiHalfEdgeOrder); return halfEdges.length; }; function d3_geom_voronoiCloseCells(extent) { var x0 = extent[0][0], x1 = extent[1][0], y0 = extent[0][1], y1 = extent[1][1], x2, y2, x3, y3, cells = d3_geom_voronoiCells, iCell = cells.length, cell, iHalfEdge, halfEdges, nHalfEdges, start, end; while (iCell--) { cell = cells[iCell]; if (!cell || !cell.prepare()) continue; halfEdges = cell.edges; nHalfEdges = halfEdges.length; iHalfEdge = 0; while (iHalfEdge < nHalfEdges) { end = halfEdges[iHalfEdge].end(), x3 = end.x, y3 = end.y; start = halfEdges[++iHalfEdge % nHalfEdges].start(), x2 = start.x, y2 = start.y; if (abs(x3 - x2) > ε || abs(y3 - y2) > ε) { halfEdges.splice(iHalfEdge, 0, new d3_geom_voronoiHalfEdge(d3_geom_voronoiCreateBorderEdge(cell.site, end, abs(x3 - x0) < ε && y1 - y3 > ε ? { x: x0, y: abs(x2 - x0) < ε ? y2 : y1 } : abs(y3 - y1) < ε && x1 - x3 > ε ? { x: abs(y2 - y1) < ε ? x2 : x1, y: y1 } : abs(x3 - x1) < ε && y3 - y0 > ε ? { x: x1, y: abs(x2 - x1) < ε ? y2 : y0 } : abs(y3 - y0) < ε && x3 - x0 > ε ? { x: abs(y2 - y0) < ε ? x2 : x0, y: y0 } : null), cell.site, null)); ++nHalfEdges; } } } } function d3_geom_voronoiHalfEdgeOrder(a, b) { return b.angle - a.angle; } function d3_geom_voronoiCircle() { d3_geom_voronoiRedBlackNode(this); this.x = this.y = this.arc = this.site = this.cy = null; } function d3_geom_voronoiAttachCircle(arc) { var lArc = arc.P, rArc = arc.N; if (!lArc || !rArc) return; var lSite = lArc.site, cSite = arc.site, rSite = rArc.site; if (lSite === rSite) return; var bx = cSite.x, by = cSite.y, ax = lSite.x - bx, ay = lSite.y - by, cx = rSite.x - bx, cy = rSite.y - by; var d = 2 * (ax * cy - ay * cx); if (d >= -ε2) return; var ha = ax * ax + ay * ay, hc = cx * cx + cy * cy, x = (cy * ha - ay * hc) / d, y = (ax * hc - cx * ha) / d, cy = y + by; var circle = d3_geom_voronoiCirclePool.pop() || new d3_geom_voronoiCircle(); circle.arc = arc; circle.site = cSite; circle.x = x + bx; circle.y = cy + Math.sqrt(x * x + y * y); circle.cy = cy; arc.circle = circle; var before = null, node = d3_geom_voronoiCircles._; while (node) { if (circle.y < node.y || circle.y === node.y && circle.x <= node.x) { if (node.L) node = node.L; else { before = node.P; break; } } else { if (node.R) node = node.R; else { before = node; break; } } } d3_geom_voronoiCircles.insert(before, circle); if (!before) d3_geom_voronoiFirstCircle = circle; } function d3_geom_voronoiDetachCircle(arc) { var circle = arc.circle; if (circle) { if (!circle.P) d3_geom_voronoiFirstCircle = circle.N; d3_geom_voronoiCircles.remove(circle); d3_geom_voronoiCirclePool.push(circle); d3_geom_voronoiRedBlackNode(circle); arc.circle = null; } } function d3_geom_voronoiClipEdges(extent) { var edges = d3_geom_voronoiEdges, clip = d3_geom_clipLine(extent[0][0], extent[0][1], extent[1][0], extent[1][1]), i = edges.length, e; while (i--) { e = edges[i]; if (!d3_geom_voronoiConnectEdge(e, extent) || !clip(e) || abs(e.a.x - e.b.x) < ε && abs(e.a.y - e.b.y) < ε) { e.a = e.b = null; edges.splice(i, 1); } } } function d3_geom_voronoiConnectEdge(edge, extent) { var vb = edge.b; if (vb) return true; var va = edge.a, x0 = extent[0][0], x1 = extent[1][0], y0 = extent[0][1], y1 = extent[1][1], lSite = edge.l, rSite = edge.r, lx = lSite.x, ly = lSite.y, rx = rSite.x, ry = rSite.y, fx = (lx + rx) / 2, fy = (ly + ry) / 2, fm, fb; if (ry === ly) { if (fx < x0 || fx >= x1) return; if (lx > rx) { if (!va) va = { x: fx, y: y0 }; else if (va.y >= y1) return; vb = { x: fx, y: y1 }; } else { if (!va) va = { x: fx, y: y1 }; else if (va.y < y0) return; vb = { x: fx, y: y0 }; } } else { fm = (lx - rx) / (ry - ly); fb = fy - fm * fx; if (fm < -1 || fm > 1) { if (lx > rx) { if (!va) va = { x: (y0 - fb) / fm, y: y0 }; else if (va.y >= y1) return; vb = { x: (y1 - fb) / fm, y: y1 }; } else { if (!va) va = { x: (y1 - fb) / fm, y: y1 }; else if (va.y < y0) return; vb = { x: (y0 - fb) / fm, y: y0 }; } } else { if (ly < ry) { if (!va) va = { x: x0, y: fm * x0 + fb }; else if (va.x >= x1) return; vb = { x: x1, y: fm * x1 + fb }; } else { if (!va) va = { x: x1, y: fm * x1 + fb }; else if (va.x < x0) return; vb = { x: x0, y: fm * x0 + fb }; } } } edge.a = va; edge.b = vb; return true; } function d3_geom_voronoiEdge(lSite, rSite) { this.l = lSite; this.r = rSite; this.a = this.b = null; } function d3_geom_voronoiCreateEdge(lSite, rSite, va, vb) { var edge = new d3_geom_voronoiEdge(lSite, rSite); d3_geom_voronoiEdges.push(edge); if (va) d3_geom_voronoiSetEdgeEnd(edge, lSite, rSite, va); if (vb) d3_geom_voronoiSetEdgeEnd(edge, rSite, lSite, vb); d3_geom_voronoiCells[lSite.i].edges.push(new d3_geom_voronoiHalfEdge(edge, lSite, rSite)); d3_geom_voronoiCells[rSite.i].edges.push(new d3_geom_voronoiHalfEdge(edge, rSite, lSite)); return edge; } function d3_geom_voronoiCreateBorderEdge(lSite, va, vb) { var edge = new d3_geom_voronoiEdge(lSite, null); edge.a = va; edge.b = vb; d3_geom_voronoiEdges.push(edge); return edge; } function d3_geom_voronoiSetEdgeEnd(edge, lSite, rSite, vertex) { if (!edge.a && !edge.b) { edge.a = vertex; edge.l = lSite; edge.r = rSite; } else if (edge.l === rSite) { edge.b = vertex; } else { edge.a = vertex; } } function d3_geom_voronoiHalfEdge(edge, lSite, rSite) { var va = edge.a, vb = edge.b; this.edge = edge; this.site = lSite; this.angle = rSite ? Math.atan2(rSite.y - lSite.y, rSite.x - lSite.x) : edge.l === lSite ? Math.atan2(vb.x - va.x, va.y - vb.y) : Math.atan2(va.x - vb.x, vb.y - va.y); } d3_geom_voronoiHalfEdge.prototype = { start: function() { return this.edge.l === this.site ? this.edge.a : this.edge.b; }, end: function() { return this.edge.l === this.site ? this.edge.b : this.edge.a; } }; function d3_geom_voronoiRedBlackTree() { this._ = null; } function d3_geom_voronoiRedBlackNode(node) { node.U = node.C = node.L = node.R = node.P = node.N = null; } d3_geom_voronoiRedBlackTree.prototype = { insert: function(after, node) { var parent, grandpa, uncle; if (after) { node.P = after; node.N = after.N; if (after.N) after.N.P = node; after.N = node; if (after.R) { after = after.R; while (after.L) after = after.L; after.L = node; } else { after.R = node; } parent = after; } else if (this._) { after = d3_geom_voronoiRedBlackFirst(this._); node.P = null; node.N = after; after.P = after.L = node; parent = after; } else { node.P = node.N = null; this._ = node; parent = null; } node.L = node.R = null; node.U = parent; node.C = true; after = node; while (parent && parent.C) { grandpa = parent.U; if (parent === grandpa.L) { uncle = grandpa.R; if (uncle && uncle.C) { parent.C = uncle.C = false; grandpa.C = true; after = grandpa; } else { if (after === parent.R) { d3_geom_voronoiRedBlackRotateLeft(this, parent); after = parent; parent = after.U; } parent.C = false; grandpa.C = true; d3_geom_voronoiRedBlackRotateRight(this, grandpa); } } else { uncle = grandpa.L; if (uncle && uncle.C) { parent.C = uncle.C = false; grandpa.C = true; after = grandpa; } else { if (after === parent.L) { d3_geom_voronoiRedBlackRotateRight(this, parent); after = parent; parent = after.U; } parent.C = false; grandpa.C = true; d3_geom_voronoiRedBlackRotateLeft(this, grandpa); } } parent = after.U; } this._.C = false; }, remove: function(node) { if (node.N) node.N.P = node.P; if (node.P) node.P.N = node.N; node.N = node.P = null; var parent = node.U, sibling, left = node.L, right = node.R, next, red; if (!left) next = right; else if (!right) next = left; else next = d3_geom_voronoiRedBlackFirst(right); if (parent) { if (parent.L === node) parent.L = next; else parent.R = next; } else { this._ = next; } if (left && right) { red = next.C; next.C = node.C; next.L = left; left.U = next; if (next !== right) { parent = next.U; next.U = node.U; node = next.R; parent.L = node; next.R = right; right.U = next; } else { next.U = parent; parent = next; node = next.R; } } else { red = node.C; node = next; } if (node) node.U = parent; if (red) return; if (node && node.C) { node.C = false; return; } do { if (node === this._) break; if (node === parent.L) { sibling = parent.R; if (sibling.C) { sibling.C = false; parent.C = true; d3_geom_voronoiRedBlackRotateLeft(this, parent); sibling = parent.R; } if (sibling.L && sibling.L.C || sibling.R && sibling.R.C) { if (!sibling.R || !sibling.R.C) { sibling.L.C = false; sibling.C = true; d3_geom_voronoiRedBlackRotateRight(this, sibling); sibling = parent.R; } sibling.C = parent.C; parent.C = sibling.R.C = false; d3_geom_voronoiRedBlackRotateLeft(this, parent); node = this._; break; } } else { sibling = parent.L; if (sibling.C) { sibling.C = false; parent.C = true; d3_geom_voronoiRedBlackRotateRight(this, parent); sibling = parent.L; } if (sibling.L && sibling.L.C || sibling.R && sibling.R.C) { if (!sibling.L || !sibling.L.C) { sibling.R.C = false; sibling.C = true; d3_geom_voronoiRedBlackRotateLeft(this, sibling); sibling = parent.L; } sibling.C = parent.C; parent.C = sibling.L.C = false; d3_geom_voronoiRedBlackRotateRight(this, parent); node = this._; break; } } sibling.C = true; node = parent; parent = parent.U; } while (!node.C); if (node) node.C = false; } }; function d3_geom_voronoiRedBlackRotateLeft(tree, node) { var p = node, q = node.R, parent = p.U; if (parent) { if (parent.L === p) parent.L = q; else parent.R = q; } else { tree._ = q; } q.U = parent; p.U = q; p.R = q.L; if (p.R) p.R.U = p; q.L = p; } function d3_geom_voronoiRedBlackRotateRight(tree, node) { var p = node, q = node.L, parent = p.U; if (parent) { if (parent.L === p) parent.L = q; else parent.R = q; } else { tree._ = q; } q.U = parent; p.U = q; p.L = q.R; if (p.L) p.L.U = p; q.R = p; } function d3_geom_voronoiRedBlackFirst(node) { while (node.L) node = node.L; return node; } function d3_geom_voronoi(sites, bbox) { var site = sites.sort(d3_geom_voronoiVertexOrder).pop(), x0, y0, circle; d3_geom_voronoiEdges = []; d3_geom_voronoiCells = new Array(sites.length); d3_geom_voronoiBeaches = new d3_geom_voronoiRedBlackTree(); d3_geom_voronoiCircles = new d3_geom_voronoiRedBlackTree(); while (true) { circle = d3_geom_voronoiFirstCircle; if (site && (!circle || site.y < circle.y || site.y === circle.y && site.x < circle.x)) { if (site.x !== x0 || site.y !== y0) { d3_geom_voronoiCells[site.i] = new d3_geom_voronoiCell(site); d3_geom_voronoiAddBeach(site); x0 = site.x, y0 = site.y; } site = sites.pop(); } else if (circle) { d3_geom_voronoiRemoveBeach(circle.arc); } else { break; } } if (bbox) d3_geom_voronoiClipEdges(bbox), d3_geom_voronoiCloseCells(bbox); var diagram = { cells: d3_geom_voronoiCells, edges: d3_geom_voronoiEdges }; d3_geom_voronoiBeaches = d3_geom_voronoiCircles = d3_geom_voronoiEdges = d3_geom_voronoiCells = null; return diagram; } function d3_geom_voronoiVertexOrder(a, b) { return b.y - a.y || b.x - a.x; } d3.geom.voronoi = function(points) { var x = d3_geom_pointX, y = d3_geom_pointY, fx = x, fy = y, clipExtent = d3_geom_voronoiClipExtent; if (points) return voronoi(points); function voronoi(data) { var polygons = new Array(data.length), x0 = clipExtent[0][0], y0 = clipExtent[0][1], x1 = clipExtent[1][0], y1 = clipExtent[1][1]; d3_geom_voronoi(sites(data), clipExtent).cells.forEach(function(cell, i) { var edges = cell.edges, site = cell.site, polygon = polygons[i] = edges.length ? edges.map(function(e) { var s = e.start(); return [ s.x, s.y ]; }) : site.x >= x0 && site.x <= x1 && site.y >= y0 && site.y <= y1 ? [ [ x0, y1 ], [ x1, y1 ], [ x1, y0 ], [ x0, y0 ] ] : []; polygon.point = data[i]; }); return polygons; } function sites(data) { return data.map(function(d, i) { return { x: Math.round(fx(d, i) / ε) * ε, y: Math.round(fy(d, i) / ε) * ε, i: i }; }); } voronoi.links = function(data) { return d3_geom_voronoi(sites(data)).edges.filter(function(edge) { return edge.l && edge.r; }).map(function(edge) { return { source: data[edge.l.i], target: data[edge.r.i] }; }); }; voronoi.triangles = function(data) { var triangles = []; d3_geom_voronoi(sites(data)).cells.forEach(function(cell, i) { var site = cell.site, edges = cell.edges.sort(d3_geom_voronoiHalfEdgeOrder), j = -1, m = edges.length, e0, s0, e1 = edges[m - 1].edge, s1 = e1.l === site ? e1.r : e1.l; while (++j < m) { e0 = e1; s0 = s1; e1 = edges[j].edge; s1 = e1.l === site ? e1.r : e1.l; if (i < s0.i && i < s1.i && d3_geom_voronoiTriangleArea(site, s0, s1) < 0) { triangles.push([ data[i], data[s0.i], data[s1.i] ]); } } }); return triangles; }; voronoi.x = function(_) { return arguments.length ? (fx = d3_functor(x = _), voronoi) : x; }; voronoi.y = function(_) { return arguments.length ? (fy = d3_functor(y = _), voronoi) : y; }; voronoi.clipExtent = function(_) { if (!arguments.length) return clipExtent === d3_geom_voronoiClipExtent ? null : clipExtent; clipExtent = _ == null ? d3_geom_voronoiClipExtent : _; return voronoi; }; voronoi.size = function(_) { if (!arguments.length) return clipExtent === d3_geom_voronoiClipExtent ? null : clipExtent && clipExtent[1]; return voronoi.clipExtent(_ && [ [ 0, 0 ], _ ]); }; return voronoi; }; var d3_geom_voronoiClipExtent = [ [ -1e6, -1e6 ], [ 1e6, 1e6 ] ]; function d3_geom_voronoiTriangleArea(a, b, c) { return (a.x - c.x) * (b.y - a.y) - (a.x - b.x) * (c.y - a.y); } d3.geom.delaunay = function(vertices) { return d3.geom.voronoi().triangles(vertices); }; d3.geom.quadtree = function(points, x1, y1, x2, y2) { var x = d3_geom_pointX, y = d3_geom_pointY, compat; if (compat = arguments.length) { x = d3_geom_quadtreeCompatX; y = d3_geom_quadtreeCompatY; if (compat === 3) { y2 = y1; x2 = x1; y1 = x1 = 0; } return quadtree(points); } function quadtree(data) { var d, fx = d3_functor(x), fy = d3_functor(y), xs, ys, i, n, x1_, y1_, x2_, y2_; if (x1 != null) { x1_ = x1, y1_ = y1, x2_ = x2, y2_ = y2; } else { x2_ = y2_ = -(x1_ = y1_ = Infinity); xs = [], ys = []; n = data.length; if (compat) for (i = 0; i < n; ++i) { d = data[i]; if (d.x < x1_) x1_ = d.x; if (d.y < y1_) y1_ = d.y; if (d.x > x2_) x2_ = d.x; if (d.y > y2_) y2_ = d.y; xs.push(d.x); ys.push(d.y); } else for (i = 0; i < n; ++i) { var x_ = +fx(d = data[i], i), y_ = +fy(d, i); if (x_ < x1_) x1_ = x_; if (y_ < y1_) y1_ = y_; if (x_ > x2_) x2_ = x_; if (y_ > y2_) y2_ = y_; xs.push(x_); ys.push(y_); } } var dx = x2_ - x1_, dy = y2_ - y1_; if (dx > dy) y2_ = y1_ + dx; else x2_ = x1_ + dy; function insert(n, d, x, y, x1, y1, x2, y2) { if (isNaN(x) || isNaN(y)) return; if (n.leaf) { var nx = n.x, ny = n.y; if (nx != null) { if (abs(nx - x) + abs(ny - y) < .01) { insertChild(n, d, x, y, x1, y1, x2, y2); } else { var nPoint = n.point; n.x = n.y = n.point = null; insertChild(n, nPoint, nx, ny, x1, y1, x2, y2); insertChild(n, d, x, y, x1, y1, x2, y2); } } else { n.x = x, n.y = y, n.point = d; } } else { insertChild(n, d, x, y, x1, y1, x2, y2); } } function insertChild(n, d, x, y, x1, y1, x2, y2) { var xm = (x1 + x2) * .5, ym = (y1 + y2) * .5, right = x >= xm, below = y >= ym, i = below << 1 | right; n.leaf = false; n = n.nodes[i] || (n.nodes[i] = d3_geom_quadtreeNode()); if (right) x1 = xm; else x2 = xm; if (below) y1 = ym; else y2 = ym; insert(n, d, x, y, x1, y1, x2, y2); } var root = d3_geom_quadtreeNode(); root.add = function(d) { insert(root, d, +fx(d, ++i), +fy(d, i), x1_, y1_, x2_, y2_); }; root.visit = function(f) { d3_geom_quadtreeVisit(f, root, x1_, y1_, x2_, y2_); }; root.find = function(point) { return d3_geom_quadtreeFind(root, point[0], point[1], x1_, y1_, x2_, y2_); }; i = -1; if (x1 == null) { while (++i < n) { insert(root, data[i], xs[i], ys[i], x1_, y1_, x2_, y2_); } --i; } else data.forEach(root.add); xs = ys = data = d = null; return root; } quadtree.x = function(_) { return arguments.length ? (x = _, quadtree) : x; }; quadtree.y = function(_) { return arguments.length ? (y = _, quadtree) : y; }; quadtree.extent = function(_) { if (!arguments.length) return x1 == null ? null : [ [ x1, y1 ], [ x2, y2 ] ]; if (_ == null) x1 = y1 = x2 = y2 = null; else x1 = +_[0][0], y1 = +_[0][1], x2 = +_[1][0], y2 = +_[1][1]; return quadtree; }; quadtree.size = function(_) { if (!arguments.length) return x1 == null ? null : [ x2 - x1, y2 - y1 ]; if (_ == null) x1 = y1 = x2 = y2 = null; else x1 = y1 = 0, x2 = +_[0], y2 = +_[1]; return quadtree; }; return quadtree; }; function d3_geom_quadtreeCompatX(d) { return d.x; } function d3_geom_quadtreeCompatY(d) { return d.y; } function d3_geom_quadtreeNode() { return { leaf: true, nodes: [], point: null, x: null, y: null }; } function d3_geom_quadtreeVisit(f, node, x1, y1, x2, y2) { if (!f(node, x1, y1, x2, y2)) { var sx = (x1 + x2) * .5, sy = (y1 + y2) * .5, children = node.nodes; if (children[0]) d3_geom_quadtreeVisit(f, children[0], x1, y1, sx, sy); if (children[1]) d3_geom_quadtreeVisit(f, children[1], sx, y1, x2, sy); if (children[2]) d3_geom_quadtreeVisit(f, children[2], x1, sy, sx, y2); if (children[3]) d3_geom_quadtreeVisit(f, children[3], sx, sy, x2, y2); } } function d3_geom_quadtreeFind(root, x, y, x0, y0, x3, y3) { var minDistance2 = Infinity, closestPoint; (function find(node, x1, y1, x2, y2) { if (x1 > x3 || y1 > y3 || x2 < x0 || y2 < y0) return; if (point = node.point) { var point, dx = x - node.x, dy = y - node.y, distance2 = dx * dx + dy * dy; if (distance2 < minDistance2) { var distance = Math.sqrt(minDistance2 = distance2); x0 = x - distance, y0 = y - distance; x3 = x + distance, y3 = y + distance; closestPoint = point; } } var children = node.nodes, xm = (x1 + x2) * .5, ym = (y1 + y2) * .5, right = x >= xm, below = y >= ym; for (var i = below << 1 | right, j = i + 4; i < j; ++i) { if (node = children[i & 3]) switch (i & 3) { case 0: find(node, x1, y1, xm, ym); break; case 1: find(node, xm, y1, x2, ym); break; case 2: find(node, x1, ym, xm, y2); break; case 3: find(node, xm, ym, x2, y2); break; } } })(root, x0, y0, x3, y3); return closestPoint; } d3.interpolateRgb = d3_interpolateRgb; function d3_interpolateRgb(a, b) { a = d3.rgb(a); b = d3.rgb(b); var ar = a.r, ag = a.g, ab = a.b, br = b.r - ar, bg = b.g - ag, bb = b.b - ab; return function(t) { return "#" + d3_rgb_hex(Math.round(ar + br * t)) + d3_rgb_hex(Math.round(ag + bg * t)) + d3_rgb_hex(Math.round(ab + bb * t)); }; } d3.interpolateObject = d3_interpolateObject; function d3_interpolateObject(a, b) { var i = {}, c = {}, k; for (k in a) { if (k in b) { i[k] = d3_interpolate(a[k], b[k]); } else { c[k] = a[k]; } } for (k in b) { if (!(k in a)) { c[k] = b[k]; } } return function(t) { for (k in i) c[k] = i[k](t); return c; }; } d3.interpolateNumber = d3_interpolateNumber; function d3_interpolateNumber(a, b) { a = +a, b = +b; return function(t) { return a * (1 - t) + b * t; }; } d3.interpolateString = d3_interpolateString; function d3_interpolateString(a, b) { var bi = d3_interpolate_numberA.lastIndex = d3_interpolate_numberB.lastIndex = 0, am, bm, bs, i = -1, s = [], q = []; a = a + "", b = b + ""; while ((am = d3_interpolate_numberA.exec(a)) && (bm = d3_interpolate_numberB.exec(b))) { if ((bs = bm.index) > bi) { bs = b.slice(bi, bs); if (s[i]) s[i] += bs; else s[++i] = bs; } if ((am = am[0]) === (bm = bm[0])) { if (s[i]) s[i] += bm; else s[++i] = bm; } else { s[++i] = null; q.push({ i: i, x: d3_interpolateNumber(am, bm) }); } bi = d3_interpolate_numberB.lastIndex; } if (bi < b.length) { bs = b.slice(bi); if (s[i]) s[i] += bs; else s[++i] = bs; } return s.length < 2 ? q[0] ? (b = q[0].x, function(t) { return b(t) + ""; }) : function() { return b; } : (b = q.length, function(t) { for (var i = 0, o; i < b; ++i) s[(o = q[i]).i] = o.x(t); return s.join(""); }); } var d3_interpolate_numberA = /[-+]?(?:\d+\.?\d*|\.?\d+)(?:[eE][-+]?\d+)?/g, d3_interpolate_numberB = new RegExp(d3_interpolate_numberA.source, "g"); d3.interpolate = d3_interpolate; function d3_interpolate(a, b) { var i = d3.interpolators.length, f; while (--i >= 0 && !(f = d3.interpolators[i](a, b))) ; return f; } d3.interpolators = [ function(a, b) { var t = typeof b; return (t === "string" ? d3_rgb_names.has(b.toLowerCase()) || /^(#|rgb\(|hsl\()/i.test(b) ? d3_interpolateRgb : d3_interpolateString : b instanceof d3_color ? d3_interpolateRgb : Array.isArray(b) ? d3_interpolateArray : t === "object" && isNaN(b) ? d3_interpolateObject : d3_interpolateNumber)(a, b); } ]; d3.interpolateArray = d3_interpolateArray; function d3_interpolateArray(a, b) { var x = [], c = [], na = a.length, nb = b.length, n0 = Math.min(a.length, b.length), i; for (i = 0; i < n0; ++i) x.push(d3_interpolate(a[i], b[i])); for (;i < na; ++i) c[i] = a[i]; for (;i < nb; ++i) c[i] = b[i]; return function(t) { for (i = 0; i < n0; ++i) c[i] = x[i](t); return c; }; } var d3_ease_default = function() { return d3_identity; }; var d3_ease = d3.map({ linear: d3_ease_default, poly: d3_ease_poly, quad: function() { return d3_ease_quad; }, cubic: function() { return d3_ease_cubic; }, sin: function() { return d3_ease_sin; }, exp: function() { return d3_ease_exp; }, circle: function() { return d3_ease_circle; }, elastic: d3_ease_elastic, back: d3_ease_back, bounce: function() { return d3_ease_bounce; } }); var d3_ease_mode = d3.map({ "in": d3_identity, out: d3_ease_reverse, "in-out": d3_ease_reflect, "out-in": function(f) { return d3_ease_reflect(d3_ease_reverse(f)); } }); d3.ease = function(name) { var i = name.indexOf("-"), t = i >= 0 ? name.slice(0, i) : name, m = i >= 0 ? name.slice(i + 1) : "in"; t = d3_ease.get(t) || d3_ease_default; m = d3_ease_mode.get(m) || d3_identity; return d3_ease_clamp(m(t.apply(null, d3_arraySlice.call(arguments, 1)))); }; function d3_ease_clamp(f) { return function(t) { return t <= 0 ? 0 : t >= 1 ? 1 : f(t); }; } function d3_ease_reverse(f) { return function(t) { return 1 - f(1 - t); }; } function d3_ease_reflect(f) { return function(t) { return .5 * (t < .5 ? f(2 * t) : 2 - f(2 - 2 * t)); }; } function d3_ease_quad(t) { return t * t; } function d3_ease_cubic(t) { return t * t * t; } function d3_ease_cubicInOut(t) { if (t <= 0) return 0; if (t >= 1) return 1; var t2 = t * t, t3 = t2 * t; return 4 * (t < .5 ? t3 : 3 * (t - t2) + t3 - .75); } function d3_ease_poly(e) { return function(t) { return Math.pow(t, e); }; } function d3_ease_sin(t) { return 1 - Math.cos(t * halfπ); } function d3_ease_exp(t) { return Math.pow(2, 10 * (t - 1)); } function d3_ease_circle(t) { return 1 - Math.sqrt(1 - t * t); } function d3_ease_elastic(a, p) { var s; if (arguments.length < 2) p = .45; if (arguments.length) s = p / τ * Math.asin(1 / a); else a = 1, s = p / 4; return function(t) { return 1 + a * Math.pow(2, -10 * t) * Math.sin((t - s) * τ / p); }; } function d3_ease_back(s) { if (!s) s = 1.70158; return function(t) { return t * t * ((s + 1) * t - s); }; } function d3_ease_bounce(t) { return t < 1 / 2.75 ? 7.5625 * t * t : t < 2 / 2.75 ? 7.5625 * (t -= 1.5 / 2.75) * t + .75 : t < 2.5 / 2.75 ? 7.5625 * (t -= 2.25 / 2.75) * t + .9375 : 7.5625 * (t -= 2.625 / 2.75) * t + .984375; } d3.interpolateHcl = d3_interpolateHcl; function d3_interpolateHcl(a, b) { a = d3.hcl(a); b = d3.hcl(b); var ah = a.h, ac = a.c, al = a.l, bh = b.h - ah, bc = b.c - ac, bl = b.l - al; if (isNaN(bc)) bc = 0, ac = isNaN(ac) ? b.c : ac; if (isNaN(bh)) bh = 0, ah = isNaN(ah) ? b.h : ah; else if (bh > 180) bh -= 360; else if (bh < -180) bh += 360; return function(t) { return d3_hcl_lab(ah + bh * t, ac + bc * t, al + bl * t) + ""; }; } d3.interpolateHsl = d3_interpolateHsl; function d3_interpolateHsl(a, b) { a = d3.hsl(a); b = d3.hsl(b); var ah = a.h, as = a.s, al = a.l, bh = b.h - ah, bs = b.s - as, bl = b.l - al; if (isNaN(bs)) bs = 0, as = isNaN(as) ? b.s : as; if (isNaN(bh)) bh = 0, ah = isNaN(ah) ? b.h : ah; else if (bh > 180) bh -= 360; else if (bh < -180) bh += 360; return function(t) { return d3_hsl_rgb(ah + bh * t, as + bs * t, al + bl * t) + ""; }; } d3.interpolateLab = d3_interpolateLab; function d3_interpolateLab(a, b) { a = d3.lab(a); b = d3.lab(b); var al = a.l, aa = a.a, ab = a.b, bl = b.l - al, ba = b.a - aa, bb = b.b - ab; return function(t) { return d3_lab_rgb(al + bl * t, aa + ba * t, ab + bb * t) + ""; }; } d3.interpolateRound = d3_interpolateRound; function d3_interpolateRound(a, b) { b -= a; return function(t) { return Math.round(a + b * t); }; } d3.transform = function(string) { var g = d3_document.createElementNS(d3.ns.prefix.svg, "g"); return (d3.transform = function(string) { if (string != null) { g.setAttribute("transform", string); var t = g.transform.baseVal.consolidate(); } return new d3_transform(t ? t.matrix : d3_transformIdentity); })(string); }; function d3_transform(m) { var r0 = [ m.a, m.b ], r1 = [ m.c, m.d ], kx = d3_transformNormalize(r0), kz = d3_transformDot(r0, r1), ky = d3_transformNormalize(d3_transformCombine(r1, r0, -kz)) || 0; if (r0[0] * r1[1] < r1[0] * r0[1]) { r0[0] *= -1; r0[1] *= -1; kx *= -1; kz *= -1; } this.rotate = (kx ? Math.atan2(r0[1], r0[0]) : Math.atan2(-r1[0], r1[1])) * d3_degrees; this.translate = [ m.e, m.f ]; this.scale = [ kx, ky ]; this.skew = ky ? Math.atan2(kz, ky) * d3_degrees : 0; } d3_transform.prototype.toString = function() { return "translate(" + this.translate + ")rotate(" + this.rotate + ")skewX(" + this.skew + ")scale(" + this.scale + ")"; }; function d3_transformDot(a, b) { return a[0] * b[0] + a[1] * b[1]; } function d3_transformNormalize(a) { var k = Math.sqrt(d3_transformDot(a, a)); if (k) { a[0] /= k; a[1] /= k; } return k; } function d3_transformCombine(a, b, k) { a[0] += k * b[0]; a[1] += k * b[1]; return a; } var d3_transformIdentity = { a: 1, b: 0, c: 0, d: 1, e: 0, f: 0 }; d3.interpolateTransform = d3_interpolateTransform; function d3_interpolateTransformPop(s) { return s.length ? s.pop() + "," : ""; } function d3_interpolateTranslate(ta, tb, s, q) { if (ta[0] !== tb[0] || ta[1] !== tb[1]) { var i = s.push("translate(", null, ",", null, ")"); q.push({ i: i - 4, x: d3_interpolateNumber(ta[0], tb[0]) }, { i: i - 2, x: d3_interpolateNumber(ta[1], tb[1]) }); } else if (tb[0] || tb[1]) { s.push("translate(" + tb + ")"); } } function d3_interpolateRotate(ra, rb, s, q) { if (ra !== rb) { if (ra - rb > 180) rb += 360; else if (rb - ra > 180) ra += 360; q.push({ i: s.push(d3_interpolateTransformPop(s) + "rotate(", null, ")") - 2, x: d3_interpolateNumber(ra, rb) }); } else if (rb) { s.push(d3_interpolateTransformPop(s) + "rotate(" + rb + ")"); } } function d3_interpolateSkew(wa, wb, s, q) { if (wa !== wb) { q.push({ i: s.push(d3_interpolateTransformPop(s) + "skewX(", null, ")") - 2, x: d3_interpolateNumber(wa, wb) }); } else if (wb) { s.push(d3_interpolateTransformPop(s) + "skewX(" + wb + ")"); } } function d3_interpolateScale(ka, kb, s, q) { if (ka[0] !== kb[0] || ka[1] !== kb[1]) { var i = s.push(d3_interpolateTransformPop(s) + "scale(", null, ",", null, ")"); q.push({ i: i - 4, x: d3_interpolateNumber(ka[0], kb[0]) }, { i: i - 2, x: d3_interpolateNumber(ka[1], kb[1]) }); } else if (kb[0] !== 1 || kb[1] !== 1) { s.push(d3_interpolateTransformPop(s) + "scale(" + kb + ")"); } } function d3_interpolateTransform(a, b) { var s = [], q = []; a = d3.transform(a), b = d3.transform(b); d3_interpolateTranslate(a.translate, b.translate, s, q); d3_interpolateRotate(a.rotate, b.rotate, s, q); d3_interpolateSkew(a.skew, b.skew, s, q); d3_interpolateScale(a.scale, b.scale, s, q); a = b = null; return function(t) { var i = -1, n = q.length, o; while (++i < n) s[(o = q[i]).i] = o.x(t); return s.join(""); }; } function d3_uninterpolateNumber(a, b) { b = (b -= a = +a) || 1 / b; return function(x) { return (x - a) / b; }; } function d3_uninterpolateClamp(a, b) { b = (b -= a = +a) || 1 / b; return function(x) { return Math.max(0, Math.min(1, (x - a) / b)); }; } d3.layout = {}; d3.layout.bundle = function() { return function(links) { var paths = [], i = -1, n = links.length; while (++i < n) paths.push(d3_layout_bundlePath(links[i])); return paths; }; }; function d3_layout_bundlePath(link) { var start = link.source, end = link.target, lca = d3_layout_bundleLeastCommonAncestor(start, end), points = [ start ]; while (start !== lca) { start = start.parent; points.push(start); } var k = points.length; while (end !== lca) { points.splice(k, 0, end); end = end.parent; } return points; } function d3_layout_bundleAncestors(node) { var ancestors = [], parent = node.parent; while (parent != null) { ancestors.push(node); node = parent; parent = parent.parent; } ancestors.push(node); return ancestors; } function d3_layout_bundleLeastCommonAncestor(a, b) { if (a === b) return a; var aNodes = d3_layout_bundleAncestors(a), bNodes = d3_layout_bundleAncestors(b), aNode = aNodes.pop(), bNode = bNodes.pop(), sharedNode = null; while (aNode === bNode) { sharedNode = aNode; aNode = aNodes.pop(); bNode = bNodes.pop(); } return sharedNode; } d3.layout.chord = function() { var chord = {}, chords, groups, matrix, n, padding = 0, sortGroups, sortSubgroups, sortChords; function relayout() { var subgroups = {}, groupSums = [], groupIndex = d3.range(n), subgroupIndex = [], k, x, x0, i, j; chords = []; groups = []; k = 0, i = -1; while (++i < n) { x = 0, j = -1; while (++j < n) { x += matrix[i][j]; } groupSums.push(x); subgroupIndex.push(d3.range(n)); k += x; } if (sortGroups) { groupIndex.sort(function(a, b) { return sortGroups(groupSums[a], groupSums[b]); }); } if (sortSubgroups) { subgroupIndex.forEach(function(d, i) { d.sort(function(a, b) { return sortSubgroups(matrix[i][a], matrix[i][b]); }); }); } k = (τ - padding * n) / k; x = 0, i = -1; while (++i < n) { x0 = x, j = -1; while (++j < n) { var di = groupIndex[i], dj = subgroupIndex[di][j], v = matrix[di][dj], a0 = x, a1 = x += v * k; subgroups[di + "-" + dj] = { index: di, subindex: dj, startAngle: a0, endAngle: a1, value: v }; } groups[di] = { index: di, startAngle: x0, endAngle: x, value: groupSums[di] }; x += padding; } i = -1; while (++i < n) { j = i - 1; while (++j < n) { var source = subgroups[i + "-" + j], target = subgroups[j + "-" + i]; if (source.value || target.value) { chords.push(source.value < target.value ? { source: target, target: source } : { source: source, target: target }); } } } if (sortChords) resort(); } function resort() { chords.sort(function(a, b) { return sortChords((a.source.value + a.target.value) / 2, (b.source.value + b.target.value) / 2); }); } chord.matrix = function(x) { if (!arguments.length) return matrix; n = (matrix = x) && matrix.length; chords = groups = null; return chord; }; chord.padding = function(x) { if (!arguments.length) return padding; padding = x; chords = groups = null; return chord; }; chord.sortGroups = function(x) { if (!arguments.length) return sortGroups; sortGroups = x; chords = groups = null; return chord; }; chord.sortSubgroups = function(x) { if (!arguments.length) return sortSubgroups; sortSubgroups = x; chords = null; return chord; }; chord.sortChords = function(x) { if (!arguments.length) return sortChords; sortChords = x; if (chords) resort(); return chord; }; chord.chords = function() { if (!chords) relayout(); return chords; }; chord.groups = function() { if (!groups) relayout(); return groups; }; return chord; }; d3.layout.force = function() { var force = {}, event = d3.dispatch("start", "tick", "end"), timer, size = [ 1, 1 ], drag, alpha, friction = .9, linkDistance = d3_layout_forceLinkDistance, linkStrength = d3_layout_forceLinkStrength, charge = -30, chargeDistance2 = d3_layout_forceChargeDistance2, gravity = .1, theta2 = .64, nodes = [], links = [], distances, strengths, charges; function repulse(node) { return function(quad, x1, _, x2) { if (quad.point !== node) { var dx = quad.cx - node.x, dy = quad.cy - node.y, dw = x2 - x1, dn = dx * dx + dy * dy; if (dw * dw / theta2 < dn) { if (dn < chargeDistance2) { var k = quad.charge / dn; node.px -= dx * k; node.py -= dy * k; } return true; } if (quad.point && dn && dn < chargeDistance2) { var k = quad.pointCharge / dn; node.px -= dx * k; node.py -= dy * k; } } return !quad.charge; }; } force.tick = function() { if ((alpha *= .99) < .005) { timer = null; event.end({ type: "end", alpha: alpha = 0 }); return true; } var n = nodes.length, m = links.length, q, i, o, s, t, l, k, x, y; for (i = 0; i < m; ++i) { o = links[i]; s = o.source; t = o.target; x = t.x - s.x; y = t.y - s.y; if (l = x * x + y * y) { l = alpha * strengths[i] * ((l = Math.sqrt(l)) - distances[i]) / l; x *= l; y *= l; t.x -= x * (k = s.weight + t.weight ? s.weight / (s.weight + t.weight) : .5); t.y -= y * k; s.x += x * (k = 1 - k); s.y += y * k; } } if (k = alpha * gravity) { x = size[0] / 2; y = size[1] / 2; i = -1; if (k) while (++i < n) { o = nodes[i]; o.x += (x - o.x) * k; o.y += (y - o.y) * k; } } if (charge) { d3_layout_forceAccumulate(q = d3.geom.quadtree(nodes), alpha, charges); i = -1; while (++i < n) { if (!(o = nodes[i]).fixed) { q.visit(repulse(o)); } } } i = -1; while (++i < n) { o = nodes[i]; if (o.fixed) { o.x = o.px; o.y = o.py; } else { o.x -= (o.px - (o.px = o.x)) * friction; o.y -= (o.py - (o.py = o.y)) * friction; } } event.tick({ type: "tick", alpha: alpha }); }; force.nodes = function(x) { if (!arguments.length) return nodes; nodes = x; return force; }; force.links = function(x) { if (!arguments.length) return links; links = x; return force; }; force.size = function(x) { if (!arguments.length) return size; size = x; return force; }; force.linkDistance = function(x) { if (!arguments.length) return linkDistance; linkDistance = typeof x === "function" ? x : +x; return force; }; force.distance = force.linkDistance; force.linkStrength = function(x) { if (!arguments.length) return linkStrength; linkStrength = typeof x === "function" ? x : +x; return force; }; force.friction = function(x) { if (!arguments.length) return friction; friction = +x; return force; }; force.charge = function(x) { if (!arguments.length) return charge; charge = typeof x === "function" ? x : +x; return force; }; force.chargeDistance = function(x) { if (!arguments.length) return Math.sqrt(chargeDistance2); chargeDistance2 = x * x; return force; }; force.gravity = function(x) { if (!arguments.length) return gravity; gravity = +x; return force; }; force.theta = function(x) { if (!arguments.length) return Math.sqrt(theta2); theta2 = x * x; return force; }; force.alpha = function(x) { if (!arguments.length) return alpha; x = +x; if (alpha) { if (x > 0) { alpha = x; } else { timer.c = null, timer.t = NaN, timer = null; event.end({ type: "end", alpha: alpha = 0 }); } } else if (x > 0) { event.start({ type: "start", alpha: alpha = x }); timer = d3_timer(force.tick); } return force; }; force.start = function() { var i, n = nodes.length, m = links.length, w = size[0], h = size[1], neighbors, o; for (i = 0; i < n; ++i) { (o = nodes[i]).index = i; o.weight = 0; } for (i = 0; i < m; ++i) { o = links[i]; if (typeof o.source == "number") o.source = nodes[o.source]; if (typeof o.target == "number") o.target = nodes[o.target]; ++o.source.weight; ++o.target.weight; } for (i = 0; i < n; ++i) { o = nodes[i]; if (isNaN(o.x)) o.x = position("x", w); if (isNaN(o.y)) o.y = position("y", h); if (isNaN(o.px)) o.px = o.x; if (isNaN(o.py)) o.py = o.y; } distances = []; if (typeof linkDistance === "function") for (i = 0; i < m; ++i) distances[i] = +linkDistance.call(this, links[i], i); else for (i = 0; i < m; ++i) distances[i] = linkDistance; strengths = []; if (typeof linkStrength === "function") for (i = 0; i < m; ++i) strengths[i] = +linkStrength.call(this, links[i], i); else for (i = 0; i < m; ++i) strengths[i] = linkStrength; charges = []; if (typeof charge === "function") for (i = 0; i < n; ++i) charges[i] = +charge.call(this, nodes[i], i); else for (i = 0; i < n; ++i) charges[i] = charge; function position(dimension, size) { if (!neighbors) { neighbors = new Array(n); for (j = 0; j < n; ++j) { neighbors[j] = []; } for (j = 0; j < m; ++j) { var o = links[j]; neighbors[o.source.index].push(o.target); neighbors[o.target.index].push(o.source); } } var candidates = neighbors[i], j = -1, l = candidates.length, x; while (++j < l) if (!isNaN(x = candidates[j][dimension])) return x; return Math.random() * size; } return force.resume(); }; force.resume = function() { return force.alpha(.1); }; force.stop = function() { return force.alpha(0); }; force.drag = function() { if (!drag) drag = d3.behavior.drag().origin(d3_identity).on("dragstart.force", d3_layout_forceDragstart).on("drag.force", dragmove).on("dragend.force", d3_layout_forceDragend); if (!arguments.length) return drag; this.on("mouseover.force", d3_layout_forceMouseover).on("mouseout.force", d3_layout_forceMouseout).call(drag); }; function dragmove(d) { d.px = d3.event.x, d.py = d3.event.y; force.resume(); } return d3.rebind(force, event, "on"); }; function d3_layout_forceDragstart(d) { d.fixed |= 2; } function d3_layout_forceDragend(d) { d.fixed &= ~6; } function d3_layout_forceMouseover(d) { d.fixed |= 4; d.px = d.x, d.py = d.y; } function d3_layout_forceMouseout(d) { d.fixed &= ~4; } function d3_layout_forceAccumulate(quad, alpha, charges) { var cx = 0, cy = 0; quad.charge = 0; if (!quad.leaf) { var nodes = quad.nodes, n = nodes.length, i = -1, c; while (++i < n) { c = nodes[i]; if (c == null) continue; d3_layout_forceAccumulate(c, alpha, charges); quad.charge += c.charge; cx += c.charge * c.cx; cy += c.charge * c.cy; } } if (quad.point) { if (!quad.leaf) { quad.point.x += Math.random() - .5; quad.point.y += Math.random() - .5; } var k = alpha * charges[quad.point.index]; quad.charge += quad.pointCharge = k; cx += k * quad.point.x; cy += k * quad.point.y; } quad.cx = cx / quad.charge; quad.cy = cy / quad.charge; } var d3_layout_forceLinkDistance = 20, d3_layout_forceLinkStrength = 1, d3_layout_forceChargeDistance2 = Infinity; d3.layout.hierarchy = function() { var sort = d3_layout_hierarchySort, children = d3_layout_hierarchyChildren, value = d3_layout_hierarchyValue; function hierarchy(root) { var stack = [ root ], nodes = [], node; root.depth = 0; while ((node = stack.pop()) != null) { nodes.push(node); if ((childs = children.call(hierarchy, node, node.depth)) && (n = childs.length)) { var n, childs, child; while (--n >= 0) { stack.push(child = childs[n]); child.parent = node; child.depth = node.depth + 1; } if (value) node.value = 0; node.children = childs; } else { if (value) node.value = +value.call(hierarchy, node, node.depth) || 0; delete node.children; } } d3_layout_hierarchyVisitAfter(root, function(node) { var childs, parent; if (sort && (childs = node.children)) childs.sort(sort); if (value && (parent = node.parent)) parent.value += node.value; }); return nodes; } hierarchy.sort = function(x) { if (!arguments.length) return sort; sort = x; return hierarchy; }; hierarchy.children = function(x) { if (!arguments.length) return children; children = x; return hierarchy; }; hierarchy.value = function(x) { if (!arguments.length) return value; value = x; return hierarchy; }; hierarchy.revalue = function(root) { if (value) { d3_layout_hierarchyVisitBefore(root, function(node) { if (node.children) node.value = 0; }); d3_layout_hierarchyVisitAfter(root, function(node) { var parent; if (!node.children) node.value = +value.call(hierarchy, node, node.depth) || 0; if (parent = node.parent) parent.value += node.value; }); } return root; }; return hierarchy; }; function d3_layout_hierarchyRebind(object, hierarchy) { d3.rebind(object, hierarchy, "sort", "children", "value"); object.nodes = object; object.links = d3_layout_hierarchyLinks; return object; } function d3_layout_hierarchyVisitBefore(node, callback) { var nodes = [ node ]; while ((node = nodes.pop()) != null) { callback(node); if ((children = node.children) && (n = children.length)) { var n, children; while (--n >= 0) nodes.push(children[n]); } } } function d3_layout_hierarchyVisitAfter(node, callback) { var nodes = [ node ], nodes2 = []; while ((node = nodes.pop()) != null) { nodes2.push(node); if ((children = node.children) && (n = children.length)) { var i = -1, n, children; while (++i < n) nodes.push(children[i]); } } while ((node = nodes2.pop()) != null) { callback(node); } } function d3_layout_hierarchyChildren(d) { return d.children; } function d3_layout_hierarchyValue(d) { return d.value; } function d3_layout_hierarchySort(a, b) { return b.value - a.value; } function d3_layout_hierarchyLinks(nodes) { return d3.merge(nodes.map(function(parent) { return (parent.children || []).map(function(child) { return { source: parent, target: child }; }); })); } d3.layout.partition = function() { var hierarchy = d3.layout.hierarchy(), size = [ 1, 1 ]; function position(node, x, dx, dy) { var children = node.children; node.x = x; node.y = node.depth * dy; node.dx = dx; node.dy = dy; if (children && (n = children.length)) { var i = -1, n, c, d; dx = node.value ? dx / node.value : 0; while (++i < n) { position(c = children[i], x, d = c.value * dx, dy); x += d; } } } function depth(node) { var children = node.children, d = 0; if (children && (n = children.length)) { var i = -1, n; while (++i < n) d = Math.max(d, depth(children[i])); } return 1 + d; } function partition(d, i) { var nodes = hierarchy.call(this, d, i); position(nodes[0], 0, size[0], size[1] / depth(nodes[0])); return nodes; } partition.size = function(x) { if (!arguments.length) return size; size = x; return partition; }; return d3_layout_hierarchyRebind(partition, hierarchy); }; d3.layout.pie = function() { var value = Number, sort = d3_layout_pieSortByValue, startAngle = 0, endAngle = τ, padAngle = 0; function pie(data) { var n = data.length, values = data.map(function(d, i) { return +value.call(pie, d, i); }), a = +(typeof startAngle === "function" ? startAngle.apply(this, arguments) : startAngle), da = (typeof endAngle === "function" ? endAngle.apply(this, arguments) : endAngle) - a, p = Math.min(Math.abs(da) / n, +(typeof padAngle === "function" ? padAngle.apply(this, arguments) : padAngle)), pa = p * (da < 0 ? -1 : 1), sum = d3.sum(values), k = sum ? (da - n * pa) / sum : 0, index = d3.range(n), arcs = [], v; if (sort != null) index.sort(sort === d3_layout_pieSortByValue ? function(i, j) { return values[j] - values[i]; } : function(i, j) { return sort(data[i], data[j]); }); index.forEach(function(i) { arcs[i] = { data: data[i], value: v = values[i], startAngle: a, endAngle: a += v * k + pa, padAngle: p }; }); return arcs; } pie.value = function(_) { if (!arguments.length) return value; value = _; return pie; }; pie.sort = function(_) { if (!arguments.length) return sort; sort = _; return pie; }; pie.startAngle = function(_) { if (!arguments.length) return startAngle; startAngle = _; return pie; }; pie.endAngle = function(_) { if (!arguments.length) return endAngle; endAngle = _; return pie; }; pie.padAngle = function(_) { if (!arguments.length) return padAngle; padAngle = _; return pie; }; return pie; }; var d3_layout_pieSortByValue = {}; d3.layout.stack = function() { var values = d3_identity, order = d3_layout_stackOrderDefault, offset = d3_layout_stackOffsetZero, out = d3_layout_stackOut, x = d3_layout_stackX, y = d3_layout_stackY; function stack(data, index) { if (!(n = data.length)) return data; var series = data.map(function(d, i) { return values.call(stack, d, i); }); var points = series.map(function(d) { return d.map(function(v, i) { return [ x.call(stack, v, i), y.call(stack, v, i) ]; }); }); var orders = order.call(stack, points, index); series = d3.permute(series, orders); points = d3.permute(points, orders); var offsets = offset.call(stack, points, index); var m = series[0].length, n, i, j, o; for (j = 0; j < m; ++j) { out.call(stack, series[0][j], o = offsets[j], points[0][j][1]); for (i = 1; i < n; ++i) { out.call(stack, series[i][j], o += points[i - 1][j][1], points[i][j][1]); } } return data; } stack.values = function(x) { if (!arguments.length) return values; values = x; return stack; }; stack.order = function(x) { if (!arguments.length) return order; order = typeof x === "function" ? x : d3_layout_stackOrders.get(x) || d3_layout_stackOrderDefault; return stack; }; stack.offset = function(x) { if (!arguments.length) return offset; offset = typeof x === "function" ? x : d3_layout_stackOffsets.get(x) || d3_layout_stackOffsetZero; return stack; }; stack.x = function(z) { if (!arguments.length) return x; x = z; return stack; }; stack.y = function(z) { if (!arguments.length) return y; y = z; return stack; }; stack.out = function(z) { if (!arguments.length) return out; out = z; return stack; }; return stack; }; function d3_layout_stackX(d) { return d.x; } function d3_layout_stackY(d) { return d.y; } function d3_layout_stackOut(d, y0, y) { d.y0 = y0; d.y = y; } var d3_layout_stackOrders = d3.map({ "inside-out": function(data) { var n = data.length, i, j, max = data.map(d3_layout_stackMaxIndex), sums = data.map(d3_layout_stackReduceSum), index = d3.range(n).sort(function(a, b) { return max[a] - max[b]; }), top = 0, bottom = 0, tops = [], bottoms = []; for (i = 0; i < n; ++i) { j = index[i]; if (top < bottom) { top += sums[j]; tops.push(j); } else { bottom += sums[j]; bottoms.push(j); } } return bottoms.reverse().concat(tops); }, reverse: function(data) { return d3.range(data.length).reverse(); }, "default": d3_layout_stackOrderDefault }); var d3_layout_stackOffsets = d3.map({ silhouette: function(data) { var n = data.length, m = data[0].length, sums = [], max = 0, i, j, o, y0 = []; for (j = 0; j < m; ++j) { for (i = 0, o = 0; i < n; i++) o += data[i][j][1]; if (o > max) max = o; sums.push(o); } for (j = 0; j < m; ++j) { y0[j] = (max - sums[j]) / 2; } return y0; }, wiggle: function(data) { var n = data.length, x = data[0], m = x.length, i, j, k, s1, s2, s3, dx, o, o0, y0 = []; y0[0] = o = o0 = 0; for (j = 1; j < m; ++j) { for (i = 0, s1 = 0; i < n; ++i) s1 += data[i][j][1]; for (i = 0, s2 = 0, dx = x[j][0] - x[j - 1][0]; i < n; ++i) { for (k = 0, s3 = (data[i][j][1] - data[i][j - 1][1]) / (2 * dx); k < i; ++k) { s3 += (data[k][j][1] - data[k][j - 1][1]) / dx; } s2 += s3 * data[i][j][1]; } y0[j] = o -= s1 ? s2 / s1 * dx : 0; if (o < o0) o0 = o; } for (j = 0; j < m; ++j) y0[j] -= o0; return y0; }, expand: function(data) { var n = data.length, m = data[0].length, k = 1 / n, i, j, o, y0 = []; for (j = 0; j < m; ++j) { for (i = 0, o = 0; i < n; i++) o += data[i][j][1]; if (o) for (i = 0; i < n; i++) data[i][j][1] /= o; else for (i = 0; i < n; i++) data[i][j][1] = k; } for (j = 0; j < m; ++j) y0[j] = 0; return y0; }, zero: d3_layout_stackOffsetZero }); function d3_layout_stackOrderDefault(data) { return d3.range(data.length); } function d3_layout_stackOffsetZero(data) { var j = -1, m = data[0].length, y0 = []; while (++j < m) y0[j] = 0; return y0; } function d3_layout_stackMaxIndex(array) { var i = 1, j = 0, v = array[0][1], k, n = array.length; for (;i < n; ++i) { if ((k = array[i][1]) > v) { j = i; v = k; } } return j; } function d3_layout_stackReduceSum(d) { return d.reduce(d3_layout_stackSum, 0); } function d3_layout_stackSum(p, d) { return p + d[1]; } d3.layout.histogram = function() { var frequency = true, valuer = Number, ranger = d3_layout_histogramRange, binner = d3_layout_histogramBinSturges; function histogram(data, i) { var bins = [], values = data.map(valuer, this), range = ranger.call(this, values, i), thresholds = binner.call(this, range, values, i), bin, i = -1, n = values.length, m = thresholds.length - 1, k = frequency ? 1 : 1 / n, x; while (++i < m) { bin = bins[i] = []; bin.dx = thresholds[i + 1] - (bin.x = thresholds[i]); bin.y = 0; } if (m > 0) { i = -1; while (++i < n) { x = values[i]; if (x >= range[0] && x <= range[1]) { bin = bins[d3.bisect(thresholds, x, 1, m) - 1]; bin.y += k; bin.push(data[i]); } } } return bins; } histogram.value = function(x) { if (!arguments.length) return valuer; valuer = x; return histogram; }; histogram.range = function(x) { if (!arguments.length) return ranger; ranger = d3_functor(x); return histogram; }; histogram.bins = function(x) { if (!arguments.length) return binner; binner = typeof x === "number" ? function(range) { return d3_layout_histogramBinFixed(range, x); } : d3_functor(x); return histogram; }; histogram.frequency = function(x) { if (!arguments.length) return frequency; frequency = !!x; return histogram; }; return histogram; }; function d3_layout_histogramBinSturges(range, values) { return d3_layout_histogramBinFixed(range, Math.ceil(Math.log(values.length) / Math.LN2 + 1)); } function d3_layout_histogramBinFixed(range, n) { var x = -1, b = +range[0], m = (range[1] - b) / n, f = []; while (++x <= n) f[x] = m * x + b; return f; } function d3_layout_histogramRange(values) { return [ d3.min(values), d3.max(values) ]; } d3.layout.pack = function() { var hierarchy = d3.layout.hierarchy().sort(d3_layout_packSort), padding = 0, size = [ 1, 1 ], radius; function pack(d, i) { var nodes = hierarchy.call(this, d, i), root = nodes[0], w = size[0], h = size[1], r = radius == null ? Math.sqrt : typeof radius === "function" ? radius : function() { return radius; }; root.x = root.y = 0; d3_layout_hierarchyVisitAfter(root, function(d) { d.r = +r(d.value); }); d3_layout_hierarchyVisitAfter(root, d3_layout_packSiblings); if (padding) { var dr = padding * (radius ? 1 : Math.max(2 * root.r / w, 2 * root.r / h)) / 2; d3_layout_hierarchyVisitAfter(root, function(d) { d.r += dr; }); d3_layout_hierarchyVisitAfter(root, d3_layout_packSiblings); d3_layout_hierarchyVisitAfter(root, function(d) { d.r -= dr; }); } d3_layout_packTransform(root, w / 2, h / 2, radius ? 1 : 1 / Math.max(2 * root.r / w, 2 * root.r / h)); return nodes; } pack.size = function(_) { if (!arguments.length) return size; size = _; return pack; }; pack.radius = function(_) { if (!arguments.length) return radius; radius = _ == null || typeof _ === "function" ? _ : +_; return pack; }; pack.padding = function(_) { if (!arguments.length) return padding; padding = +_; return pack; }; return d3_layout_hierarchyRebind(pack, hierarchy); }; function d3_layout_packSort(a, b) { return a.value - b.value; } function d3_layout_packInsert(a, b) { var c = a._pack_next; a._pack_next = b; b._pack_prev = a; b._pack_next = c; c._pack_prev = b; } function d3_layout_packSplice(a, b) { a._pack_next = b; b._pack_prev = a; } function d3_layout_packIntersects(a, b) { var dx = b.x - a.x, dy = b.y - a.y, dr = a.r + b.r; return .999 * dr * dr > dx * dx + dy * dy; } function d3_layout_packSiblings(node) { if (!(nodes = node.children) || !(n = nodes.length)) return; var nodes, xMin = Infinity, xMax = -Infinity, yMin = Infinity, yMax = -Infinity, a, b, c, i, j, k, n; function bound(node) { xMin = Math.min(node.x - node.r, xMin); xMax = Math.max(node.x + node.r, xMax); yMin = Math.min(node.y - node.r, yMin); yMax = Math.max(node.y + node.r, yMax); } nodes.forEach(d3_layout_packLink); a = nodes[0]; a.x = -a.r; a.y = 0; bound(a); if (n > 1) { b = nodes[1]; b.x = b.r; b.y = 0; bound(b); if (n > 2) { c = nodes[2]; d3_layout_packPlace(a, b, c); bound(c); d3_layout_packInsert(a, c); a._pack_prev = c; d3_layout_packInsert(c, b); b = a._pack_next; for (i = 3; i < n; i++) { d3_layout_packPlace(a, b, c = nodes[i]); var isect = 0, s1 = 1, s2 = 1; for (j = b._pack_next; j !== b; j = j._pack_next, s1++) { if (d3_layout_packIntersects(j, c)) { isect = 1; break; } } if (isect == 1) { for (k = a._pack_prev; k !== j._pack_prev; k = k._pack_prev, s2++) { if (d3_layout_packIntersects(k, c)) { break; } } } if (isect) { if (s1 < s2 || s1 == s2 && b.r < a.r) d3_layout_packSplice(a, b = j); else d3_layout_packSplice(a = k, b); i--; } else { d3_layout_packInsert(a, c); b = c; bound(c); } } } } var cx = (xMin + xMax) / 2, cy = (yMin + yMax) / 2, cr = 0; for (i = 0; i < n; i++) { c = nodes[i]; c.x -= cx; c.y -= cy; cr = Math.max(cr, c.r + Math.sqrt(c.x * c.x + c.y * c.y)); } node.r = cr; nodes.forEach(d3_layout_packUnlink); } function d3_layout_packLink(node) { node._pack_next = node._pack_prev = node; } function d3_layout_packUnlink(node) { delete node._pack_next; delete node._pack_prev; } function d3_layout_packTransform(node, x, y, k) { var children = node.children; node.x = x += k * node.x; node.y = y += k * node.y; node.r *= k; if (children) { var i = -1, n = children.length; while (++i < n) d3_layout_packTransform(children[i], x, y, k); } } function d3_layout_packPlace(a, b, c) { var db = a.r + c.r, dx = b.x - a.x, dy = b.y - a.y; if (db && (dx || dy)) { var da = b.r + c.r, dc = dx * dx + dy * dy; da *= da; db *= db; var x = .5 + (db - da) / (2 * dc), y = Math.sqrt(Math.max(0, 2 * da * (db + dc) - (db -= dc) * db - da * da)) / (2 * dc); c.x = a.x + x * dx + y * dy; c.y = a.y + x * dy - y * dx; } else { c.x = a.x + db; c.y = a.y; } } d3.layout.tree = function() { var hierarchy = d3.layout.hierarchy().sort(null).value(null), separation = d3_layout_treeSeparation, size = [ 1, 1 ], nodeSize = null; function tree(d, i) { var nodes = hierarchy.call(this, d, i), root0 = nodes[0], root1 = wrapTree(root0); d3_layout_hierarchyVisitAfter(root1, firstWalk), root1.parent.m = -root1.z; d3_layout_hierarchyVisitBefore(root1, secondWalk); if (nodeSize) d3_layout_hierarchyVisitBefore(root0, sizeNode); else { var left = root0, right = root0, bottom = root0; d3_layout_hierarchyVisitBefore(root0, function(node) { if (node.x < left.x) left = node; if (node.x > right.x) right = node; if (node.depth > bottom.depth) bottom = node; }); var tx = separation(left, right) / 2 - left.x, kx = size[0] / (right.x + separation(right, left) / 2 + tx), ky = size[1] / (bottom.depth || 1); d3_layout_hierarchyVisitBefore(root0, function(node) { node.x = (node.x + tx) * kx; node.y = node.depth * ky; }); } return nodes; } function wrapTree(root0) { var root1 = { A: null, children: [ root0 ] }, queue = [ root1 ], node1; while ((node1 = queue.pop()) != null) { for (var children = node1.children, child, i = 0, n = children.length; i < n; ++i) { queue.push((children[i] = child = { _: children[i], parent: node1, children: (child = children[i].children) && child.slice() || [], A: null, a: null, z: 0, m: 0, c: 0, s: 0, t: null, i: i }).a = child); } } return root1.children[0]; } function firstWalk(v) { var children = v.children, siblings = v.parent.children, w = v.i ? siblings[v.i - 1] : null; if (children.length) { d3_layout_treeShift(v); var midpoint = (children[0].z + children[children.length - 1].z) / 2; if (w) { v.z = w.z + separation(v._, w._); v.m = v.z - midpoint; } else { v.z = midpoint; } } else if (w) { v.z = w.z + separation(v._, w._); } v.parent.A = apportion(v, w, v.parent.A || siblings[0]); } function secondWalk(v) { v._.x = v.z + v.parent.m; v.m += v.parent.m; } function apportion(v, w, ancestor) { if (w) { var vip = v, vop = v, vim = w, vom = vip.parent.children[0], sip = vip.m, sop = vop.m, sim = vim.m, som = vom.m, shift; while (vim = d3_layout_treeRight(vim), vip = d3_layout_treeLeft(vip), vim && vip) { vom = d3_layout_treeLeft(vom); vop = d3_layout_treeRight(vop); vop.a = v; shift = vim.z + sim - vip.z - sip + separation(vim._, vip._); if (shift > 0) { d3_layout_treeMove(d3_layout_treeAncestor(vim, v, ancestor), v, shift); sip += shift; sop += shift; } sim += vim.m; sip += vip.m; som += vom.m; sop += vop.m; } if (vim && !d3_layout_treeRight(vop)) { vop.t = vim; vop.m += sim - sop; } if (vip && !d3_layout_treeLeft(vom)) { vom.t = vip; vom.m += sip - som; ancestor = v; } } return ancestor; } function sizeNode(node) { node.x *= size[0]; node.y = node.depth * size[1]; } tree.separation = function(x) { if (!arguments.length) return separation; separation = x; return tree; }; tree.size = function(x) { if (!arguments.length) return nodeSize ? null : size; nodeSize = (size = x) == null ? sizeNode : null; return tree; }; tree.nodeSize = function(x) { if (!arguments.length) return nodeSize ? size : null; nodeSize = (size = x) == null ? null : sizeNode; return tree; }; return d3_layout_hierarchyRebind(tree, hierarchy); }; function d3_layout_treeSeparation(a, b) { return a.parent == b.parent ? 1 : 2; } function d3_layout_treeLeft(v) { var children = v.children; return children.length ? children[0] : v.t; } function d3_layout_treeRight(v) { var children = v.children, n; return (n = children.length) ? children[n - 1] : v.t; } function d3_layout_treeMove(wm, wp, shift) { var change = shift / (wp.i - wm.i); wp.c -= change; wp.s += shift; wm.c += change; wp.z += shift; wp.m += shift; } function d3_layout_treeShift(v) { var shift = 0, change = 0, children = v.children, i = children.length, w; while (--i >= 0) { w = children[i]; w.z += shift; w.m += shift; shift += w.s + (change += w.c); } } function d3_layout_treeAncestor(vim, v, ancestor) { return vim.a.parent === v.parent ? vim.a : ancestor; } d3.layout.cluster = function() { var hierarchy = d3.layout.hierarchy().sort(null).value(null), separation = d3_layout_treeSeparation, size = [ 1, 1 ], nodeSize = false; function cluster(d, i) { var nodes = hierarchy.call(this, d, i), root = nodes[0], previousNode, x = 0; d3_layout_hierarchyVisitAfter(root, function(node) { var children = node.children; if (children && children.length) { node.x = d3_layout_clusterX(children); node.y = d3_layout_clusterY(children); } else { node.x = previousNode ? x += separation(node, previousNode) : 0; node.y = 0; previousNode = node; } }); var left = d3_layout_clusterLeft(root), right = d3_layout_clusterRight(root), x0 = left.x - separation(left, right) / 2, x1 = right.x + separation(right, left) / 2; d3_layout_hierarchyVisitAfter(root, nodeSize ? function(node) { node.x = (node.x - root.x) * size[0]; node.y = (root.y - node.y) * size[1]; } : function(node) { node.x = (node.x - x0) / (x1 - x0) * size[0]; node.y = (1 - (root.y ? node.y / root.y : 1)) * size[1]; }); return nodes; } cluster.separation = function(x) { if (!arguments.length) return separation; separation = x; return cluster; }; cluster.size = function(x) { if (!arguments.length) return nodeSize ? null : size; nodeSize = (size = x) == null; return cluster; }; cluster.nodeSize = function(x) { if (!arguments.length) return nodeSize ? size : null; nodeSize = (size = x) != null; return cluster; }; return d3_layout_hierarchyRebind(cluster, hierarchy); }; function d3_layout_clusterY(children) { return 1 + d3.max(children, function(child) { return child.y; }); } function d3_layout_clusterX(children) { return children.reduce(function(x, child) { return x + child.x; }, 0) / children.length; } function d3_layout_clusterLeft(node) { var children = node.children; return children && children.length ? d3_layout_clusterLeft(children[0]) : node; } function d3_layout_clusterRight(node) { var children = node.children, n; return children && (n = children.length) ? d3_layout_clusterRight(children[n - 1]) : node; } d3.layout.treemap = function() { var hierarchy = d3.layout.hierarchy(), round = Math.round, size = [ 1, 1 ], padding = null, pad = d3_layout_treemapPadNull, sticky = false, stickies, mode = "squarify", ratio = .5 * (1 + Math.sqrt(5)); function scale(children, k) { var i = -1, n = children.length, child, area; while (++i < n) { area = (child = children[i]).value * (k < 0 ? 0 : k); child.area = isNaN(area) || area <= 0 ? 0 : area; } } function squarify(node) { var children = node.children; if (children && children.length) { var rect = pad(node), row = [], remaining = children.slice(), child, best = Infinity, score, u = mode === "slice" ? rect.dx : mode === "dice" ? rect.dy : mode === "slice-dice" ? node.depth & 1 ? rect.dy : rect.dx : Math.min(rect.dx, rect.dy), n; scale(remaining, rect.dx * rect.dy / node.value); row.area = 0; while ((n = remaining.length) > 0) { row.push(child = remaining[n - 1]); row.area += child.area; if (mode !== "squarify" || (score = worst(row, u)) <= best) { remaining.pop(); best = score; } else { row.area -= row.pop().area; position(row, u, rect, false); u = Math.min(rect.dx, rect.dy); row.length = row.area = 0; best = Infinity; } } if (row.length) { position(row, u, rect, true); row.length = row.area = 0; } children.forEach(squarify); } } function stickify(node) { var children = node.children; if (children && children.length) { var rect = pad(node), remaining = children.slice(), child, row = []; scale(remaining, rect.dx * rect.dy / node.value); row.area = 0; while (child = remaining.pop()) { row.push(child); row.area += child.area; if (child.z != null) { position(row, child.z ? rect.dx : rect.dy, rect, !remaining.length); row.length = row.area = 0; } } children.forEach(stickify); } } function worst(row, u) { var s = row.area, r, rmax = 0, rmin = Infinity, i = -1, n = row.length; while (++i < n) { if (!(r = row[i].area)) continue; if (r < rmin) rmin = r; if (r > rmax) rmax = r; } s *= s; u *= u; return s ? Math.max(u * rmax * ratio / s, s / (u * rmin * ratio)) : Infinity; } function position(row, u, rect, flush) { var i = -1, n = row.length, x = rect.x, y = rect.y, v = u ? round(row.area / u) : 0, o; if (u == rect.dx) { if (flush || v > rect.dy) v = rect.dy; while (++i < n) { o = row[i]; o.x = x; o.y = y; o.dy = v; x += o.dx = Math.min(rect.x + rect.dx - x, v ? round(o.area / v) : 0); } o.z = true; o.dx += rect.x + rect.dx - x; rect.y += v; rect.dy -= v; } else { if (flush || v > rect.dx) v = rect.dx; while (++i < n) { o = row[i]; o.x = x; o.y = y; o.dx = v; y += o.dy = Math.min(rect.y + rect.dy - y, v ? round(o.area / v) : 0); } o.z = false; o.dy += rect.y + rect.dy - y; rect.x += v; rect.dx -= v; } } function treemap(d) { var nodes = stickies || hierarchy(d), root = nodes[0]; root.x = root.y = 0; if (root.value) root.dx = size[0], root.dy = size[1]; else root.dx = root.dy = 0; if (stickies) hierarchy.revalue(root); scale([ root ], root.dx * root.dy / root.value); (stickies ? stickify : squarify)(root); if (sticky) stickies = nodes; return nodes; } treemap.size = function(x) { if (!arguments.length) return size; size = x; return treemap; }; treemap.padding = function(x) { if (!arguments.length) return padding; function padFunction(node) { var p = x.call(treemap, node, node.depth); return p == null ? d3_layout_treemapPadNull(node) : d3_layout_treemapPad(node, typeof p === "number" ? [ p, p, p, p ] : p); } function padConstant(node) { return d3_layout_treemapPad(node, x); } var type; pad = (padding = x) == null ? d3_layout_treemapPadNull : (type = typeof x) === "function" ? padFunction : type === "number" ? (x = [ x, x, x, x ], padConstant) : padConstant; return treemap; }; treemap.round = function(x) { if (!arguments.length) return round != Number; round = x ? Math.round : Number; return treemap; }; treemap.sticky = function(x) { if (!arguments.length) return sticky; sticky = x; stickies = null; return treemap; }; treemap.ratio = function(x) { if (!arguments.length) return ratio; ratio = x; return treemap; }; treemap.mode = function(x) { if (!arguments.length) return mode; mode = x + ""; return treemap; }; return d3_layout_hierarchyRebind(treemap, hierarchy); }; function d3_layout_treemapPadNull(node) { return { x: node.x, y: node.y, dx: node.dx, dy: node.dy }; } function d3_layout_treemapPad(node, padding) { var x = node.x + padding[3], y = node.y + padding[0], dx = node.dx - padding[1] - padding[3], dy = node.dy - padding[0] - padding[2]; if (dx < 0) { x += dx / 2; dx = 0; } if (dy < 0) { y += dy / 2; dy = 0; } return { x: x, y: y, dx: dx, dy: dy }; } d3.random = { normal: function(µ, σ) { var n = arguments.length; if (n < 2) σ = 1; if (n < 1) µ = 0; return function() { var x, y, r; do { x = Math.random() * 2 - 1; y = Math.random() * 2 - 1; r = x * x + y * y; } while (!r || r > 1); return µ + σ * x * Math.sqrt(-2 * Math.log(r) / r); }; }, logNormal: function() { var random = d3.random.normal.apply(d3, arguments); return function() { return Math.exp(random()); }; }, bates: function(m) { var random = d3.random.irwinHall(m); return function() { return random() / m; }; }, irwinHall: function(m) { return function() { for (var s = 0, j = 0; j < m; j++) s += Math.random(); return s; }; } }; d3.scale = {}; function d3_scaleExtent(domain) { var start = domain[0], stop = domain[domain.length - 1]; return start < stop ? [ start, stop ] : [ stop, start ]; } function d3_scaleRange(scale) { return scale.rangeExtent ? scale.rangeExtent() : d3_scaleExtent(scale.range()); } function d3_scale_bilinear(domain, range, uninterpolate, interpolate) { var u = uninterpolate(domain[0], domain[1]), i = interpolate(range[0], range[1]); return function(x) { return i(u(x)); }; } function d3_scale_nice(domain, nice) { var i0 = 0, i1 = domain.length - 1, x0 = domain[i0], x1 = domain[i1], dx; if (x1 < x0) { dx = i0, i0 = i1, i1 = dx; dx = x0, x0 = x1, x1 = dx; } domain[i0] = nice.floor(x0); domain[i1] = nice.ceil(x1); return domain; } function d3_scale_niceStep(step) { return step ? { floor: function(x) { return Math.floor(x / step) * step; }, ceil: function(x) { return Math.ceil(x / step) * step; } } : d3_scale_niceIdentity; } var d3_scale_niceIdentity = { floor: d3_identity, ceil: d3_identity }; function d3_scale_polylinear(domain, range, uninterpolate, interpolate) { var u = [], i = [], j = 0, k = Math.min(domain.length, range.length) - 1; if (domain[k] < domain[0]) { domain = domain.slice().reverse(); range = range.slice().reverse(); } while (++j <= k) { u.push(uninterpolate(domain[j - 1], domain[j])); i.push(interpolate(range[j - 1], range[j])); } return function(x) { var j = d3.bisect(domain, x, 1, k) - 1; return i[j](u[j](x)); }; } d3.scale.linear = function() { return d3_scale_linear([ 0, 1 ], [ 0, 1 ], d3_interpolate, false); }; function d3_scale_linear(domain, range, interpolate, clamp) { var output, input; function rescale() { var linear = Math.min(domain.length, range.length) > 2 ? d3_scale_polylinear : d3_scale_bilinear, uninterpolate = clamp ? d3_uninterpolateClamp : d3_uninterpolateNumber; output = linear(domain, range, uninterpolate, interpolate); input = linear(range, domain, uninterpolate, d3_interpolate); return scale; } function scale(x) { return output(x); } scale.invert = function(y) { return input(y); }; scale.domain = function(x) { if (!arguments.length) return domain; domain = x.map(Number); return rescale(); }; scale.range = function(x) { if (!arguments.length) return range; range = x; return rescale(); }; scale.rangeRound = function(x) { return scale.range(x).interpolate(d3_interpolateRound); }; scale.clamp = function(x) { if (!arguments.length) return clamp; clamp = x; return rescale(); }; scale.interpolate = function(x) { if (!arguments.length) return interpolate; interpolate = x; return rescale(); }; scale.ticks = function(m) { return d3_scale_linearTicks(domain, m); }; scale.tickFormat = function(m, format) { return d3_scale_linearTickFormat(domain, m, format); }; scale.nice = function(m) { d3_scale_linearNice(domain, m); return rescale(); }; scale.copy = function() { return d3_scale_linear(domain, range, interpolate, clamp); }; return rescale(); } function d3_scale_linearRebind(scale, linear) { return d3.rebind(scale, linear, "range", "rangeRound", "interpolate", "clamp"); } function d3_scale_linearNice(domain, m) { d3_scale_nice(domain, d3_scale_niceStep(d3_scale_linearTickRange(domain, m)[2])); d3_scale_nice(domain, d3_scale_niceStep(d3_scale_linearTickRange(domain, m)[2])); return domain; } function d3_scale_linearTickRange(domain, m) { if (m == null) m = 10; var extent = d3_scaleExtent(domain), span = extent[1] - extent[0], step = Math.pow(10, Math.floor(Math.log(span / m) / Math.LN10)), err = m / span * step; if (err <= .15) step *= 10; else if (err <= .35) step *= 5; else if (err <= .75) step *= 2; extent[0] = Math.ceil(extent[0] / step) * step; extent[1] = Math.floor(extent[1] / step) * step + step * .5; extent[2] = step; return extent; } function d3_scale_linearTicks(domain, m) { return d3.range.apply(d3, d3_scale_linearTickRange(domain, m)); } function d3_scale_linearTickFormat(domain, m, format) { var range = d3_scale_linearTickRange(domain, m); if (format) { var match = d3_format_re.exec(format); match.shift(); if (match[8] === "s") { var prefix = d3.formatPrefix(Math.max(abs(range[0]), abs(range[1]))); if (!match[7]) match[7] = "." + d3_scale_linearPrecision(prefix.scale(range[2])); match[8] = "f"; format = d3.format(match.join("")); return function(d) { return format(prefix.scale(d)) + prefix.symbol; }; } if (!match[7]) match[7] = "." + d3_scale_linearFormatPrecision(match[8], range); format = match.join(""); } else { format = ",." + d3_scale_linearPrecision(range[2]) + "f"; } return d3.format(format); } var d3_scale_linearFormatSignificant = { s: 1, g: 1, p: 1, r: 1, e: 1 }; function d3_scale_linearPrecision(value) { return -Math.floor(Math.log(value) / Math.LN10 + .01); } function d3_scale_linearFormatPrecision(type, range) { var p = d3_scale_linearPrecision(range[2]); return type in d3_scale_linearFormatSignificant ? Math.abs(p - d3_scale_linearPrecision(Math.max(abs(range[0]), abs(range[1])))) + +(type !== "e") : p - (type === "%") * 2; } d3.scale.log = function() { return d3_scale_log(d3.scale.linear().domain([ 0, 1 ]), 10, true, [ 1, 10 ]); }; function d3_scale_log(linear, base, positive, domain) { function log(x) { return (positive ? Math.log(x < 0 ? 0 : x) : -Math.log(x > 0 ? 0 : -x)) / Math.log(base); } function pow(x) { return positive ? Math.pow(base, x) : -Math.pow(base, -x); } function scale(x) { return linear(log(x)); } scale.invert = function(x) { return pow(linear.invert(x)); }; scale.domain = function(x) { if (!arguments.length) return domain; positive = x[0] >= 0; linear.domain((domain = x.map(Number)).map(log)); return scale; }; scale.base = function(_) { if (!arguments.length) return base; base = +_; linear.domain(domain.map(log)); return scale; }; scale.nice = function() { var niced = d3_scale_nice(domain.map(log), positive ? Math : d3_scale_logNiceNegative); linear.domain(niced); domain = niced.map(pow); return scale; }; scale.ticks = function() { var extent = d3_scaleExtent(domain), ticks = [], u = extent[0], v = extent[1], i = Math.floor(log(u)), j = Math.ceil(log(v)), n = base % 1 ? 2 : base; if (isFinite(j - i)) { if (positive) { for (;i < j; i++) for (var k = 1; k < n; k++) ticks.push(pow(i) * k); ticks.push(pow(i)); } else { ticks.push(pow(i)); for (;i++ < j; ) for (var k = n - 1; k > 0; k--) ticks.push(pow(i) * k); } for (i = 0; ticks[i] < u; i++) {} for (j = ticks.length; ticks[j - 1] > v; j--) {} ticks = ticks.slice(i, j); } return ticks; }; scale.tickFormat = function(n, format) { if (!arguments.length) return d3_scale_logFormat; if (arguments.length < 2) format = d3_scale_logFormat; else if (typeof format !== "function") format = d3.format(format); var k = Math.max(1, base * n / scale.ticks().length); return function(d) { var i = d / pow(Math.round(log(d))); if (i * base < base - .5) i *= base; return i <= k ? format(d) : ""; }; }; scale.copy = function() { return d3_scale_log(linear.copy(), base, positive, domain); }; return d3_scale_linearRebind(scale, linear); } var d3_scale_logFormat = d3.format(".0e"), d3_scale_logNiceNegative = { floor: function(x) { return -Math.ceil(-x); }, ceil: function(x) { return -Math.floor(-x); } }; d3.scale.pow = function() { return d3_scale_pow(d3.scale.linear(), 1, [ 0, 1 ]); }; function d3_scale_pow(linear, exponent, domain) { var powp = d3_scale_powPow(exponent), powb = d3_scale_powPow(1 / exponent); function scale(x) { return linear(powp(x)); } scale.invert = function(x) { return powb(linear.invert(x)); }; scale.domain = function(x) { if (!arguments.length) return domain; linear.domain((domain = x.map(Number)).map(powp)); return scale; }; scale.ticks = function(m) { return d3_scale_linearTicks(domain, m); }; scale.tickFormat = function(m, format) { return d3_scale_linearTickFormat(domain, m, format); }; scale.nice = function(m) { return scale.domain(d3_scale_linearNice(domain, m)); }; scale.exponent = function(x) { if (!arguments.length) return exponent; powp = d3_scale_powPow(exponent = x); powb = d3_scale_powPow(1 / exponent); linear.domain(domain.map(powp)); return scale; }; scale.copy = function() { return d3_scale_pow(linear.copy(), exponent, domain); }; return d3_scale_linearRebind(scale, linear); } function d3_scale_powPow(e) { return function(x) { return x < 0 ? -Math.pow(-x, e) : Math.pow(x, e); }; } d3.scale.sqrt = function() { return d3.scale.pow().exponent(.5); }; d3.scale.ordinal = function() { return d3_scale_ordinal([], { t: "range", a: [ [] ] }); }; function d3_scale_ordinal(domain, ranger) { var index, range, rangeBand; function scale(x) { return range[((index.get(x) || (ranger.t === "range" ? index.set(x, domain.push(x)) : NaN)) - 1) % range.length]; } function steps(start, step) { return d3.range(domain.length).map(function(i) { return start + step * i; }); } scale.domain = function(x) { if (!arguments.length) return domain; domain = []; index = new d3_Map(); var i = -1, n = x.length, xi; while (++i < n) if (!index.has(xi = x[i])) index.set(xi, domain.push(xi)); return scale[ranger.t].apply(scale, ranger.a); }; scale.range = function(x) { if (!arguments.length) return range; range = x; rangeBand = 0; ranger = { t: "range", a: arguments }; return scale; }; scale.rangePoints = function(x, padding) { if (arguments.length < 2) padding = 0; var start = x[0], stop = x[1], step = domain.length < 2 ? (start = (start + stop) / 2, 0) : (stop - start) / (domain.length - 1 + padding); range = steps(start + step * padding / 2, step); rangeBand = 0; ranger = { t: "rangePoints", a: arguments }; return scale; }; scale.rangeRoundPoints = function(x, padding) { if (arguments.length < 2) padding = 0; var start = x[0], stop = x[1], step = domain.length < 2 ? (start = stop = Math.round((start + stop) / 2), 0) : (stop - start) / (domain.length - 1 + padding) | 0; range = steps(start + Math.round(step * padding / 2 + (stop - start - (domain.length - 1 + padding) * step) / 2), step); rangeBand = 0; ranger = { t: "rangeRoundPoints", a: arguments }; return scale; }; scale.rangeBands = function(x, padding, outerPadding) { if (arguments.length < 2) padding = 0; if (arguments.length < 3) outerPadding = padding; var reverse = x[1] < x[0], start = x[reverse - 0], stop = x[1 - reverse], step = (stop - start) / (domain.length - padding + 2 * outerPadding); range = steps(start + step * outerPadding, step); if (reverse) range.reverse(); rangeBand = step * (1 - padding); ranger = { t: "rangeBands", a: arguments }; return scale; }; scale.rangeRoundBands = function(x, padding, outerPadding) { if (arguments.length < 2) padding = 0; if (arguments.length < 3) outerPadding = padding; var reverse = x[1] < x[0], start = x[reverse - 0], stop = x[1 - reverse], step = Math.floor((stop - start) / (domain.length - padding + 2 * outerPadding)); range = steps(start + Math.round((stop - start - (domain.length - padding) * step) / 2), step); if (reverse) range.reverse(); rangeBand = Math.round(step * (1 - padding)); ranger = { t: "rangeRoundBands", a: arguments }; return scale; }; scale.rangeBand = function() { return rangeBand; }; scale.rangeExtent = function() { return d3_scaleExtent(ranger.a[0]); }; scale.copy = function() { return d3_scale_ordinal(domain, ranger); }; return scale.domain(domain); } d3.scale.category10 = function() { return d3.scale.ordinal().range(d3_category10); }; d3.scale.category20 = function() { return d3.scale.ordinal().range(d3_category20); }; d3.scale.category20b = function() { return d3.scale.ordinal().range(d3_category20b); }; d3.scale.category20c = function() { return d3.scale.ordinal().range(d3_category20c); }; var d3_category10 = [ 2062260, 16744206, 2924588, 14034728, 9725885, 9197131, 14907330, 8355711, 12369186, 1556175 ].map(d3_rgbString); var d3_category20 = [ 2062260, 11454440, 16744206, 16759672, 2924588, 10018698, 14034728, 16750742, 9725885, 12955861, 9197131, 12885140, 14907330, 16234194, 8355711, 13092807, 12369186, 14408589, 1556175, 10410725 ].map(d3_rgbString); var d3_category20b = [ 3750777, 5395619, 7040719, 10264286, 6519097, 9216594, 11915115, 13556636, 9202993, 12426809, 15186514, 15190932, 8666169, 11356490, 14049643, 15177372, 8077683, 10834324, 13528509, 14589654 ].map(d3_rgbString); var d3_category20c = [ 3244733, 7057110, 10406625, 13032431, 15095053, 16616764, 16625259, 16634018, 3253076, 7652470, 10607003, 13101504, 7695281, 10394312, 12369372, 14342891, 6513507, 9868950, 12434877, 14277081 ].map(d3_rgbString); d3.scale.quantile = function() { return d3_scale_quantile([], []); }; function d3_scale_quantile(domain, range) { var thresholds; function rescale() { var k = 0, q = range.length; thresholds = []; while (++k < q) thresholds[k - 1] = d3.quantile(domain, k / q); return scale; } function scale(x) { if (!isNaN(x = +x)) return range[d3.bisect(thresholds, x)]; } scale.domain = function(x) { if (!arguments.length) return domain; domain = x.map(d3_number).filter(d3_numeric).sort(d3_ascending); return rescale(); }; scale.range = function(x) { if (!arguments.length) return range; range = x; return rescale(); }; scale.quantiles = function() { return thresholds; }; scale.invertExtent = function(y) { y = range.indexOf(y); return y < 0 ? [ NaN, NaN ] : [ y > 0 ? thresholds[y - 1] : domain[0], y < thresholds.length ? thresholds[y] : domain[domain.length - 1] ]; }; scale.copy = function() { return d3_scale_quantile(domain, range); }; return rescale(); } d3.scale.quantize = function() { return d3_scale_quantize(0, 1, [ 0, 1 ]); }; function d3_scale_quantize(x0, x1, range) { var kx, i; function scale(x) { return range[Math.max(0, Math.min(i, Math.floor(kx * (x - x0))))]; } function rescale() { kx = range.length / (x1 - x0); i = range.length - 1; return scale; } scale.domain = function(x) { if (!arguments.length) return [ x0, x1 ]; x0 = +x[0]; x1 = +x[x.length - 1]; return rescale(); }; scale.range = function(x) { if (!arguments.length) return range; range = x; return rescale(); }; scale.invertExtent = function(y) { y = range.indexOf(y); y = y < 0 ? NaN : y / kx + x0; return [ y, y + 1 / kx ]; }; scale.copy = function() { return d3_scale_quantize(x0, x1, range); }; return rescale(); } d3.scale.threshold = function() { return d3_scale_threshold([ .5 ], [ 0, 1 ]); }; function d3_scale_threshold(domain, range) { function scale(x) { if (x <= x) return range[d3.bisect(domain, x)]; } scale.domain = function(_) { if (!arguments.length) return domain; domain = _; return scale; }; scale.range = function(_) { if (!arguments.length) return range; range = _; return scale; }; scale.invertExtent = function(y) { y = range.indexOf(y); return [ domain[y - 1], domain[y] ]; }; scale.copy = function() { return d3_scale_threshold(domain, range); }; return scale; } d3.scale.identity = function() { return d3_scale_identity([ 0, 1 ]); }; function d3_scale_identity(domain) { function identity(x) { return +x; } identity.invert = identity; identity.domain = identity.range = function(x) { if (!arguments.length) return domain; domain = x.map(identity); return identity; }; identity.ticks = function(m) { return d3_scale_linearTicks(domain, m); }; identity.tickFormat = function(m, format) { return d3_scale_linearTickFormat(domain, m, format); }; identity.copy = function() { return d3_scale_identity(domain); }; return identity; } d3.svg = {}; function d3_zero() { return 0; } d3.svg.arc = function() { var innerRadius = d3_svg_arcInnerRadius, outerRadius = d3_svg_arcOuterRadius, cornerRadius = d3_zero, padRadius = d3_svg_arcAuto, startAngle = d3_svg_arcStartAngle, endAngle = d3_svg_arcEndAngle, padAngle = d3_svg_arcPadAngle; function arc() { var r0 = Math.max(0, +innerRadius.apply(this, arguments)), r1 = Math.max(0, +outerRadius.apply(this, arguments)), a0 = startAngle.apply(this, arguments) - halfπ, a1 = endAngle.apply(this, arguments) - halfπ, da = Math.abs(a1 - a0), cw = a0 > a1 ? 0 : 1; if (r1 < r0) rc = r1, r1 = r0, r0 = rc; if (da >= τε) return circleSegment(r1, cw) + (r0 ? circleSegment(r0, 1 - cw) : "") + "Z"; var rc, cr, rp, ap, p0 = 0, p1 = 0, x0, y0, x1, y1, x2, y2, x3, y3, path = []; if (ap = (+padAngle.apply(this, arguments) || 0) / 2) { rp = padRadius === d3_svg_arcAuto ? Math.sqrt(r0 * r0 + r1 * r1) : +padRadius.apply(this, arguments); if (!cw) p1 *= -1; if (r1) p1 = d3_asin(rp / r1 * Math.sin(ap)); if (r0) p0 = d3_asin(rp / r0 * Math.sin(ap)); } if (r1) { x0 = r1 * Math.cos(a0 + p1); y0 = r1 * Math.sin(a0 + p1); x1 = r1 * Math.cos(a1 - p1); y1 = r1 * Math.sin(a1 - p1); var l1 = Math.abs(a1 - a0 - 2 * p1) <= π ? 0 : 1; if (p1 && d3_svg_arcSweep(x0, y0, x1, y1) === cw ^ l1) { var h1 = (a0 + a1) / 2; x0 = r1 * Math.cos(h1); y0 = r1 * Math.sin(h1); x1 = y1 = null; } } else { x0 = y0 = 0; } if (r0) { x2 = r0 * Math.cos(a1 - p0); y2 = r0 * Math.sin(a1 - p0); x3 = r0 * Math.cos(a0 + p0); y3 = r0 * Math.sin(a0 + p0); var l0 = Math.abs(a0 - a1 + 2 * p0) <= π ? 0 : 1; if (p0 && d3_svg_arcSweep(x2, y2, x3, y3) === 1 - cw ^ l0) { var h0 = (a0 + a1) / 2; x2 = r0 * Math.cos(h0); y2 = r0 * Math.sin(h0); x3 = y3 = null; } } else { x2 = y2 = 0; } if (da > ε && (rc = Math.min(Math.abs(r1 - r0) / 2, +cornerRadius.apply(this, arguments))) > .001) { cr = r0 < r1 ^ cw ? 0 : 1; var rc1 = rc, rc0 = rc; if (da < π) { var oc = x3 == null ? [ x2, y2 ] : x1 == null ? [ x0, y0 ] : d3_geom_polygonIntersect([ x0, y0 ], [ x3, y3 ], [ x1, y1 ], [ x2, y2 ]), ax = x0 - oc[0], ay = y0 - oc[1], bx = x1 - oc[0], by = y1 - oc[1], kc = 1 / Math.sin(Math.acos((ax * bx + ay * by) / (Math.sqrt(ax * ax + ay * ay) * Math.sqrt(bx * bx + by * by))) / 2), lc = Math.sqrt(oc[0] * oc[0] + oc[1] * oc[1]); rc0 = Math.min(rc, (r0 - lc) / (kc - 1)); rc1 = Math.min(rc, (r1 - lc) / (kc + 1)); } if (x1 != null) { var t30 = d3_svg_arcCornerTangents(x3 == null ? [ x2, y2 ] : [ x3, y3 ], [ x0, y0 ], r1, rc1, cw), t12 = d3_svg_arcCornerTangents([ x1, y1 ], [ x2, y2 ], r1, rc1, cw); if (rc === rc1) { path.push("M", t30[0], "A", rc1, ",", rc1, " 0 0,", cr, " ", t30[1], "A", r1, ",", r1, " 0 ", 1 - cw ^ d3_svg_arcSweep(t30[1][0], t30[1][1], t12[1][0], t12[1][1]), ",", cw, " ", t12[1], "A", rc1, ",", rc1, " 0 0,", cr, " ", t12[0]); } else { path.push("M", t30[0], "A", rc1, ",", rc1, " 0 1,", cr, " ", t12[0]); } } else { path.push("M", x0, ",", y0); } if (x3 != null) { var t03 = d3_svg_arcCornerTangents([ x0, y0 ], [ x3, y3 ], r0, -rc0, cw), t21 = d3_svg_arcCornerTangents([ x2, y2 ], x1 == null ? [ x0, y0 ] : [ x1, y1 ], r0, -rc0, cw); if (rc === rc0) { path.push("L", t21[0], "A", rc0, ",", rc0, " 0 0,", cr, " ", t21[1], "A", r0, ",", r0, " 0 ", cw ^ d3_svg_arcSweep(t21[1][0], t21[1][1], t03[1][0], t03[1][1]), ",", 1 - cw, " ", t03[1], "A", rc0, ",", rc0, " 0 0,", cr, " ", t03[0]); } else { path.push("L", t21[0], "A", rc0, ",", rc0, " 0 0,", cr, " ", t03[0]); } } else { path.push("L", x2, ",", y2); } } else { path.push("M", x0, ",", y0); if (x1 != null) path.push("A", r1, ",", r1, " 0 ", l1, ",", cw, " ", x1, ",", y1); path.push("L", x2, ",", y2); if (x3 != null) path.push("A", r0, ",", r0, " 0 ", l0, ",", 1 - cw, " ", x3, ",", y3); } path.push("Z"); return path.join(""); } function circleSegment(r1, cw) { return "M0," + r1 + "A" + r1 + "," + r1 + " 0 1," + cw + " 0," + -r1 + "A" + r1 + "," + r1 + " 0 1," + cw + " 0," + r1; } arc.innerRadius = function(v) { if (!arguments.length) return innerRadius; innerRadius = d3_functor(v); return arc; }; arc.outerRadius = function(v) { if (!arguments.length) return outerRadius; outerRadius = d3_functor(v); return arc; }; arc.cornerRadius = function(v) { if (!arguments.length) return cornerRadius; cornerRadius = d3_functor(v); return arc; }; arc.padRadius = function(v) { if (!arguments.length) return padRadius; padRadius = v == d3_svg_arcAuto ? d3_svg_arcAuto : d3_functor(v); return arc; }; arc.startAngle = function(v) { if (!arguments.length) return startAngle; startAngle = d3_functor(v); return arc; }; arc.endAngle = function(v) { if (!arguments.length) return endAngle; endAngle = d3_functor(v); return arc; }; arc.padAngle = function(v) { if (!arguments.length) return padAngle; padAngle = d3_functor(v); return arc; }; arc.centroid = function() { var r = (+innerRadius.apply(this, arguments) + +outerRadius.apply(this, arguments)) / 2, a = (+startAngle.apply(this, arguments) + +endAngle.apply(this, arguments)) / 2 - halfπ; return [ Math.cos(a) * r, Math.sin(a) * r ]; }; return arc; }; var d3_svg_arcAuto = "auto"; function d3_svg_arcInnerRadius(d) { return d.innerRadius; } function d3_svg_arcOuterRadius(d) { return d.outerRadius; } function d3_svg_arcStartAngle(d) { return d.startAngle; } function d3_svg_arcEndAngle(d) { return d.endAngle; } function d3_svg_arcPadAngle(d) { return d && d.padAngle; } function d3_svg_arcSweep(x0, y0, x1, y1) { return (x0 - x1) * y0 - (y0 - y1) * x0 > 0 ? 0 : 1; } function d3_svg_arcCornerTangents(p0, p1, r1, rc, cw) { var x01 = p0[0] - p1[0], y01 = p0[1] - p1[1], lo = (cw ? rc : -rc) / Math.sqrt(x01 * x01 + y01 * y01), ox = lo * y01, oy = -lo * x01, x1 = p0[0] + ox, y1 = p0[1] + oy, x2 = p1[0] + ox, y2 = p1[1] + oy, x3 = (x1 + x2) / 2, y3 = (y1 + y2) / 2, dx = x2 - x1, dy = y2 - y1, d2 = dx * dx + dy * dy, r = r1 - rc, D = x1 * y2 - x2 * y1, d = (dy < 0 ? -1 : 1) * Math.sqrt(Math.max(0, r * r * d2 - D * D)), cx0 = (D * dy - dx * d) / d2, cy0 = (-D * dx - dy * d) / d2, cx1 = (D * dy + dx * d) / d2, cy1 = (-D * dx + dy * d) / d2, dx0 = cx0 - x3, dy0 = cy0 - y3, dx1 = cx1 - x3, dy1 = cy1 - y3; if (dx0 * dx0 + dy0 * dy0 > dx1 * dx1 + dy1 * dy1) cx0 = cx1, cy0 = cy1; return [ [ cx0 - ox, cy0 - oy ], [ cx0 * r1 / r, cy0 * r1 / r ] ]; } function d3_svg_line(projection) { var x = d3_geom_pointX, y = d3_geom_pointY, defined = d3_true, interpolate = d3_svg_lineLinear, interpolateKey = interpolate.key, tension = .7; function line(data) { var segments = [], points = [], i = -1, n = data.length, d, fx = d3_functor(x), fy = d3_functor(y); function segment() { segments.push("M", interpolate(projection(points), tension)); } while (++i < n) { if (defined.call(this, d = data[i], i)) { points.push([ +fx.call(this, d, i), +fy.call(this, d, i) ]); } else if (points.length) { segment(); points = []; } } if (points.length) segment(); return segments.length ? segments.join("") : null; } line.x = function(_) { if (!arguments.length) return x; x = _; return line; }; line.y = function(_) { if (!arguments.length) return y; y = _; return line; }; line.defined = function(_) { if (!arguments.length) return defined; defined = _; return line; }; line.interpolate = function(_) { if (!arguments.length) return interpolateKey; if (typeof _ === "function") interpolateKey = interpolate = _; else interpolateKey = (interpolate = d3_svg_lineInterpolators.get(_) || d3_svg_lineLinear).key; return line; }; line.tension = function(_) { if (!arguments.length) return tension; tension = _; return line; }; return line; } d3.svg.line = function() { return d3_svg_line(d3_identity); }; var d3_svg_lineInterpolators = d3.map({ linear: d3_svg_lineLinear, "linear-closed": d3_svg_lineLinearClosed, step: d3_svg_lineStep, "step-before": d3_svg_lineStepBefore, "step-after": d3_svg_lineStepAfter, basis: d3_svg_lineBasis, "basis-open": d3_svg_lineBasisOpen, "basis-closed": d3_svg_lineBasisClosed, bundle: d3_svg_lineBundle, cardinal: d3_svg_lineCardinal, "cardinal-open": d3_svg_lineCardinalOpen, "cardinal-closed": d3_svg_lineCardinalClosed, monotone: d3_svg_lineMonotone }); d3_svg_lineInterpolators.forEach(function(key, value) { value.key = key; value.closed = /-closed$/.test(key); }); function d3_svg_lineLinear(points) { return points.length > 1 ? points.join("L") : points + "Z"; } function d3_svg_lineLinearClosed(points) { return points.join("L") + "Z"; } function d3_svg_lineStep(points) { var i = 0, n = points.length, p = points[0], path = [ p[0], ",", p[1] ]; while (++i < n) path.push("H", (p[0] + (p = points[i])[0]) / 2, "V", p[1]); if (n > 1) path.push("H", p[0]); return path.join(""); } function d3_svg_lineStepBefore(points) { var i = 0, n = points.length, p = points[0], path = [ p[0], ",", p[1] ]; while (++i < n) path.push("V", (p = points[i])[1], "H", p[0]); return path.join(""); } function d3_svg_lineStepAfter(points) { var i = 0, n = points.length, p = points[0], path = [ p[0], ",", p[1] ]; while (++i < n) path.push("H", (p = points[i])[0], "V", p[1]); return path.join(""); } function d3_svg_lineCardinalOpen(points, tension) { return points.length < 4 ? d3_svg_lineLinear(points) : points[1] + d3_svg_lineHermite(points.slice(1, -1), d3_svg_lineCardinalTangents(points, tension)); } function d3_svg_lineCardinalClosed(points, tension) { return points.length < 3 ? d3_svg_lineLinearClosed(points) : points[0] + d3_svg_lineHermite((points.push(points[0]), points), d3_svg_lineCardinalTangents([ points[points.length - 2] ].concat(points, [ points[1] ]), tension)); } function d3_svg_lineCardinal(points, tension) { return points.length < 3 ? d3_svg_lineLinear(points) : points[0] + d3_svg_lineHermite(points, d3_svg_lineCardinalTangents(points, tension)); } function d3_svg_lineHermite(points, tangents) { if (tangents.length < 1 || points.length != tangents.length && points.length != tangents.length + 2) { return d3_svg_lineLinear(points); } var quad = points.length != tangents.length, path = "", p0 = points[0], p = points[1], t0 = tangents[0], t = t0, pi = 1; if (quad) { path += "Q" + (p[0] - t0[0] * 2 / 3) + "," + (p[1] - t0[1] * 2 / 3) + "," + p[0] + "," + p[1]; p0 = points[1]; pi = 2; } if (tangents.length > 1) { t = tangents[1]; p = points[pi]; pi++; path += "C" + (p0[0] + t0[0]) + "," + (p0[1] + t0[1]) + "," + (p[0] - t[0]) + "," + (p[1] - t[1]) + "," + p[0] + "," + p[1]; for (var i = 2; i < tangents.length; i++, pi++) { p = points[pi]; t = tangents[i]; path += "S" + (p[0] - t[0]) + "," + (p[1] - t[1]) + "," + p[0] + "," + p[1]; } } if (quad) { var lp = points[pi]; path += "Q" + (p[0] + t[0] * 2 / 3) + "," + (p[1] + t[1] * 2 / 3) + "," + lp[0] + "," + lp[1]; } return path; } function d3_svg_lineCardinalTangents(points, tension) { var tangents = [], a = (1 - tension) / 2, p0, p1 = points[0], p2 = points[1], i = 1, n = points.length; while (++i < n) { p0 = p1; p1 = p2; p2 = points[i]; tangents.push([ a * (p2[0] - p0[0]), a * (p2[1] - p0[1]) ]); } return tangents; } function d3_svg_lineBasis(points) { if (points.length < 3) return d3_svg_lineLinear(points); var i = 1, n = points.length, pi = points[0], x0 = pi[0], y0 = pi[1], px = [ x0, x0, x0, (pi = points[1])[0] ], py = [ y0, y0, y0, pi[1] ], path = [ x0, ",", y0, "L", d3_svg_lineDot4(d3_svg_lineBasisBezier3, px), ",", d3_svg_lineDot4(d3_svg_lineBasisBezier3, py) ]; points.push(points[n - 1]); while (++i <= n) { pi = points[i]; px.shift(); px.push(pi[0]); py.shift(); py.push(pi[1]); d3_svg_lineBasisBezier(path, px, py); } points.pop(); path.push("L", pi); return path.join(""); } function d3_svg_lineBasisOpen(points) { if (points.length < 4) return d3_svg_lineLinear(points); var path = [], i = -1, n = points.length, pi, px = [ 0 ], py = [ 0 ]; while (++i < 3) { pi = points[i]; px.push(pi[0]); py.push(pi[1]); } path.push(d3_svg_lineDot4(d3_svg_lineBasisBezier3, px) + "," + d3_svg_lineDot4(d3_svg_lineBasisBezier3, py)); --i; while (++i < n) { pi = points[i]; px.shift(); px.push(pi[0]); py.shift(); py.push(pi[1]); d3_svg_lineBasisBezier(path, px, py); } return path.join(""); } function d3_svg_lineBasisClosed(points) { var path, i = -1, n = points.length, m = n + 4, pi, px = [], py = []; while (++i < 4) { pi = points[i % n]; px.push(pi[0]); py.push(pi[1]); } path = [ d3_svg_lineDot4(d3_svg_lineBasisBezier3, px), ",", d3_svg_lineDot4(d3_svg_lineBasisBezier3, py) ]; --i; while (++i < m) { pi = points[i % n]; px.shift(); px.push(pi[0]); py.shift(); py.push(pi[1]); d3_svg_lineBasisBezier(path, px, py); } return path.join(""); } function d3_svg_lineBundle(points, tension) { var n = points.length - 1; if (n) { var x0 = points[0][0], y0 = points[0][1], dx = points[n][0] - x0, dy = points[n][1] - y0, i = -1, p, t; while (++i <= n) { p = points[i]; t = i / n; p[0] = tension * p[0] + (1 - tension) * (x0 + t * dx); p[1] = tension * p[1] + (1 - tension) * (y0 + t * dy); } } return d3_svg_lineBasis(points); } function d3_svg_lineDot4(a, b) { return a[0] * b[0] + a[1] * b[1] + a[2] * b[2] + a[3] * b[3]; } var d3_svg_lineBasisBezier1 = [ 0, 2 / 3, 1 / 3, 0 ], d3_svg_lineBasisBezier2 = [ 0, 1 / 3, 2 / 3, 0 ], d3_svg_lineBasisBezier3 = [ 0, 1 / 6, 2 / 3, 1 / 6 ]; function d3_svg_lineBasisBezier(path, x, y) { path.push("C", d3_svg_lineDot4(d3_svg_lineBasisBezier1, x), ",", d3_svg_lineDot4(d3_svg_lineBasisBezier1, y), ",", d3_svg_lineDot4(d3_svg_lineBasisBezier2, x), ",", d3_svg_lineDot4(d3_svg_lineBasisBezier2, y), ",", d3_svg_lineDot4(d3_svg_lineBasisBezier3, x), ",", d3_svg_lineDot4(d3_svg_lineBasisBezier3, y)); } function d3_svg_lineSlope(p0, p1) { return (p1[1] - p0[1]) / (p1[0] - p0[0]); } function d3_svg_lineFiniteDifferences(points) { var i = 0, j = points.length - 1, m = [], p0 = points[0], p1 = points[1], d = m[0] = d3_svg_lineSlope(p0, p1); while (++i < j) { m[i] = (d + (d = d3_svg_lineSlope(p0 = p1, p1 = points[i + 1]))) / 2; } m[i] = d; return m; } function d3_svg_lineMonotoneTangents(points) { var tangents = [], d, a, b, s, m = d3_svg_lineFiniteDifferences(points), i = -1, j = points.length - 1; while (++i < j) { d = d3_svg_lineSlope(points[i], points[i + 1]); if (abs(d) < ε) { m[i] = m[i + 1] = 0; } else { a = m[i] / d; b = m[i + 1] / d; s = a * a + b * b; if (s > 9) { s = d * 3 / Math.sqrt(s); m[i] = s * a; m[i + 1] = s * b; } } } i = -1; while (++i <= j) { s = (points[Math.min(j, i + 1)][0] - points[Math.max(0, i - 1)][0]) / (6 * (1 + m[i] * m[i])); tangents.push([ s || 0, m[i] * s || 0 ]); } return tangents; } function d3_svg_lineMonotone(points) { return points.length < 3 ? d3_svg_lineLinear(points) : points[0] + d3_svg_lineHermite(points, d3_svg_lineMonotoneTangents(points)); } d3.svg.line.radial = function() { var line = d3_svg_line(d3_svg_lineRadial); line.radius = line.x, delete line.x; line.angle = line.y, delete line.y; return line; }; function d3_svg_lineRadial(points) { var point, i = -1, n = points.length, r, a; while (++i < n) { point = points[i]; r = point[0]; a = point[1] - halfπ; point[0] = r * Math.cos(a); point[1] = r * Math.sin(a); } return points; } function d3_svg_area(projection) { var x0 = d3_geom_pointX, x1 = d3_geom_pointX, y0 = 0, y1 = d3_geom_pointY, defined = d3_true, interpolate = d3_svg_lineLinear, interpolateKey = interpolate.key, interpolateReverse = interpolate, L = "L", tension = .7; function area(data) { var segments = [], points0 = [], points1 = [], i = -1, n = data.length, d, fx0 = d3_functor(x0), fy0 = d3_functor(y0), fx1 = x0 === x1 ? function() { return x; } : d3_functor(x1), fy1 = y0 === y1 ? function() { return y; } : d3_functor(y1), x, y; function segment() { segments.push("M", interpolate(projection(points1), tension), L, interpolateReverse(projection(points0.reverse()), tension), "Z"); } while (++i < n) { if (defined.call(this, d = data[i], i)) { points0.push([ x = +fx0.call(this, d, i), y = +fy0.call(this, d, i) ]); points1.push([ +fx1.call(this, d, i), +fy1.call(this, d, i) ]); } else if (points0.length) { segment(); points0 = []; points1 = []; } } if (points0.length) segment(); return segments.length ? segments.join("") : null; } area.x = function(_) { if (!arguments.length) return x1; x0 = x1 = _; return area; }; area.x0 = function(_) { if (!arguments.length) return x0; x0 = _; return area; }; area.x1 = function(_) { if (!arguments.length) return x1; x1 = _; return area; }; area.y = function(_) { if (!arguments.length) return y1; y0 = y1 = _; return area; }; area.y0 = function(_) { if (!arguments.length) return y0; y0 = _; return area; }; area.y1 = function(_) { if (!arguments.length) return y1; y1 = _; return area; }; area.defined = function(_) { if (!arguments.length) return defined; defined = _; return area; }; area.interpolate = function(_) { if (!arguments.length) return interpolateKey; if (typeof _ === "function") interpolateKey = interpolate = _; else interpolateKey = (interpolate = d3_svg_lineInterpolators.get(_) || d3_svg_lineLinear).key; interpolateReverse = interpolate.reverse || interpolate; L = interpolate.closed ? "M" : "L"; return area; }; area.tension = function(_) { if (!arguments.length) return tension; tension = _; return area; }; return area; } d3_svg_lineStepBefore.reverse = d3_svg_lineStepAfter; d3_svg_lineStepAfter.reverse = d3_svg_lineStepBefore; d3.svg.area = function() { return d3_svg_area(d3_identity); }; d3.svg.area.radial = function() { var area = d3_svg_area(d3_svg_lineRadial); area.radius = area.x, delete area.x; area.innerRadius = area.x0, delete area.x0; area.outerRadius = area.x1, delete area.x1; area.angle = area.y, delete area.y; area.startAngle = area.y0, delete area.y0; area.endAngle = area.y1, delete area.y1; return area; }; d3.svg.chord = function() { var source = d3_source, target = d3_target, radius = d3_svg_chordRadius, startAngle = d3_svg_arcStartAngle, endAngle = d3_svg_arcEndAngle; function chord(d, i) { var s = subgroup(this, source, d, i), t = subgroup(this, target, d, i); return "M" + s.p0 + arc(s.r, s.p1, s.a1 - s.a0) + (equals(s, t) ? curve(s.r, s.p1, s.r, s.p0) : curve(s.r, s.p1, t.r, t.p0) + arc(t.r, t.p1, t.a1 - t.a0) + curve(t.r, t.p1, s.r, s.p0)) + "Z"; } function subgroup(self, f, d, i) { var subgroup = f.call(self, d, i), r = radius.call(self, subgroup, i), a0 = startAngle.call(self, subgroup, i) - halfπ, a1 = endAngle.call(self, subgroup, i) - halfπ; return { r: r, a0: a0, a1: a1, p0: [ r * Math.cos(a0), r * Math.sin(a0) ], p1: [ r * Math.cos(a1), r * Math.sin(a1) ] }; } function equals(a, b) { return a.a0 == b.a0 && a.a1 == b.a1; } function arc(r, p, a) { return "A" + r + "," + r + " 0 " + +(a > π) + ",1 " + p; } function curve(r0, p0, r1, p1) { return "Q 0,0 " + p1; } chord.radius = function(v) { if (!arguments.length) return radius; radius = d3_functor(v); return chord; }; chord.source = function(v) { if (!arguments.length) return source; source = d3_functor(v); return chord; }; chord.target = function(v) { if (!arguments.length) return target; target = d3_functor(v); return chord; }; chord.startAngle = function(v) { if (!arguments.length) return startAngle; startAngle = d3_functor(v); return chord; }; chord.endAngle = function(v) { if (!arguments.length) return endAngle; endAngle = d3_functor(v); return chord; }; return chord; }; function d3_svg_chordRadius(d) { return d.radius; } d3.svg.diagonal = function() { var source = d3_source, target = d3_target, projection = d3_svg_diagonalProjection; function diagonal(d, i) { var p0 = source.call(this, d, i), p3 = target.call(this, d, i), m = (p0.y + p3.y) / 2, p = [ p0, { x: p0.x, y: m }, { x: p3.x, y: m }, p3 ]; p = p.map(projection); return "M" + p[0] + "C" + p[1] + " " + p[2] + " " + p[3]; } diagonal.source = function(x) { if (!arguments.length) return source; source = d3_functor(x); return diagonal; }; diagonal.target = function(x) { if (!arguments.length) return target; target = d3_functor(x); return diagonal; }; diagonal.projection = function(x) { if (!arguments.length) return projection; projection = x; return diagonal; }; return diagonal; }; function d3_svg_diagonalProjection(d) { return [ d.x, d.y ]; } d3.svg.diagonal.radial = function() { var diagonal = d3.svg.diagonal(), projection = d3_svg_diagonalProjection, projection_ = diagonal.projection; diagonal.projection = function(x) { return arguments.length ? projection_(d3_svg_diagonalRadialProjection(projection = x)) : projection; }; return diagonal; }; function d3_svg_diagonalRadialProjection(projection) { return function() { var d = projection.apply(this, arguments), r = d[0], a = d[1] - halfπ; return [ r * Math.cos(a), r * Math.sin(a) ]; }; } d3.svg.symbol = function() { var type = d3_svg_symbolType, size = d3_svg_symbolSize; function symbol(d, i) { return (d3_svg_symbols.get(type.call(this, d, i)) || d3_svg_symbolCircle)(size.call(this, d, i)); } symbol.type = function(x) { if (!arguments.length) return type; type = d3_functor(x); return symbol; }; symbol.size = function(x) { if (!arguments.length) return size; size = d3_functor(x); return symbol; }; return symbol; }; function d3_svg_symbolSize() { return 64; } function d3_svg_symbolType() { return "circle"; } function d3_svg_symbolCircle(size) { var r = Math.sqrt(size / π); return "M0," + r + "A" + r + "," + r + " 0 1,1 0," + -r + "A" + r + "," + r + " 0 1,1 0," + r + "Z"; } var d3_svg_symbols = d3.map({ circle: d3_svg_symbolCircle, cross: function(size) { var r = Math.sqrt(size / 5) / 2; return "M" + -3 * r + "," + -r + "H" + -r + "V" + -3 * r + "H" + r + "V" + -r + "H" + 3 * r + "V" + r + "H" + r + "V" + 3 * r + "H" + -r + "V" + r + "H" + -3 * r + "Z"; }, diamond: function(size) { var ry = Math.sqrt(size / (2 * d3_svg_symbolTan30)), rx = ry * d3_svg_symbolTan30; return "M0," + -ry + "L" + rx + ",0" + " 0," + ry + " " + -rx + ",0" + "Z"; }, square: function(size) { var r = Math.sqrt(size) / 2; return "M" + -r + "," + -r + "L" + r + "," + -r + " " + r + "," + r + " " + -r + "," + r + "Z"; }, "triangle-down": function(size) { var rx = Math.sqrt(size / d3_svg_symbolSqrt3), ry = rx * d3_svg_symbolSqrt3 / 2; return "M0," + ry + "L" + rx + "," + -ry + " " + -rx + "," + -ry + "Z"; }, "triangle-up": function(size) { var rx = Math.sqrt(size / d3_svg_symbolSqrt3), ry = rx * d3_svg_symbolSqrt3 / 2; return "M0," + -ry + "L" + rx + "," + ry + " " + -rx + "," + ry + "Z"; } }); d3.svg.symbolTypes = d3_svg_symbols.keys(); var d3_svg_symbolSqrt3 = Math.sqrt(3), d3_svg_symbolTan30 = Math.tan(30 * d3_radians); d3_selectionPrototype.transition = function(name) { var id = d3_transitionInheritId || ++d3_transitionId, ns = d3_transitionNamespace(name), subgroups = [], subgroup, node, transition = d3_transitionInherit || { time: Date.now(), ease: d3_ease_cubicInOut, delay: 0, duration: 250 }; for (var j = -1, m = this.length; ++j < m; ) { subgroups.push(subgroup = []); for (var group = this[j], i = -1, n = group.length; ++i < n; ) { if (node = group[i]) d3_transitionNode(node, i, ns, id, transition); subgroup.push(node); } } return d3_transition(subgroups, ns, id); }; d3_selectionPrototype.interrupt = function(name) { return this.each(name == null ? d3_selection_interrupt : d3_selection_interruptNS(d3_transitionNamespace(name))); }; var d3_selection_interrupt = d3_selection_interruptNS(d3_transitionNamespace()); function d3_selection_interruptNS(ns) { return function() { var lock, activeId, active; if ((lock = this[ns]) && (active = lock[activeId = lock.active])) { active.timer.c = null; active.timer.t = NaN; if (--lock.count) delete lock[activeId]; else delete this[ns]; lock.active += .5; active.event && active.event.interrupt.call(this, this.__data__, active.index); } }; } function d3_transition(groups, ns, id) { d3_subclass(groups, d3_transitionPrototype); groups.namespace = ns; groups.id = id; return groups; } var d3_transitionPrototype = [], d3_transitionId = 0, d3_transitionInheritId, d3_transitionInherit; d3_transitionPrototype.call = d3_selectionPrototype.call; d3_transitionPrototype.empty = d3_selectionPrototype.empty; d3_transitionPrototype.node = d3_selectionPrototype.node; d3_transitionPrototype.size = d3_selectionPrototype.size; d3.transition = function(selection, name) { return selection && selection.transition ? d3_transitionInheritId ? selection.transition(name) : selection : d3.selection().transition(selection); }; d3.transition.prototype = d3_transitionPrototype; d3_transitionPrototype.select = function(selector) { var id = this.id, ns = this.namespace, subgroups = [], subgroup, subnode, node; selector = d3_selection_selector(selector); for (var j = -1, m = this.length; ++j < m; ) { subgroups.push(subgroup = []); for (var group = this[j], i = -1, n = group.length; ++i < n; ) { if ((node = group[i]) && (subnode = selector.call(node, node.__data__, i, j))) { if ("__data__" in node) subnode.__data__ = node.__data__; d3_transitionNode(subnode, i, ns, id, node[ns][id]); subgroup.push(subnode); } else { subgroup.push(null); } } } return d3_transition(subgroups, ns, id); }; d3_transitionPrototype.selectAll = function(selector) { var id = this.id, ns = this.namespace, subgroups = [], subgroup, subnodes, node, subnode, transition; selector = d3_selection_selectorAll(selector); for (var j = -1, m = this.length; ++j < m; ) { for (var group = this[j], i = -1, n = group.length; ++i < n; ) { if (node = group[i]) { transition = node[ns][id]; subnodes = selector.call(node, node.__data__, i, j); subgroups.push(subgroup = []); for (var k = -1, o = subnodes.length; ++k < o; ) { if (subnode = subnodes[k]) d3_transitionNode(subnode, k, ns, id, transition); subgroup.push(subnode); } } } } return d3_transition(subgroups, ns, id); }; d3_transitionPrototype.filter = function(filter) { var subgroups = [], subgroup, group, node; if (typeof filter !== "function") filter = d3_selection_filter(filter); for (var j = 0, m = this.length; j < m; j++) { subgroups.push(subgroup = []); for (var group = this[j], i = 0, n = group.length; i < n; i++) { if ((node = group[i]) && filter.call(node, node.__data__, i, j)) { subgroup.push(node); } } } return d3_transition(subgroups, this.namespace, this.id); }; d3_transitionPrototype.tween = function(name, tween) { var id = this.id, ns = this.namespace; if (arguments.length < 2) return this.node()[ns][id].tween.get(name); return d3_selection_each(this, tween == null ? function(node) { node[ns][id].tween.remove(name); } : function(node) { node[ns][id].tween.set(name, tween); }); }; function d3_transition_tween(groups, name, value, tween) { var id = groups.id, ns = groups.namespace; return d3_selection_each(groups, typeof value === "function" ? function(node, i, j) { node[ns][id].tween.set(name, tween(value.call(node, node.__data__, i, j))); } : (value = tween(value), function(node) { node[ns][id].tween.set(name, value); })); } d3_transitionPrototype.attr = function(nameNS, value) { if (arguments.length < 2) { for (value in nameNS) this.attr(value, nameNS[value]); return this; } var interpolate = nameNS == "transform" ? d3_interpolateTransform : d3_interpolate, name = d3.ns.qualify(nameNS); function attrNull() { this.removeAttribute(name); } function attrNullNS() { this.removeAttributeNS(name.space, name.local); } function attrTween(b) { return b == null ? attrNull : (b += "", function() { var a = this.getAttribute(name), i; return a !== b && (i = interpolate(a, b), function(t) { this.setAttribute(name, i(t)); }); }); } function attrTweenNS(b) { return b == null ? attrNullNS : (b += "", function() { var a = this.getAttributeNS(name.space, name.local), i; return a !== b && (i = interpolate(a, b), function(t) { this.setAttributeNS(name.space, name.local, i(t)); }); }); } return d3_transition_tween(this, "attr." + nameNS, value, name.local ? attrTweenNS : attrTween); }; d3_transitionPrototype.attrTween = function(nameNS, tween) { var name = d3.ns.qualify(nameNS); function attrTween(d, i) { var f = tween.call(this, d, i, this.getAttribute(name)); return f && function(t) { this.setAttribute(name, f(t)); }; } function attrTweenNS(d, i) { var f = tween.call(this, d, i, this.getAttributeNS(name.space, name.local)); return f && function(t) { this.setAttributeNS(name.space, name.local, f(t)); }; } return this.tween("attr." + nameNS, name.local ? attrTweenNS : attrTween); }; d3_transitionPrototype.style = function(name, value, priority) { var n = arguments.length; if (n < 3) { if (typeof name !== "string") { if (n < 2) value = ""; for (priority in name) this.style(priority, name[priority], value); return this; } priority = ""; } function styleNull() { this.style.removeProperty(name); } function styleString(b) { return b == null ? styleNull : (b += "", function() { var a = d3_window(this).getComputedStyle(this, null).getPropertyValue(name), i; return a !== b && (i = d3_interpolate(a, b), function(t) { this.style.setProperty(name, i(t), priority); }); }); } return d3_transition_tween(this, "style." + name, value, styleString); }; d3_transitionPrototype.styleTween = function(name, tween, priority) { if (arguments.length < 3) priority = ""; function styleTween(d, i) { var f = tween.call(this, d, i, d3_window(this).getComputedStyle(this, null).getPropertyValue(name)); return f && function(t) { this.style.setProperty(name, f(t), priority); }; } return this.tween("style." + name, styleTween); }; d3_transitionPrototype.text = function(value) { return d3_transition_tween(this, "text", value, d3_transition_text); }; function d3_transition_text(b) { if (b == null) b = ""; return function() { this.textContent = b; }; } d3_transitionPrototype.remove = function() { var ns = this.namespace; return this.each("end.transition", function() { var p; if (this[ns].count < 2 && (p = this.parentNode)) p.removeChild(this); }); }; d3_transitionPrototype.ease = function(value) { var id = this.id, ns = this.namespace; if (arguments.length < 1) return this.node()[ns][id].ease; if (typeof value !== "function") value = d3.ease.apply(d3, arguments); return d3_selection_each(this, function(node) { node[ns][id].ease = value; }); }; d3_transitionPrototype.delay = function(value) { var id = this.id, ns = this.namespace; if (arguments.length < 1) return this.node()[ns][id].delay; return d3_selection_each(this, typeof value === "function" ? function(node, i, j) { node[ns][id].delay = +value.call(node, node.__data__, i, j); } : (value = +value, function(node) { node[ns][id].delay = value; })); }; d3_transitionPrototype.duration = function(value) { var id = this.id, ns = this.namespace; if (arguments.length < 1) return this.node()[ns][id].duration; return d3_selection_each(this, typeof value === "function" ? function(node, i, j) { node[ns][id].duration = Math.max(1, value.call(node, node.__data__, i, j)); } : (value = Math.max(1, value), function(node) { node[ns][id].duration = value; })); }; d3_transitionPrototype.each = function(type, listener) { var id = this.id, ns = this.namespace; if (arguments.length < 2) { var inherit = d3_transitionInherit, inheritId = d3_transitionInheritId; try { d3_transitionInheritId = id; d3_selection_each(this, function(node, i, j) { d3_transitionInherit = node[ns][id]; type.call(node, node.__data__, i, j); }); } finally { d3_transitionInherit = inherit; d3_transitionInheritId = inheritId; } } else { d3_selection_each(this, function(node) { var transition = node[ns][id]; (transition.event || (transition.event = d3.dispatch("start", "end", "interrupt"))).on(type, listener); }); } return this; }; d3_transitionPrototype.transition = function() { var id0 = this.id, id1 = ++d3_transitionId, ns = this.namespace, subgroups = [], subgroup, group, node, transition; for (var j = 0, m = this.length; j < m; j++) { subgroups.push(subgroup = []); for (var group = this[j], i = 0, n = group.length; i < n; i++) { if (node = group[i]) { transition = node[ns][id0]; d3_transitionNode(node, i, ns, id1, { time: transition.time, ease: transition.ease, delay: transition.delay + transition.duration, duration: transition.duration }); } subgroup.push(node); } } return d3_transition(subgroups, ns, id1); }; function d3_transitionNamespace(name) { return name == null ? "__transition__" : "__transition_" + name + "__"; } function d3_transitionNode(node, i, ns, id, inherit) { var lock = node[ns] || (node[ns] = { active: 0, count: 0 }), transition = lock[id], time, timer, duration, ease, tweens; function schedule(elapsed) { var delay = transition.delay; timer.t = delay + time; if (delay <= elapsed) return start(elapsed - delay); timer.c = start; } function start(elapsed) { var activeId = lock.active, active = lock[activeId]; if (active) { active.timer.c = null; active.timer.t = NaN; --lock.count; delete lock[activeId]; active.event && active.event.interrupt.call(node, node.__data__, active.index); } for (var cancelId in lock) { if (+cancelId < id) { var cancel = lock[cancelId]; cancel.timer.c = null; cancel.timer.t = NaN; --lock.count; delete lock[cancelId]; } } timer.c = tick; d3_timer(function() { if (timer.c && tick(elapsed || 1)) { timer.c = null; timer.t = NaN; } return 1; }, 0, time); lock.active = id; transition.event && transition.event.start.call(node, node.__data__, i); tweens = []; transition.tween.forEach(function(key, value) { if (value = value.call(node, node.__data__, i)) { tweens.push(value); } }); ease = transition.ease; duration = transition.duration; } function tick(elapsed) { var t = elapsed / duration, e = ease(t), n = tweens.length; while (n > 0) { tweens[--n].call(node, e); } if (t >= 1) { transition.event && transition.event.end.call(node, node.__data__, i); if (--lock.count) delete lock[id]; else delete node[ns]; return 1; } } if (!transition) { time = inherit.time; timer = d3_timer(schedule, 0, time); transition = lock[id] = { tween: new d3_Map(), time: time, timer: timer, delay: inherit.delay, duration: inherit.duration, ease: inherit.ease, index: i }; inherit = null; ++lock.count; } } d3.svg.axis = function() { var scale = d3.scale.linear(), orient = d3_svg_axisDefaultOrient, innerTickSize = 6, outerTickSize = 6, tickPadding = 3, tickArguments_ = [ 10 ], tickValues = null, tickFormat_; function axis(g) { g.each(function() { var g = d3.select(this); var scale0 = this.__chart__ || scale, scale1 = this.__chart__ = scale.copy(); var ticks = tickValues == null ? scale1.ticks ? scale1.ticks.apply(scale1, tickArguments_) : scale1.domain() : tickValues, tickFormat = tickFormat_ == null ? scale1.tickFormat ? scale1.tickFormat.apply(scale1, tickArguments_) : d3_identity : tickFormat_, tick = g.selectAll(".tick").data(ticks, scale1), tickEnter = tick.enter().insert("g", ".domain").attr("class", "tick").style("opacity", ε), tickExit = d3.transition(tick.exit()).style("opacity", ε).remove(), tickUpdate = d3.transition(tick.order()).style("opacity", 1), tickSpacing = Math.max(innerTickSize, 0) + tickPadding, tickTransform; var range = d3_scaleRange(scale1), path = g.selectAll(".domain").data([ 0 ]), pathUpdate = (path.enter().append("path").attr("class", "domain"), d3.transition(path)); tickEnter.append("line"); tickEnter.append("text"); var lineEnter = tickEnter.select("line"), lineUpdate = tickUpdate.select("line"), text = tick.select("text").text(tickFormat), textEnter = tickEnter.select("text"), textUpdate = tickUpdate.select("text"), sign = orient === "top" || orient === "left" ? -1 : 1, x1, x2, y1, y2; if (orient === "bottom" || orient === "top") { tickTransform = d3_svg_axisX, x1 = "x", y1 = "y", x2 = "x2", y2 = "y2"; text.attr("dy", sign < 0 ? "0em" : ".71em").style("text-anchor", "middle"); pathUpdate.attr("d", "M" + range[0] + "," + sign * outerTickSize + "V0H" + range[1] + "V" + sign * outerTickSize); } else { tickTransform = d3_svg_axisY, x1 = "y", y1 = "x", x2 = "y2", y2 = "x2"; text.attr("dy", ".32em").style("text-anchor", sign < 0 ? "end" : "start"); pathUpdate.attr("d", "M" + sign * outerTickSize + "," + range[0] + "H0V" + range[1] + "H" + sign * outerTickSize); } lineEnter.attr(y2, sign * innerTickSize); textEnter.attr(y1, sign * tickSpacing); lineUpdate.attr(x2, 0).attr(y2, sign * innerTickSize); textUpdate.attr(x1, 0).attr(y1, sign * tickSpacing); if (scale1.rangeBand) { var x = scale1, dx = x.rangeBand() / 2; scale0 = scale1 = function(d) { return x(d) + dx; }; } else if (scale0.rangeBand) { scale0 = scale1; } else { tickExit.call(tickTransform, scale1, scale0); } tickEnter.call(tickTransform, scale0, scale1); tickUpdate.call(tickTransform, scale1, scale1); }); } axis.scale = function(x) { if (!arguments.length) return scale; scale = x; return axis; }; axis.orient = function(x) { if (!arguments.length) return orient; orient = x in d3_svg_axisOrients ? x + "" : d3_svg_axisDefaultOrient; return axis; }; axis.ticks = function() { if (!arguments.length) return tickArguments_; tickArguments_ = d3_array(arguments); return axis; }; axis.tickValues = function(x) { if (!arguments.length) return tickValues; tickValues = x; return axis; }; axis.tickFormat = function(x) { if (!arguments.length) return tickFormat_; tickFormat_ = x; return axis; }; axis.tickSize = function(x) { var n = arguments.length; if (!n) return innerTickSize; innerTickSize = +x; outerTickSize = +arguments[n - 1]; return axis; }; axis.innerTickSize = function(x) { if (!arguments.length) return innerTickSize; innerTickSize = +x; return axis; }; axis.outerTickSize = function(x) { if (!arguments.length) return outerTickSize; outerTickSize = +x; return axis; }; axis.tickPadding = function(x) { if (!arguments.length) return tickPadding; tickPadding = +x; return axis; }; axis.tickSubdivide = function() { return arguments.length && axis; }; return axis; }; var d3_svg_axisDefaultOrient = "bottom", d3_svg_axisOrients = { top: 1, right: 1, bottom: 1, left: 1 }; function d3_svg_axisX(selection, x0, x1) { selection.attr("transform", function(d) { var v0 = x0(d); return "translate(" + (isFinite(v0) ? v0 : x1(d)) + ",0)"; }); } function d3_svg_axisY(selection, y0, y1) { selection.attr("transform", function(d) { var v0 = y0(d); return "translate(0," + (isFinite(v0) ? v0 : y1(d)) + ")"; }); } d3.svg.brush = function() { var event = d3_eventDispatch(brush, "brushstart", "brush", "brushend"), x = null, y = null, xExtent = [ 0, 0 ], yExtent = [ 0, 0 ], xExtentDomain, yExtentDomain, xClamp = true, yClamp = true, resizes = d3_svg_brushResizes[0]; function brush(g) { g.each(function() { var g = d3.select(this).style("pointer-events", "all").style("-webkit-tap-highlight-color", "rgba(0,0,0,0)").on("mousedown.brush", brushstart).on("touchstart.brush", brushstart); var background = g.selectAll(".background").data([ 0 ]); background.enter().append("rect").attr("class", "background").style("visibility", "hidden").style("cursor", "crosshair"); g.selectAll(".extent").data([ 0 ]).enter().append("rect").attr("class", "extent").style("cursor", "move"); var resize = g.selectAll(".resize").data(resizes, d3_identity); resize.exit().remove(); resize.enter().append("g").attr("class", function(d) { return "resize " + d; }).style("cursor", function(d) { return d3_svg_brushCursor[d]; }).append("rect").attr("x", function(d) { return /[ew]$/.test(d) ? -3 : null; }).attr("y", function(d) { return /^[ns]/.test(d) ? -3 : null; }).attr("width", 6).attr("height", 6).style("visibility", "hidden"); resize.style("display", brush.empty() ? "none" : null); var gUpdate = d3.transition(g), backgroundUpdate = d3.transition(background), range; if (x) { range = d3_scaleRange(x); backgroundUpdate.attr("x", range[0]).attr("width", range[1] - range[0]); redrawX(gUpdate); } if (y) { range = d3_scaleRange(y); backgroundUpdate.attr("y", range[0]).attr("height", range[1] - range[0]); redrawY(gUpdate); } redraw(gUpdate); }); } brush.event = function(g) { g.each(function() { var event_ = event.of(this, arguments), extent1 = { x: xExtent, y: yExtent, i: xExtentDomain, j: yExtentDomain }, extent0 = this.__chart__ || extent1; this.__chart__ = extent1; if (d3_transitionInheritId) { d3.select(this).transition().each("start.brush", function() { xExtentDomain = extent0.i; yExtentDomain = extent0.j; xExtent = extent0.x; yExtent = extent0.y; event_({ type: "brushstart" }); }).tween("brush:brush", function() { var xi = d3_interpolateArray(xExtent, extent1.x), yi = d3_interpolateArray(yExtent, extent1.y); xExtentDomain = yExtentDomain = null; return function(t) { xExtent = extent1.x = xi(t); yExtent = extent1.y = yi(t); event_({ type: "brush", mode: "resize" }); }; }).each("end.brush", function() { xExtentDomain = extent1.i; yExtentDomain = extent1.j; event_({ type: "brush", mode: "resize" }); event_({ type: "brushend" }); }); } else { event_({ type: "brushstart" }); event_({ type: "brush", mode: "resize" }); event_({ type: "brushend" }); } }); }; function redraw(g) { g.selectAll(".resize").attr("transform", function(d) { return "translate(" + xExtent[+/e$/.test(d)] + "," + yExtent[+/^s/.test(d)] + ")"; }); } function redrawX(g) { g.select(".extent").attr("x", xExtent[0]); g.selectAll(".extent,.n>rect,.s>rect").attr("width", xExtent[1] - xExtent[0]); } function redrawY(g) { g.select(".extent").attr("y", yExtent[0]); g.selectAll(".extent,.e>rect,.w>rect").attr("height", yExtent[1] - yExtent[0]); } function brushstart() { var target = this, eventTarget = d3.select(d3.event.target), event_ = event.of(target, arguments), g = d3.select(target), resizing = eventTarget.datum(), resizingX = !/^(n|s)$/.test(resizing) && x, resizingY = !/^(e|w)$/.test(resizing) && y, dragging = eventTarget.classed("extent"), dragRestore = d3_event_dragSuppress(target), center, origin = d3.mouse(target), offset; var w = d3.select(d3_window(target)).on("keydown.brush", keydown).on("keyup.brush", keyup); if (d3.event.changedTouches) { w.on("touchmove.brush", brushmove).on("touchend.brush", brushend); } else { w.on("mousemove.brush", brushmove).on("mouseup.brush", brushend); } g.interrupt().selectAll("*").interrupt(); if (dragging) { origin[0] = xExtent[0] - origin[0]; origin[1] = yExtent[0] - origin[1]; } else if (resizing) { var ex = +/w$/.test(resizing), ey = +/^n/.test(resizing); offset = [ xExtent[1 - ex] - origin[0], yExtent[1 - ey] - origin[1] ]; origin[0] = xExtent[ex]; origin[1] = yExtent[ey]; } else if (d3.event.altKey) center = origin.slice(); g.style("pointer-events", "none").selectAll(".resize").style("display", null); d3.select("body").style("cursor", eventTarget.style("cursor")); event_({ type: "brushstart" }); brushmove(); function keydown() { if (d3.event.keyCode == 32) { if (!dragging) { center = null; origin[0] -= xExtent[1]; origin[1] -= yExtent[1]; dragging = 2; } d3_eventPreventDefault(); } } function keyup() { if (d3.event.keyCode == 32 && dragging == 2) { origin[0] += xExtent[1]; origin[1] += yExtent[1]; dragging = 0; d3_eventPreventDefault(); } } function brushmove() { var point = d3.mouse(target), moved = false; if (offset) { point[0] += offset[0]; point[1] += offset[1]; } if (!dragging) { if (d3.event.altKey) { if (!center) center = [ (xExtent[0] + xExtent[1]) / 2, (yExtent[0] + yExtent[1]) / 2 ]; origin[0] = xExtent[+(point[0] < center[0])]; origin[1] = yExtent[+(point[1] < center[1])]; } else center = null; } if (resizingX && move1(point, x, 0)) { redrawX(g); moved = true; } if (resizingY && move1(point, y, 1)) { redrawY(g); moved = true; } if (moved) { redraw(g); event_({ type: "brush", mode: dragging ? "move" : "resize" }); } } function move1(point, scale, i) { var range = d3_scaleRange(scale), r0 = range[0], r1 = range[1], position = origin[i], extent = i ? yExtent : xExtent, size = extent[1] - extent[0], min, max; if (dragging) { r0 -= position; r1 -= size + position; } min = (i ? yClamp : xClamp) ? Math.max(r0, Math.min(r1, point[i])) : point[i]; if (dragging) { max = (min += position) + size; } else { if (center) position = Math.max(r0, Math.min(r1, 2 * center[i] - min)); if (position < min) { max = min; min = position; } else { max = position; } } if (extent[0] != min || extent[1] != max) { if (i) yExtentDomain = null; else xExtentDomain = null; extent[0] = min; extent[1] = max; return true; } } function brushend() { brushmove(); g.style("pointer-events", "all").selectAll(".resize").style("display", brush.empty() ? "none" : null); d3.select("body").style("cursor", null); w.on("mousemove.brush", null).on("mouseup.brush", null).on("touchmove.brush", null).on("touchend.brush", null).on("keydown.brush", null).on("keyup.brush", null); dragRestore(); event_({ type: "brushend" }); } } brush.x = function(z) { if (!arguments.length) return x; x = z; resizes = d3_svg_brushResizes[!x << 1 | !y]; return brush; }; brush.y = function(z) { if (!arguments.length) return y; y = z; resizes = d3_svg_brushResizes[!x << 1 | !y]; return brush; }; brush.clamp = function(z) { if (!arguments.length) return x && y ? [ xClamp, yClamp ] : x ? xClamp : y ? yClamp : null; if (x && y) xClamp = !!z[0], yClamp = !!z[1]; else if (x) xClamp = !!z; else if (y) yClamp = !!z; return brush; }; brush.extent = function(z) { var x0, x1, y0, y1, t; if (!arguments.length) { if (x) { if (xExtentDomain) { x0 = xExtentDomain[0], x1 = xExtentDomain[1]; } else { x0 = xExtent[0], x1 = xExtent[1]; if (x.invert) x0 = x.invert(x0), x1 = x.invert(x1); if (x1 < x0) t = x0, x0 = x1, x1 = t; } } if (y) { if (yExtentDomain) { y0 = yExtentDomain[0], y1 = yExtentDomain[1]; } else { y0 = yExtent[0], y1 = yExtent[1]; if (y.invert) y0 = y.invert(y0), y1 = y.invert(y1); if (y1 < y0) t = y0, y0 = y1, y1 = t; } } return x && y ? [ [ x0, y0 ], [ x1, y1 ] ] : x ? [ x0, x1 ] : y && [ y0, y1 ]; } if (x) { x0 = z[0], x1 = z[1]; if (y) x0 = x0[0], x1 = x1[0]; xExtentDomain = [ x0, x1 ]; if (x.invert) x0 = x(x0), x1 = x(x1); if (x1 < x0) t = x0, x0 = x1, x1 = t; if (x0 != xExtent[0] || x1 != xExtent[1]) xExtent = [ x0, x1 ]; } if (y) { y0 = z[0], y1 = z[1]; if (x) y0 = y0[1], y1 = y1[1]; yExtentDomain = [ y0, y1 ]; if (y.invert) y0 = y(y0), y1 = y(y1); if (y1 < y0) t = y0, y0 = y1, y1 = t; if (y0 != yExtent[0] || y1 != yExtent[1]) yExtent = [ y0, y1 ]; } return brush; }; brush.clear = function() { if (!brush.empty()) { xExtent = [ 0, 0 ], yExtent = [ 0, 0 ]; xExtentDomain = yExtentDomain = null; } return brush; }; brush.empty = function() { return !!x && xExtent[0] == xExtent[1] || !!y && yExtent[0] == yExtent[1]; }; return d3.rebind(brush, event, "on"); }; var d3_svg_brushCursor = { n: "ns-resize", e: "ew-resize", s: "ns-resize", w: "ew-resize", nw: "nwse-resize", ne: "nesw-resize", se: "nwse-resize", sw: "nesw-resize" }; var d3_svg_brushResizes = [ [ "n", "e", "s", "w", "nw", "ne", "se", "sw" ], [ "e", "w" ], [ "n", "s" ], [] ]; var d3_time_format = d3_time.format = d3_locale_enUS.timeFormat; var d3_time_formatUtc = d3_time_format.utc; var d3_time_formatIso = d3_time_formatUtc("%Y-%m-%dT%H:%M:%S.%LZ"); d3_time_format.iso = Date.prototype.toISOString && +new Date("2000-01-01T00:00:00.000Z") ? d3_time_formatIsoNative : d3_time_formatIso; function d3_time_formatIsoNative(date) { return date.toISOString(); } d3_time_formatIsoNative.parse = function(string) { var date = new Date(string); return isNaN(date) ? null : date; }; d3_time_formatIsoNative.toString = d3_time_formatIso.toString; d3_time.second = d3_time_interval(function(date) { return new d3_date(Math.floor(date / 1e3) * 1e3); }, function(date, offset) { date.setTime(date.getTime() + Math.floor(offset) * 1e3); }, function(date) { return date.getSeconds(); }); d3_time.seconds = d3_time.second.range; d3_time.seconds.utc = d3_time.second.utc.range; d3_time.minute = d3_time_interval(function(date) { return new d3_date(Math.floor(date / 6e4) * 6e4); }, function(date, offset) { date.setTime(date.getTime() + Math.floor(offset) * 6e4); }, function(date) { return date.getMinutes(); }); d3_time.minutes = d3_time.minute.range; d3_time.minutes.utc = d3_time.minute.utc.range; d3_time.hour = d3_time_interval(function(date) { var timezone = date.getTimezoneOffset() / 60; return new d3_date((Math.floor(date / 36e5 - timezone) + timezone) * 36e5); }, function(date, offset) { date.setTime(date.getTime() + Math.floor(offset) * 36e5); }, function(date) { return date.getHours(); }); d3_time.hours = d3_time.hour.range; d3_time.hours.utc = d3_time.hour.utc.range; d3_time.month = d3_time_interval(function(date) { date = d3_time.day(date); date.setDate(1); return date; }, function(date, offset) { date.setMonth(date.getMonth() + offset); }, function(date) { return date.getMonth(); }); d3_time.months = d3_time.month.range; d3_time.months.utc = d3_time.month.utc.range; function d3_time_scale(linear, methods, format) { function scale(x) { return linear(x); } scale.invert = function(x) { return d3_time_scaleDate(linear.invert(x)); }; scale.domain = function(x) { if (!arguments.length) return linear.domain().map(d3_time_scaleDate); linear.domain(x); return scale; }; function tickMethod(extent, count) { var span = extent[1] - extent[0], target = span / count, i = d3.bisect(d3_time_scaleSteps, target); return i == d3_time_scaleSteps.length ? [ methods.year, d3_scale_linearTickRange(extent.map(function(d) { return d / 31536e6; }), count)[2] ] : !i ? [ d3_time_scaleMilliseconds, d3_scale_linearTickRange(extent, count)[2] ] : methods[target / d3_time_scaleSteps[i - 1] < d3_time_scaleSteps[i] / target ? i - 1 : i]; } scale.nice = function(interval, skip) { var domain = scale.domain(), extent = d3_scaleExtent(domain), method = interval == null ? tickMethod(extent, 10) : typeof interval === "number" && tickMethod(extent, interval); if (method) interval = method[0], skip = method[1]; function skipped(date) { return !isNaN(date) && !interval.range(date, d3_time_scaleDate(+date + 1), skip).length; } return scale.domain(d3_scale_nice(domain, skip > 1 ? { floor: function(date) { while (skipped(date = interval.floor(date))) date = d3_time_scaleDate(date - 1); return date; }, ceil: function(date) { while (skipped(date = interval.ceil(date))) date = d3_time_scaleDate(+date + 1); return date; } } : interval)); }; scale.ticks = function(interval, skip) { var extent = d3_scaleExtent(scale.domain()), method = interval == null ? tickMethod(extent, 10) : typeof interval === "number" ? tickMethod(extent, interval) : !interval.range && [ { range: interval }, skip ]; if (method) interval = method[0], skip = method[1]; return interval.range(extent[0], d3_time_scaleDate(+extent[1] + 1), skip < 1 ? 1 : skip); }; scale.tickFormat = function() { return format; }; scale.copy = function() { return d3_time_scale(linear.copy(), methods, format); }; return d3_scale_linearRebind(scale, linear); } function d3_time_scaleDate(t) { return new Date(t); } var d3_time_scaleSteps = [ 1e3, 5e3, 15e3, 3e4, 6e4, 3e5, 9e5, 18e5, 36e5, 108e5, 216e5, 432e5, 864e5, 1728e5, 6048e5, 2592e6, 7776e6, 31536e6 ]; var d3_time_scaleLocalMethods = [ [ d3_time.second, 1 ], [ d3_time.second, 5 ], [ d3_time.second, 15 ], [ d3_time.second, 30 ], [ d3_time.minute, 1 ], [ d3_time.minute, 5 ], [ d3_time.minute, 15 ], [ d3_time.minute, 30 ], [ d3_time.hour, 1 ], [ d3_time.hour, 3 ], [ d3_time.hour, 6 ], [ d3_time.hour, 12 ], [ d3_time.day, 1 ], [ d3_time.day, 2 ], [ d3_time.week, 1 ], [ d3_time.month, 1 ], [ d3_time.month, 3 ], [ d3_time.year, 1 ] ]; var d3_time_scaleLocalFormat = d3_time_format.multi([ [ ".%L", function(d) { return d.getMilliseconds(); } ], [ ":%S", function(d) { return d.getSeconds(); } ], [ "%I:%M", function(d) { return d.getMinutes(); } ], [ "%I %p", function(d) { return d.getHours(); } ], [ "%a %d", function(d) { return d.getDay() && d.getDate() != 1; } ], [ "%b %d", function(d) { return d.getDate() != 1; } ], [ "%B", function(d) { return d.getMonth(); } ], [ "%Y", d3_true ] ]); var d3_time_scaleMilliseconds = { range: function(start, stop, step) { return d3.range(Math.ceil(start / step) * step, +stop, step).map(d3_time_scaleDate); }, floor: d3_identity, ceil: d3_identity }; d3_time_scaleLocalMethods.year = d3_time.year; d3_time.scale = function() { return d3_time_scale(d3.scale.linear(), d3_time_scaleLocalMethods, d3_time_scaleLocalFormat); }; var d3_time_scaleUtcMethods = d3_time_scaleLocalMethods.map(function(m) { return [ m[0].utc, m[1] ]; }); var d3_time_scaleUtcFormat = d3_time_formatUtc.multi([ [ ".%L", function(d) { return d.getUTCMilliseconds(); } ], [ ":%S", function(d) { return d.getUTCSeconds(); } ], [ "%I:%M", function(d) { return d.getUTCMinutes(); } ], [ "%I %p", function(d) { return d.getUTCHours(); } ], [ "%a %d", function(d) { return d.getUTCDay() && d.getUTCDate() != 1; } ], [ "%b %d", function(d) { return d.getUTCDate() != 1; } ], [ "%B", function(d) { return d.getUTCMonth(); } ], [ "%Y", d3_true ] ]); d3_time_scaleUtcMethods.year = d3_time.year.utc; d3_time.scale.utc = function() { return d3_time_scale(d3.scale.linear(), d3_time_scaleUtcMethods, d3_time_scaleUtcFormat); }; d3.text = d3_xhrType(function(request) { return request.responseText; }); d3.json = function(url, callback) { return d3_xhr(url, "application/json", d3_json, callback); }; function d3_json(request) { return JSON.parse(request.responseText); } d3.html = function(url, callback) { return d3_xhr(url, "text/html", d3_html, callback); }; function d3_html(request) { var range = d3_document.createRange(); range.selectNode(d3_document.body); return range.createContextualFragment(request.responseText); } d3.xml = d3_xhrType(function(request) { return request.responseXML; }); if (typeof define === "function" && define.amd) this.d3 = d3, define(d3); else if (typeof module === "object" && module.exports) module.exports = d3; else this.d3 = d3; }(); },{}],71:[function(require,module,exports){ "use strict" var ch = require("incremental-convex-hull") var uniq = require("uniq") module.exports = triangulate function LiftedPoint(p, i) { this.point = p this.index = i } function compareLifted(a, b) { var ap = a.point var bp = b.point var d = ap.length for(var i=0; i= 2) { return false } } cell[j] = v } return true }) } else { hull = hull.filter(function(cell) { for(var i=0; i<=d; ++i) { var v = dindex[cell[i]] if(v < 0) { return false } cell[i] = v } return true }) } if(d & 1) { for(var i=0; i 0) { return dupe_number(count|0, value) } break case "object": if(typeof (count.length) === "number") { return dupe_array(count, value, 0) } break } return [] } module.exports = dupe },{}],73:[function(require,module,exports){ (function (process,global){ /*! * @overview es6-promise - a tiny implementation of Promises/A+. * @copyright Copyright (c) 2014 Yehuda Katz, Tom Dale, Stefan Penner and contributors (Conversion to ES6 API by Jake Archibald) * @license Licensed under MIT license * See https://raw.githubusercontent.com/jakearchibald/es6-promise/master/LICENSE * @version 3.0.2 */ (function() { "use strict"; function lib$es6$promise$utils$$objectOrFunction(x) { return typeof x === 'function' || (typeof x === 'object' && x !== null); } function lib$es6$promise$utils$$isFunction(x) { return typeof x === 'function'; } function lib$es6$promise$utils$$isMaybeThenable(x) { return typeof x === 'object' && x !== null; } var lib$es6$promise$utils$$_isArray; if (!Array.isArray) { lib$es6$promise$utils$$_isArray = function (x) { return Object.prototype.toString.call(x) === '[object Array]'; }; } else { lib$es6$promise$utils$$_isArray = Array.isArray; } var lib$es6$promise$utils$$isArray = lib$es6$promise$utils$$_isArray; var lib$es6$promise$asap$$len = 0; var lib$es6$promise$asap$$toString = {}.toString; var lib$es6$promise$asap$$vertxNext; var lib$es6$promise$asap$$customSchedulerFn; var lib$es6$promise$asap$$asap = function asap(callback, arg) { lib$es6$promise$asap$$queue[lib$es6$promise$asap$$len] = callback; lib$es6$promise$asap$$queue[lib$es6$promise$asap$$len + 1] = arg; lib$es6$promise$asap$$len += 2; if (lib$es6$promise$asap$$len === 2) { // If len is 2, that means that we need to schedule an async flush. // If additional callbacks are queued before the queue is flushed, they // will be processed by this flush that we are scheduling. if (lib$es6$promise$asap$$customSchedulerFn) { lib$es6$promise$asap$$customSchedulerFn(lib$es6$promise$asap$$flush); } else { lib$es6$promise$asap$$scheduleFlush(); } } } function lib$es6$promise$asap$$setScheduler(scheduleFn) { lib$es6$promise$asap$$customSchedulerFn = scheduleFn; } function lib$es6$promise$asap$$setAsap(asapFn) { lib$es6$promise$asap$$asap = asapFn; } var lib$es6$promise$asap$$browserWindow = (typeof window !== 'undefined') ? window : undefined; var lib$es6$promise$asap$$browserGlobal = lib$es6$promise$asap$$browserWindow || {}; var lib$es6$promise$asap$$BrowserMutationObserver = lib$es6$promise$asap$$browserGlobal.MutationObserver || lib$es6$promise$asap$$browserGlobal.WebKitMutationObserver; var lib$es6$promise$asap$$isNode = typeof process !== 'undefined' && {}.toString.call(process) === '[object process]'; // test for web worker but not in IE10 var lib$es6$promise$asap$$isWorker = typeof Uint8ClampedArray !== 'undefined' && typeof importScripts !== 'undefined' && typeof MessageChannel !== 'undefined'; // node function lib$es6$promise$asap$$useNextTick() { // node version 0.10.x displays a deprecation warning when nextTick is used recursively // see https://github.com/cujojs/when/issues/410 for details return function() { process.nextTick(lib$es6$promise$asap$$flush); }; } // vertx function lib$es6$promise$asap$$useVertxTimer() { return function() { lib$es6$promise$asap$$vertxNext(lib$es6$promise$asap$$flush); }; } function lib$es6$promise$asap$$useMutationObserver() { var iterations = 0; var observer = new lib$es6$promise$asap$$BrowserMutationObserver(lib$es6$promise$asap$$flush); var node = document.createTextNode(''); observer.observe(node, { characterData: true }); return function() { node.data = (iterations = ++iterations % 2); }; } // web worker function lib$es6$promise$asap$$useMessageChannel() { var channel = new MessageChannel(); channel.port1.onmessage = lib$es6$promise$asap$$flush; return function () { channel.port2.postMessage(0); }; } function lib$es6$promise$asap$$useSetTimeout() { return function() { setTimeout(lib$es6$promise$asap$$flush, 1); }; } var lib$es6$promise$asap$$queue = new Array(1000); function lib$es6$promise$asap$$flush() { for (var i = 0; i < lib$es6$promise$asap$$len; i+=2) { var callback = lib$es6$promise$asap$$queue[i]; var arg = lib$es6$promise$asap$$queue[i+1]; callback(arg); lib$es6$promise$asap$$queue[i] = undefined; lib$es6$promise$asap$$queue[i+1] = undefined; } lib$es6$promise$asap$$len = 0; } function lib$es6$promise$asap$$attemptVertx() { try { var r = require; var vertx = r('vertx'); lib$es6$promise$asap$$vertxNext = vertx.runOnLoop || vertx.runOnContext; return lib$es6$promise$asap$$useVertxTimer(); } catch(e) { return lib$es6$promise$asap$$useSetTimeout(); } } var lib$es6$promise$asap$$scheduleFlush; // Decide what async method to use to triggering processing of queued callbacks: if (lib$es6$promise$asap$$isNode) { lib$es6$promise$asap$$scheduleFlush = lib$es6$promise$asap$$useNextTick(); } else if (lib$es6$promise$asap$$BrowserMutationObserver) { lib$es6$promise$asap$$scheduleFlush = lib$es6$promise$asap$$useMutationObserver(); } else if (lib$es6$promise$asap$$isWorker) { lib$es6$promise$asap$$scheduleFlush = lib$es6$promise$asap$$useMessageChannel(); } else if (lib$es6$promise$asap$$browserWindow === undefined && typeof require === 'function') { lib$es6$promise$asap$$scheduleFlush = lib$es6$promise$asap$$attemptVertx(); } else { lib$es6$promise$asap$$scheduleFlush = lib$es6$promise$asap$$useSetTimeout(); } function lib$es6$promise$$internal$$noop() {} var lib$es6$promise$$internal$$PENDING = void 0; var lib$es6$promise$$internal$$FULFILLED = 1; var lib$es6$promise$$internal$$REJECTED = 2; var lib$es6$promise$$internal$$GET_THEN_ERROR = new lib$es6$promise$$internal$$ErrorObject(); function lib$es6$promise$$internal$$selfFulfillment() { return new TypeError("You cannot resolve a promise with itself"); } function lib$es6$promise$$internal$$cannotReturnOwn() { return new TypeError('A promises callback cannot return that same promise.'); } function lib$es6$promise$$internal$$getThen(promise) { try { return promise.then; } catch(error) { lib$es6$promise$$internal$$GET_THEN_ERROR.error = error; return lib$es6$promise$$internal$$GET_THEN_ERROR; } } function lib$es6$promise$$internal$$tryThen(then, value, fulfillmentHandler, rejectionHandler) { try { then.call(value, fulfillmentHandler, rejectionHandler); } catch(e) { return e; } } function lib$es6$promise$$internal$$handleForeignThenable(promise, thenable, then) { lib$es6$promise$asap$$asap(function(promise) { var sealed = false; var error = lib$es6$promise$$internal$$tryThen(then, thenable, function(value) { if (sealed) { return; } sealed = true; if (thenable !== value) { lib$es6$promise$$internal$$resolve(promise, value); } else { lib$es6$promise$$internal$$fulfill(promise, value); } }, function(reason) { if (sealed) { return; } sealed = true; lib$es6$promise$$internal$$reject(promise, reason); }, 'Settle: ' + (promise._label || ' unknown promise')); if (!sealed && error) { sealed = true; lib$es6$promise$$internal$$reject(promise, error); } }, promise); } function lib$es6$promise$$internal$$handleOwnThenable(promise, thenable) { if (thenable._state === lib$es6$promise$$internal$$FULFILLED) { lib$es6$promise$$internal$$fulfill(promise, thenable._result); } else if (thenable._state === lib$es6$promise$$internal$$REJECTED) { lib$es6$promise$$internal$$reject(promise, thenable._result); } else { lib$es6$promise$$internal$$subscribe(thenable, undefined, function(value) { lib$es6$promise$$internal$$resolve(promise, value); }, function(reason) { lib$es6$promise$$internal$$reject(promise, reason); }); } } function lib$es6$promise$$internal$$handleMaybeThenable(promise, maybeThenable) { if (maybeThenable.constructor === promise.constructor) { lib$es6$promise$$internal$$handleOwnThenable(promise, maybeThenable); } else { var then = lib$es6$promise$$internal$$getThen(maybeThenable); if (then === lib$es6$promise$$internal$$GET_THEN_ERROR) { lib$es6$promise$$internal$$reject(promise, lib$es6$promise$$internal$$GET_THEN_ERROR.error); } else if (then === undefined) { lib$es6$promise$$internal$$fulfill(promise, maybeThenable); } else if (lib$es6$promise$utils$$isFunction(then)) { lib$es6$promise$$internal$$handleForeignThenable(promise, maybeThenable, then); } else { lib$es6$promise$$internal$$fulfill(promise, maybeThenable); } } } function lib$es6$promise$$internal$$resolve(promise, value) { if (promise === value) { lib$es6$promise$$internal$$reject(promise, lib$es6$promise$$internal$$selfFulfillment()); } else if (lib$es6$promise$utils$$objectOrFunction(value)) { lib$es6$promise$$internal$$handleMaybeThenable(promise, value); } else { lib$es6$promise$$internal$$fulfill(promise, value); } } function lib$es6$promise$$internal$$publishRejection(promise) { if (promise._onerror) { promise._onerror(promise._result); } lib$es6$promise$$internal$$publish(promise); } function lib$es6$promise$$internal$$fulfill(promise, value) { if (promise._state !== lib$es6$promise$$internal$$PENDING) { return; } promise._result = value; promise._state = lib$es6$promise$$internal$$FULFILLED; if (promise._subscribers.length !== 0) { lib$es6$promise$asap$$asap(lib$es6$promise$$internal$$publish, promise); } } function lib$es6$promise$$internal$$reject(promise, reason) { if (promise._state !== lib$es6$promise$$internal$$PENDING) { return; } promise._state = lib$es6$promise$$internal$$REJECTED; promise._result = reason; lib$es6$promise$asap$$asap(lib$es6$promise$$internal$$publishRejection, promise); } function lib$es6$promise$$internal$$subscribe(parent, child, onFulfillment, onRejection) { var subscribers = parent._subscribers; var length = subscribers.length; parent._onerror = null; subscribers[length] = child; subscribers[length + lib$es6$promise$$internal$$FULFILLED] = onFulfillment; subscribers[length + lib$es6$promise$$internal$$REJECTED] = onRejection; if (length === 0 && parent._state) { lib$es6$promise$asap$$asap(lib$es6$promise$$internal$$publish, parent); } } function lib$es6$promise$$internal$$publish(promise) { var subscribers = promise._subscribers; var settled = promise._state; if (subscribers.length === 0) { return; } var child, callback, detail = promise._result; for (var i = 0; i < subscribers.length; i += 3) { child = subscribers[i]; callback = subscribers[i + settled]; if (child) { lib$es6$promise$$internal$$invokeCallback(settled, child, callback, detail); } else { callback(detail); } } promise._subscribers.length = 0; } function lib$es6$promise$$internal$$ErrorObject() { this.error = null; } var lib$es6$promise$$internal$$TRY_CATCH_ERROR = new lib$es6$promise$$internal$$ErrorObject(); function lib$es6$promise$$internal$$tryCatch(callback, detail) { try { return callback(detail); } catch(e) { lib$es6$promise$$internal$$TRY_CATCH_ERROR.error = e; return lib$es6$promise$$internal$$TRY_CATCH_ERROR; } } function lib$es6$promise$$internal$$invokeCallback(settled, promise, callback, detail) { var hasCallback = lib$es6$promise$utils$$isFunction(callback), value, error, succeeded, failed; if (hasCallback) { value = lib$es6$promise$$internal$$tryCatch(callback, detail); if (value === lib$es6$promise$$internal$$TRY_CATCH_ERROR) { failed = true; error = value.error; value = null; } else { succeeded = true; } if (promise === value) { lib$es6$promise$$internal$$reject(promise, lib$es6$promise$$internal$$cannotReturnOwn()); return; } } else { value = detail; succeeded = true; } if (promise._state !== lib$es6$promise$$internal$$PENDING) { // noop } else if (hasCallback && succeeded) { lib$es6$promise$$internal$$resolve(promise, value); } else if (failed) { lib$es6$promise$$internal$$reject(promise, error); } else if (settled === lib$es6$promise$$internal$$FULFILLED) { lib$es6$promise$$internal$$fulfill(promise, value); } else if (settled === lib$es6$promise$$internal$$REJECTED) { lib$es6$promise$$internal$$reject(promise, value); } } function lib$es6$promise$$internal$$initializePromise(promise, resolver) { try { resolver(function resolvePromise(value){ lib$es6$promise$$internal$$resolve(promise, value); }, function rejectPromise(reason) { lib$es6$promise$$internal$$reject(promise, reason); }); } catch(e) { lib$es6$promise$$internal$$reject(promise, e); } } function lib$es6$promise$enumerator$$Enumerator(Constructor, input) { var enumerator = this; enumerator._instanceConstructor = Constructor; enumerator.promise = new Constructor(lib$es6$promise$$internal$$noop); if (enumerator._validateInput(input)) { enumerator._input = input; enumerator.length = input.length; enumerator._remaining = input.length; enumerator._init(); if (enumerator.length === 0) { lib$es6$promise$$internal$$fulfill(enumerator.promise, enumerator._result); } else { enumerator.length = enumerator.length || 0; enumerator._enumerate(); if (enumerator._remaining === 0) { lib$es6$promise$$internal$$fulfill(enumerator.promise, enumerator._result); } } } else { lib$es6$promise$$internal$$reject(enumerator.promise, enumerator._validationError()); } } lib$es6$promise$enumerator$$Enumerator.prototype._validateInput = function(input) { return lib$es6$promise$utils$$isArray(input); }; lib$es6$promise$enumerator$$Enumerator.prototype._validationError = function() { return new Error('Array Methods must be provided an Array'); }; lib$es6$promise$enumerator$$Enumerator.prototype._init = function() { this._result = new Array(this.length); }; var lib$es6$promise$enumerator$$default = lib$es6$promise$enumerator$$Enumerator; lib$es6$promise$enumerator$$Enumerator.prototype._enumerate = function() { var enumerator = this; var length = enumerator.length; var promise = enumerator.promise; var input = enumerator._input; for (var i = 0; promise._state === lib$es6$promise$$internal$$PENDING && i < length; i++) { enumerator._eachEntry(input[i], i); } }; lib$es6$promise$enumerator$$Enumerator.prototype._eachEntry = function(entry, i) { var enumerator = this; var c = enumerator._instanceConstructor; if (lib$es6$promise$utils$$isMaybeThenable(entry)) { if (entry.constructor === c && entry._state !== lib$es6$promise$$internal$$PENDING) { entry._onerror = null; enumerator._settledAt(entry._state, i, entry._result); } else { enumerator._willSettleAt(c.resolve(entry), i); } } else { enumerator._remaining--; enumerator._result[i] = entry; } }; lib$es6$promise$enumerator$$Enumerator.prototype._settledAt = function(state, i, value) { var enumerator = this; var promise = enumerator.promise; if (promise._state === lib$es6$promise$$internal$$PENDING) { enumerator._remaining--; if (state === lib$es6$promise$$internal$$REJECTED) { lib$es6$promise$$internal$$reject(promise, value); } else { enumerator._result[i] = value; } } if (enumerator._remaining === 0) { lib$es6$promise$$internal$$fulfill(promise, enumerator._result); } }; lib$es6$promise$enumerator$$Enumerator.prototype._willSettleAt = function(promise, i) { var enumerator = this; lib$es6$promise$$internal$$subscribe(promise, undefined, function(value) { enumerator._settledAt(lib$es6$promise$$internal$$FULFILLED, i, value); }, function(reason) { enumerator._settledAt(lib$es6$promise$$internal$$REJECTED, i, reason); }); }; function lib$es6$promise$promise$all$$all(entries) { return new lib$es6$promise$enumerator$$default(this, entries).promise; } var lib$es6$promise$promise$all$$default = lib$es6$promise$promise$all$$all; function lib$es6$promise$promise$race$$race(entries) { /*jshint validthis:true */ var Constructor = this; var promise = new Constructor(lib$es6$promise$$internal$$noop); if (!lib$es6$promise$utils$$isArray(entries)) { lib$es6$promise$$internal$$reject(promise, new TypeError('You must pass an array to race.')); return promise; } var length = entries.length; function onFulfillment(value) { lib$es6$promise$$internal$$resolve(promise, value); } function onRejection(reason) { lib$es6$promise$$internal$$reject(promise, reason); } for (var i = 0; promise._state === lib$es6$promise$$internal$$PENDING && i < length; i++) { lib$es6$promise$$internal$$subscribe(Constructor.resolve(entries[i]), undefined, onFulfillment, onRejection); } return promise; } var lib$es6$promise$promise$race$$default = lib$es6$promise$promise$race$$race; function lib$es6$promise$promise$resolve$$resolve(object) { /*jshint validthis:true */ var Constructor = this; if (object && typeof object === 'object' && object.constructor === Constructor) { return object; } var promise = new Constructor(lib$es6$promise$$internal$$noop); lib$es6$promise$$internal$$resolve(promise, object); return promise; } var lib$es6$promise$promise$resolve$$default = lib$es6$promise$promise$resolve$$resolve; function lib$es6$promise$promise$reject$$reject(reason) { /*jshint validthis:true */ var Constructor = this; var promise = new Constructor(lib$es6$promise$$internal$$noop); lib$es6$promise$$internal$$reject(promise, reason); return promise; } var lib$es6$promise$promise$reject$$default = lib$es6$promise$promise$reject$$reject; var lib$es6$promise$promise$$counter = 0; function lib$es6$promise$promise$$needsResolver() { throw new TypeError('You must pass a resolver function as the first argument to the promise constructor'); } function lib$es6$promise$promise$$needsNew() { throw new TypeError("Failed to construct 'Promise': Please use the 'new' operator, this object constructor cannot be called as a function."); } var lib$es6$promise$promise$$default = lib$es6$promise$promise$$Promise; /** Promise objects represent the eventual result of an asynchronous operation. The primary way of interacting with a promise is through its `then` method, which registers callbacks to receive either a promise's eventual value or the reason why the promise cannot be fulfilled. Terminology ----------- - `promise` is an object or function with a `then` method whose behavior conforms to this specification. - `thenable` is an object or function that defines a `then` method. - `value` is any legal JavaScript value (including undefined, a thenable, or a promise). - `exception` is a value that is thrown using the throw statement. - `reason` is a value that indicates why a promise was rejected. - `settled` the final resting state of a promise, fulfilled or rejected. A promise can be in one of three states: pending, fulfilled, or rejected. Promises that are fulfilled have a fulfillment value and are in the fulfilled state. Promises that are rejected have a rejection reason and are in the rejected state. A fulfillment value is never a thenable. Promises can also be said to *resolve* a value. If this value is also a promise, then the original promise's settled state will match the value's settled state. So a promise that *resolves* a promise that rejects will itself reject, and a promise that *resolves* a promise that fulfills will itself fulfill. Basic Usage: ------------ ```js var promise = new Promise(function(resolve, reject) { // on success resolve(value); // on failure reject(reason); }); promise.then(function(value) { // on fulfillment }, function(reason) { // on rejection }); ``` Advanced Usage: --------------- Promises shine when abstracting away asynchronous interactions such as `XMLHttpRequest`s. ```js function getJSON(url) { return new Promise(function(resolve, reject){ var xhr = new XMLHttpRequest(); xhr.open('GET', url); xhr.onreadystatechange = handler; xhr.responseType = 'json'; xhr.setRequestHeader('Accept', 'application/json'); xhr.send(); function handler() { if (this.readyState === this.DONE) { if (this.status === 200) { resolve(this.response); } else { reject(new Error('getJSON: `' + url + '` failed with status: [' + this.status + ']')); } } }; }); } getJSON('/posts.json').then(function(json) { // on fulfillment }, function(reason) { // on rejection }); ``` Unlike callbacks, promises are great composable primitives. ```js Promise.all([ getJSON('/posts'), getJSON('/comments') ]).then(function(values){ values[0] // => postsJSON values[1] // => commentsJSON return values; }); ``` @class Promise @param {function} resolver Useful for tooling. @constructor */ function lib$es6$promise$promise$$Promise(resolver) { this._id = lib$es6$promise$promise$$counter++; this._state = undefined; this._result = undefined; this._subscribers = []; if (lib$es6$promise$$internal$$noop !== resolver) { if (!lib$es6$promise$utils$$isFunction(resolver)) { lib$es6$promise$promise$$needsResolver(); } if (!(this instanceof lib$es6$promise$promise$$Promise)) { lib$es6$promise$promise$$needsNew(); } lib$es6$promise$$internal$$initializePromise(this, resolver); } } lib$es6$promise$promise$$Promise.all = lib$es6$promise$promise$all$$default; lib$es6$promise$promise$$Promise.race = lib$es6$promise$promise$race$$default; lib$es6$promise$promise$$Promise.resolve = lib$es6$promise$promise$resolve$$default; lib$es6$promise$promise$$Promise.reject = lib$es6$promise$promise$reject$$default; lib$es6$promise$promise$$Promise._setScheduler = lib$es6$promise$asap$$setScheduler; lib$es6$promise$promise$$Promise._setAsap = lib$es6$promise$asap$$setAsap; lib$es6$promise$promise$$Promise._asap = lib$es6$promise$asap$$asap; lib$es6$promise$promise$$Promise.prototype = { constructor: lib$es6$promise$promise$$Promise, /** The primary way of interacting with a promise is through its `then` method, which registers callbacks to receive either a promise's eventual value or the reason why the promise cannot be fulfilled. ```js findUser().then(function(user){ // user is available }, function(reason){ // user is unavailable, and you are given the reason why }); ``` Chaining -------- The return value of `then` is itself a promise. This second, 'downstream' promise is resolved with the return value of the first promise's fulfillment or rejection handler, or rejected if the handler throws an exception. ```js findUser().then(function (user) { return user.name; }, function (reason) { return 'default name'; }).then(function (userName) { // If `findUser` fulfilled, `userName` will be the user's name, otherwise it // will be `'default name'` }); findUser().then(function (user) { throw new Error('Found user, but still unhappy'); }, function (reason) { throw new Error('`findUser` rejected and we're unhappy'); }).then(function (value) { // never reached }, function (reason) { // if `findUser` fulfilled, `reason` will be 'Found user, but still unhappy'. // If `findUser` rejected, `reason` will be '`findUser` rejected and we're unhappy'. }); ``` If the downstream promise does not specify a rejection handler, rejection reasons will be propagated further downstream. ```js findUser().then(function (user) { throw new PedagogicalException('Upstream error'); }).then(function (value) { // never reached }).then(function (value) { // never reached }, function (reason) { // The `PedgagocialException` is propagated all the way down to here }); ``` Assimilation ------------ Sometimes the value you want to propagate to a downstream promise can only be retrieved asynchronously. This can be achieved by returning a promise in the fulfillment or rejection handler. The downstream promise will then be pending until the returned promise is settled. This is called *assimilation*. ```js findUser().then(function (user) { return findCommentsByAuthor(user); }).then(function (comments) { // The user's comments are now available }); ``` If the assimliated promise rejects, then the downstream promise will also reject. ```js findUser().then(function (user) { return findCommentsByAuthor(user); }).then(function (comments) { // If `findCommentsByAuthor` fulfills, we'll have the value here }, function (reason) { // If `findCommentsByAuthor` rejects, we'll have the reason here }); ``` Simple Example -------------- Synchronous Example ```javascript var result; try { result = findResult(); // success } catch(reason) { // failure } ``` Errback Example ```js findResult(function(result, err){ if (err) { // failure } else { // success } }); ``` Promise Example; ```javascript findResult().then(function(result){ // success }, function(reason){ // failure }); ``` Advanced Example -------------- Synchronous Example ```javascript var author, books; try { author = findAuthor(); books = findBooksByAuthor(author); // success } catch(reason) { // failure } ``` Errback Example ```js function foundBooks(books) { } function failure(reason) { } findAuthor(function(author, err){ if (err) { failure(err); // failure } else { try { findBoooksByAuthor(author, function(books, err) { if (err) { failure(err); } else { try { foundBooks(books); } catch(reason) { failure(reason); } } }); } catch(error) { failure(err); } // success } }); ``` Promise Example; ```javascript findAuthor(). then(findBooksByAuthor). then(function(books){ // found books }).catch(function(reason){ // something went wrong }); ``` @method then @param {Function} onFulfilled @param {Function} onRejected Useful for tooling. @return {Promise} */ then: function(onFulfillment, onRejection) { var parent = this; var state = parent._state; if (state === lib$es6$promise$$internal$$FULFILLED && !onFulfillment || state === lib$es6$promise$$internal$$REJECTED && !onRejection) { return this; } var child = new this.constructor(lib$es6$promise$$internal$$noop); var result = parent._result; if (state) { var callback = arguments[state - 1]; lib$es6$promise$asap$$asap(function(){ lib$es6$promise$$internal$$invokeCallback(state, child, callback, result); }); } else { lib$es6$promise$$internal$$subscribe(parent, child, onFulfillment, onRejection); } return child; }, /** `catch` is simply sugar for `then(undefined, onRejection)` which makes it the same as the catch block of a try/catch statement. ```js function findAuthor(){ throw new Error('couldn't find that author'); } // synchronous try { findAuthor(); } catch(reason) { // something went wrong } // async with promises findAuthor().catch(function(reason){ // something went wrong }); ``` @method catch @param {Function} onRejection Useful for tooling. @return {Promise} */ 'catch': function(onRejection) { return this.then(null, onRejection); } }; function lib$es6$promise$polyfill$$polyfill() { var local; if (typeof global !== 'undefined') { local = global; } else if (typeof self !== 'undefined') { local = self; } else { try { local = Function('return this')(); } catch (e) { throw new Error('polyfill failed because global object is unavailable in this environment'); } } var P = local.Promise; if (P && Object.prototype.toString.call(P.resolve()) === '[object Promise]' && !P.cast) { return; } local.Promise = lib$es6$promise$promise$$default; } var lib$es6$promise$polyfill$$default = lib$es6$promise$polyfill$$polyfill; var lib$es6$promise$umd$$ES6Promise = { 'Promise': lib$es6$promise$promise$$default, 'polyfill': lib$es6$promise$polyfill$$default }; /* global define:true module:true window: true */ if (typeof define === 'function' && define['amd']) { define(function() { return lib$es6$promise$umd$$ES6Promise; }); } else if (typeof module !== 'undefined' && module['exports']) { module['exports'] = lib$es6$promise$umd$$ES6Promise; } else if (typeof this !== 'undefined') { this['ES6Promise'] = lib$es6$promise$umd$$ES6Promise; } lib$es6$promise$polyfill$$default(); }).call(this); }).call(this,require('_process'),typeof global !== "undefined" ? global : typeof self !== "undefined" ? self : typeof window !== "undefined" ? window : {}) },{"_process":55}],74:[function(require,module,exports){ /** * inspired by is-number * but significantly simplified and sped up by ignoring number and string constructors * ie these return false: * new Number(1) * new String('1') */ 'use strict'; /** * Is this string all whitespace? * This solution kind of makes my brain hurt, but it's significantly faster * than !str.trim() or any other solution I could find. * * whitespace codes from: http://en.wikipedia.org/wiki/Whitespace_character * and verified with: * * for(var i = 0; i < 65536; i++) { * var s = String.fromCharCode(i); * if(+s===0 && !s.trim()) console.log(i, s); * } * * which counts a couple of these as *not* whitespace, but finds nothing else * that *is* whitespace. Note that charCodeAt stops at 16 bits, but it appears * that there are no whitespace characters above this, and code points above * this do not map onto white space characters. */ function allBlankCharCodes(str){ var l = str.length, a; for(var i = 0; i < l; i++) { a = str.charCodeAt(i); if((a < 9 || a > 13) && (a !== 32) && (a !== 133) && (a !== 160) && (a !== 5760) && (a !== 6158) && (a < 8192 || a > 8205) && (a !== 8232) && (a !== 8233) && (a !== 8239) && (a !== 8287) && (a !== 8288) && (a !== 12288) && (a !== 65279)) { return false; } } return true; } module.exports = function(n) { var type = typeof n; if(type === 'string') { var original = n; n = +n; // whitespace strings cast to zero - filter them out if(n===0 && allBlankCharCodes(original)) return false; } else if(type !== 'number') return false; return n - n < 1; }; },{}],75:[function(require,module,exports){ "use strict" var pool = require("typedarray-pool") var ops = require("ndarray-ops") var ndarray = require("ndarray") var SUPPORTED_TYPES = [ "uint8", "uint8_clamped", "uint16", "uint32", "int8", "int16", "int32", "float32" ] function GLBuffer(gl, type, handle, length, usage) { this.gl = gl this.type = type this.handle = handle this.length = length this.usage = usage } var proto = GLBuffer.prototype proto.bind = function() { this.gl.bindBuffer(this.type, this.handle) } proto.unbind = function() { this.gl.bindBuffer(this.type, null) } proto.dispose = function() { this.gl.deleteBuffer(this.handle) } function updateTypeArray(gl, type, len, usage, data, offset) { var dataLen = data.length * data.BYTES_PER_ELEMENT if(offset < 0) { gl.bufferData(type, data, usage) return dataLen } if(dataLen + offset > len) { throw new Error("gl-buffer: If resizing buffer, must not specify offset") } gl.bufferSubData(type, offset, data) return len } function makeScratchTypeArray(array, dtype) { var res = pool.malloc(array.length, dtype) var n = array.length for(var i=0; i=0; --i) { if(stride[i] !== n) { return false } n *= shape[i] } return true } proto.update = function(array, offset) { if(typeof offset !== "number") { offset = -1 } this.bind() if(typeof array === "object" && typeof array.shape !== "undefined") { //ndarray var dtype = array.dtype if(SUPPORTED_TYPES.indexOf(dtype) < 0) { dtype = "float32" } if(this.type === this.gl.ELEMENT_ARRAY_BUFFER) { var ext = gl.getExtension('OES_element_index_uint') if(ext && dtype !== "uint16") { dtype = "uint32" } else { dtype = "uint16" } } if(dtype === array.dtype && isPacked(array.shape, array.stride)) { if(array.offset === 0 && array.data.length === array.shape[0]) { this.length = updateTypeArray(this.gl, this.type, this.length, this.usage, array.data, offset) } else { this.length = updateTypeArray(this.gl, this.type, this.length, this.usage, array.data.subarray(array.offset, array.shape[0]), offset) } } else { var tmp = pool.malloc(array.size, dtype) var ndt = ndarray(tmp, array.shape) ops.assign(ndt, array) if(offset < 0) { this.length = updateTypeArray(this.gl, this.type, this.length, this.usage, tmp, offset) } else { this.length = updateTypeArray(this.gl, this.type, this.length, this.usage, tmp.subarray(0, array.size), offset) } pool.free(tmp) } } else if(Array.isArray(array)) { //Vanilla array var t if(this.type === this.gl.ELEMENT_ARRAY_BUFFER) { t = makeScratchTypeArray(array, "uint16") } else { t = makeScratchTypeArray(array, "float32") } if(offset < 0) { this.length = updateTypeArray(this.gl, this.type, this.length, this.usage, t, offset) } else { this.length = updateTypeArray(this.gl, this.type, this.length, this.usage, t.subarray(0, array.length), offset) } pool.free(t) } else if(typeof array === "object" && typeof array.length === "number") { //Typed array this.length = updateTypeArray(this.gl, this.type, this.length, this.usage, array, offset) } else if(typeof array === "number" || array === undefined) { //Number/default if(offset >= 0) { throw new Error("gl-buffer: Cannot specify offset when resizing buffer") } array = array | 0 if(array <= 0) { array = 1 } this.gl.bufferData(this.type, array|0, this.usage) this.length = array } else { //Error, case should not happen throw new Error("gl-buffer: Invalid data type") } } function createBuffer(gl, data, type, usage) { type = type || gl.ARRAY_BUFFER usage = usage || gl.DYNAMIC_DRAW if(type !== gl.ARRAY_BUFFER && type !== gl.ELEMENT_ARRAY_BUFFER) { throw new Error("gl-buffer: Invalid type for webgl buffer, must be either gl.ARRAY_BUFFER or gl.ELEMENT_ARRAY_BUFFER") } if(usage !== gl.DYNAMIC_DRAW && usage !== gl.STATIC_DRAW && usage !== gl.STREAM_DRAW) { throw new Error("gl-buffer: Invalid usage for buffer, must be either gl.DYNAMIC_DRAW, gl.STATIC_DRAW or gl.STREAM_DRAW") } var handle = gl.createBuffer() var result = new GLBuffer(gl, type, handle, 0, usage) result.update(data) return result } module.exports = createBuffer },{"ndarray":208,"ndarray-ops":207,"typedarray-pool":233}],76:[function(require,module,exports){ 'use strict' var createShader = require('gl-shader') var createBuffer = require('gl-buffer') var pool = require('typedarray-pool') var shaders = require('./lib/shaders') module.exports = createError2D var WEIGHTS = [ //x-error bar [ 1, 0, 0, 1, 0, 0], [ 1, 0, 0,-1, 0, 0], [-1, 0, 0,-1, 0, 0], [-1, 0, 0,-1, 0, 0], [-1, 0, 0, 1, 0, 0], [ 1, 0, 0, 1, 0, 0], //x-error right cap [ 1, 0, -1, 0, 0, 1], [ 1, 0, -1, 0, 0,-1], [ 1, 0, 1, 0, 0,-1], [ 1, 0, 1, 0, 0,-1], [ 1, 0, 1, 0, 0, 1], [ 1, 0, -1, 0, 0, 1], //x-error left cap [-1, 0, -1, 0, 0, 1], [-1, 0, -1, 0, 0,-1], [-1, 0, 1, 0, 0,-1], [-1, 0, 1, 0, 0,-1], [-1, 0, 1, 0, 0, 1], [-1, 0, -1, 0, 0, 1], //y-error bar [0, 1, 1, 0, 0, 0], [0, 1,-1, 0, 0, 0], [0,-1,-1, 0, 0, 0], [0,-1,-1, 0, 0, 0], [0, 1, 1, 0, 0, 0], [0,-1, 1, 0, 0, 0], //y-error top cap [ 0, 1, 0,-1, 1, 0], [ 0, 1, 0,-1,-1, 0], [ 0, 1, 0, 1,-1, 0], [ 0, 1, 0, 1, 1, 0], [ 0, 1, 0,-1, 1, 0], [ 0, 1, 0, 1,-1, 0], //y-error bottom cap [ 0,-1, 0,-1, 1, 0], [ 0,-1, 0,-1,-1, 0], [ 0,-1, 0, 1,-1, 0], [ 0,-1, 0, 1, 1, 0], [ 0,-1, 0,-1, 1, 0], [ 0,-1, 0, 1,-1, 0] ] function GLError2D(plot, shader, buffer) { this.plot = plot this.shader = shader this.buffer = buffer this.bounds = [Infinity, Infinity, -Infinity, -Infinity] this.numPoints = 0 this.color = [0,0,0,1] } var proto = GLError2D.prototype proto.draw = (function() { var MATRIX = [ 1, 0, 0, 0, 1, 0, 0, 0, 1 ] var PIXEL_SCALE = [1,1] return function() { var plot = this.plot var shader = this.shader var buffer = this.buffer var bounds = this.bounds var numPoints = this.numPoints var color = this.color var gl = plot.gl var dataBox = plot.dataBox var viewBox = plot.viewBox var pixelRatio = plot.pixelRatio var boundX = bounds[2] - bounds[0] var boundY = bounds[3] - bounds[1] var dataX = dataBox[2] - dataBox[0] var dataY = dataBox[3] - dataBox[1] MATRIX[0] = 2.0 * boundX / dataX MATRIX[4] = 2.0 * boundY / dataY MATRIX[6] = 2.0 * (bounds[0] - dataBox[0]) / dataX - 1.0 MATRIX[7] = 2.0 * (bounds[1] - dataBox[1]) / dataY - 1.0 var screenX = viewBox[2] - viewBox[0] var screenY = viewBox[3] - viewBox[1] PIXEL_SCALE[0] = 2.0 * pixelRatio / screenX PIXEL_SCALE[1] = 2.0 * pixelRatio / screenY buffer.bind() shader.bind() shader.uniforms.viewTransform = MATRIX shader.uniforms.pixelScale = PIXEL_SCALE shader.uniforms.color = this.color shader.attributes.position.pointer( gl.FLOAT, false, 16, 0) shader.attributes.pixelOffset.pointer( gl.FLOAT, false, 16, 8) gl.drawArrays(gl.TRIANGLES, 0, numPoints * WEIGHTS.length) } })() proto.drawPick = function(offset) { return offset } proto.pick = function(x, y) { return null } proto.update = function(options) { options = options || {} var positions = options.positions || [] var errors = options.errors || [] var lineWidth = 1 if('lineWidth' in options) { lineWidth = +options.lineWidth } var capSize = 5 if('capSize' in options) { capSize = +options.capSize } this.color = (options.color || [0,0,0,1]).slice() var bounds = this.bounds = [Infinity, Infinity, -Infinity, -Infinity] var numPoints = this.numPoints = positions.length>>1 for(var i=0; i 0) { dx *= ex1 } if(dy < 0) { dy *= ey0 } else if(dy > 0) { dy *= ey1 } bufferData[ptr++] = sx * ((x - tx) + dx) bufferData[ptr++] = sy * ((y - ty) + dy) bufferData[ptr++] = lineWidth * w[2] + (capSize + lineWidth) * w[4] bufferData[ptr++] = lineWidth * w[3] + (capSize + lineWidth) * w[5] } } this.buffer.update(bufferData) pool.free(bufferData) } proto.dispose = function() { this.plot.removeObject(this) this.shader.dispose() this.buffer.dispose() } function createError2D(plot, options) { var shader = createShader(plot.gl, shaders.vertex, shaders.fragment) var buffer = createBuffer(plot.gl) var errorbars = new GLError2D(plot, shader, buffer) errorbars.update(options) plot.addObject(errorbars) return errorbars } },{"./lib/shaders":77,"gl-buffer":75,"gl-shader":154,"typedarray-pool":233}],77:[function(require,module,exports){ module.exports = { vertex: "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec2 position;\nattribute vec2 pixelOffset;\n\nuniform mat3 viewTransform;\nuniform vec2 pixelScale;\n\nvoid main() {\n vec3 scrPosition = viewTransform * vec3(position, 1);\n gl_Position = vec4(\n scrPosition.xy + scrPosition.z * pixelScale * pixelOffset,\n 0,\n scrPosition.z);\n}\n", fragment: "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec4 color;\n\nvoid main() {\n gl_FragColor = vec4(color.rgb * color.a, color.a);\n}\n" } },{}],78:[function(require,module,exports){ 'use strict' module.exports = createErrorBars var createBuffer = require('gl-buffer') var createVAO = require('gl-vao') var createShader = require('./shaders/index') var IDENTITY = [1,0,0,0, 0,1,0,0, 0,0,1,0, 0,0,0,1] function ErrorBars(gl, buffer, vao, shader) { this.gl = gl this.shader = shader this.buffer = buffer this.vao = vao this.pixelRatio = 1 this.bounds = [[ Infinity, Infinity, Infinity], [-Infinity,-Infinity,-Infinity]] this.clipBounds = [[-Infinity,-Infinity,-Infinity], [ Infinity, Infinity, Infinity]] this.lineWidth = [1,1,1] this.capSize = [10,10,10] this.lineCount = [0,0,0] this.lineOffset = [0,0,0] this.opacity = 1 } var proto = ErrorBars.prototype proto.isOpaque = function() { return this.opacity >= 1 } proto.isTransparent = function() { return this.opacity < 1 } proto.drawTransparent = proto.draw = function(cameraParams) { var gl = this.gl var uniforms = this.shader.uniforms this.shader.bind() var view = uniforms.view = cameraParams.view || IDENTITY var projection = uniforms.projection = cameraParams.projection || IDENTITY uniforms.model = cameraParams.model || IDENTITY uniforms.clipBounds = this.clipBounds uniforms.opacity = this.opacity var cx = view[12] var cy = view[13] var cz = view[14] var cw = view[15] var pixelScaleF = this.pixelRatio * (projection[3]*cx + projection[7]*cy + projection[11]*cz + projection[15]*cw) / gl.drawingBufferHeight this.vao.bind() for(var i=0; i<3; ++i) { gl.lineWidth(this.lineWidth[i]) uniforms.capSize = this.capSize[i] * pixelScaleF gl.drawArrays(gl.LINES, this.lineOffset[i], this.lineCount[i]) } this.vao.unbind() } function updateBounds(bounds, point) { for(var i=0; i<3; ++i) { bounds[0][i] = Math.min(bounds[0][i], point[i]) bounds[1][i] = Math.max(bounds[1][i], point[i]) } } var FACE_TABLE = (function(){ var table = new Array(3) for(var d=0; d<3; ++d) { var row = [] for(var j=1; j<=2; ++j) { for(var s=-1; s<=1; s+=2) { var u = (j+d) % 3 var y = [0,0,0] y[u] = s row.push(y) } } table[d] = row } return table })() function emitFace(verts, x, c, d) { var offsets = FACE_TABLE[d] for(var i=0; i 0) { var x = p.slice() x[j] += e[1][j] verts.push(p[0], p[1], p[2], c[0], c[1], c[2], c[3], 0, 0, 0, x[0], x[1], x[2], c[0], c[1], c[2], c[3], 0, 0, 0) updateBounds(this.bounds, x) vertexCount += 2 + emitFace(verts, x, c, j) } } this.lineCount[j] = vertexCount - this.lineOffset[j] } this.buffer.update(verts) } } proto.dispose = function() { this.shader.dispose() this.buffer.dispose() this.vao.dispose() } function createErrorBars(options) { var gl = options.gl var buffer = createBuffer(gl) var vao = createVAO(gl, [ { buffer: buffer, type: gl.FLOAT, size: 3, offset: 0, stride: 40 }, { buffer: buffer, type: gl.FLOAT, size: 4, offset: 12, stride: 40 }, { buffer: buffer, type: gl.FLOAT, size: 3, offset: 28, stride: 40 } ]) var shader = createShader(gl) shader.attributes.position.location = 0 shader.attributes.color.location = 1 shader.attributes.offset.location = 2 var result = new ErrorBars(gl, buffer, vao, shader) result.update(options) return result } },{"./shaders/index":79,"gl-buffer":75,"gl-vao":189}],79:[function(require,module,exports){ 'use strict' var createShader = require('gl-shader') var vertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec3 position, offset;\nattribute vec4 color;\nuniform mat4 model, view, projection;\nuniform float capSize;\nvarying vec4 fragColor;\nvarying vec3 fragPosition;\n\nvoid main() {\n vec4 worldPosition = model * vec4(position, 1.0);\n worldPosition = (worldPosition / worldPosition.w) + vec4(capSize * offset, 0.0);\n gl_Position = projection * view * worldPosition;\n fragColor = color;\n fragPosition = position;\n}" var fragSrc = "#define GLSLIFY 1\nprecision mediump float;\nuniform vec3 clipBounds[2];\nuniform float opacity;\nvarying vec3 fragPosition;\nvarying vec4 fragColor;\n\nvoid main() {\n if(any(lessThan(fragPosition, clipBounds[0])) || any(greaterThan(fragPosition, clipBounds[1]))) {\n discard;\n }\n gl_FragColor = opacity * fragColor;\n}" module.exports = function(gl) { return createShader(gl, vertSrc, fragSrc, null, [ {name: 'position', type: 'vec3'}, {name: 'offset', type: 'vec3'}, {name: 'color', type: 'vec4'} ]) } },{"gl-shader":154}],80:[function(require,module,exports){ 'use strict' var createTexture = require('gl-texture2d') module.exports = createFBO var colorAttachmentArrays = null var FRAMEBUFFER_UNSUPPORTED var FRAMEBUFFER_INCOMPLETE_ATTACHMENT var FRAMEBUFFER_INCOMPLETE_DIMENSIONS var FRAMEBUFFER_INCOMPLETE_MISSING_ATTACHMENT function saveFBOState(gl) { var fbo = gl.getParameter(gl.FRAMEBUFFER_BINDING) var rbo = gl.getParameter(gl.RENDERBUFFER_BINDING) var tex = gl.getParameter(gl.TEXTURE_BINDING_2D) return [fbo, rbo, tex] } function restoreFBOState(gl, data) { gl.bindFramebuffer(gl.FRAMEBUFFER, data[0]) gl.bindRenderbuffer(gl.RENDERBUFFER, data[1]) gl.bindTexture(gl.TEXTURE_2D, data[2]) } function lazyInitColorAttachments(gl, ext) { var maxColorAttachments = gl.getParameter(ext.MAX_COLOR_ATTACHMENTS_WEBGL) colorAttachmentArrays = new Array(maxColorAttachments + 1) for(var i=0; i<=maxColorAttachments; ++i) { var x = new Array(maxColorAttachments) for(var j=0; j 1) { ext.drawBuffersWEBGL(colorAttachmentArrays[numColors]) } //Allocate depth/stencil buffers var WEBGL_depth_texture = gl.getExtension('WEBGL_depth_texture') if(WEBGL_depth_texture) { if(useStencil) { fbo.depth = initTexture(gl, width, height, WEBGL_depth_texture.UNSIGNED_INT_24_8_WEBGL, gl.DEPTH_STENCIL, gl.DEPTH_STENCIL_ATTACHMENT) } else if(useDepth) { fbo.depth = initTexture(gl, width, height, gl.UNSIGNED_SHORT, gl.DEPTH_COMPONENT, gl.DEPTH_ATTACHMENT) } } else { if(useDepth && useStencil) { fbo._depth_rb = initRenderBuffer(gl, width, height, gl.DEPTH_STENCIL, gl.DEPTH_STENCIL_ATTACHMENT) } else if(useDepth) { fbo._depth_rb = initRenderBuffer(gl, width, height, gl.DEPTH_COMPONENT16, gl.DEPTH_ATTACHMENT) } else if(useStencil) { fbo._depth_rb = initRenderBuffer(gl, width, height, gl.STENCIL_INDEX, gl.STENCIL_ATTACHMENT) } } //Check frame buffer state var status = gl.checkFramebufferStatus(gl.FRAMEBUFFER) if(status !== gl.FRAMEBUFFER_COMPLETE) { //Release all partially allocated resources fbo._destroyed = true //Release all resources gl.bindFramebuffer(gl.FRAMEBUFFER, null) gl.deleteFramebuffer(fbo.handle) fbo.handle = null if(fbo.depth) { fbo.depth.dispose() fbo.depth = null } if(fbo._depth_rb) { gl.deleteRenderbuffer(fbo._depth_rb) fbo._depth_rb = null } for(var i=0; i maxFBOSize || h < 0 || h > maxFBOSize) { throw new Error('gl-fbo: Can\'t resize FBO, invalid dimensions') } //Update shape fbo._shape[0] = w fbo._shape[1] = h //Save framebuffer state var state = saveFBOState(gl) //Resize framebuffer attachments for(var i=0; i maxFBOSize || height < 0 || height > maxFBOSize) { throw new Error('gl-fbo: Parameters are too large for FBO') } //Handle each option type options = options || {} //Figure out number of color buffers to use var numColors = 1 if('color' in options) { numColors = Math.max(options.color|0, 0) if(numColors < 0) { throw new Error('gl-fbo: Must specify a nonnegative number of colors') } if(numColors > 1) { //Check if multiple render targets supported if(!WEBGL_draw_buffers) { throw new Error('gl-fbo: Multiple draw buffer extension not supported') } else if(numColors > gl.getParameter(WEBGL_draw_buffers.MAX_COLOR_ATTACHMENTS_WEBGL)) { throw new Error('gl-fbo: Context does not support ' + numColors + ' draw buffers') } } } //Determine whether to use floating point textures var colorType = gl.UNSIGNED_BYTE var OES_texture_float = gl.getExtension('OES_texture_float') if(options.float && numColors > 0) { if(!OES_texture_float) { throw new Error('gl-fbo: Context does not support floating point textures') } colorType = gl.FLOAT } else if(options.preferFloat && numColors > 0) { if(OES_texture_float) { colorType = gl.FLOAT } } //Check if we should use depth buffer var useDepth = true if('depth' in options) { useDepth = !!options.depth } //Check if we should use a stencil buffer var useStencil = false if('stencil' in options) { useStencil = !!options.stencil } return new Framebuffer( gl, width, height, colorType, numColors, useDepth, useStencil, WEBGL_draw_buffers) } },{"gl-texture2d":185}],81:[function(require,module,exports){ exports.lineVertex = "#define GLSLIFY 1\nprecision mediump float;\n\nfloat inverse_1_0(float m) {\n return 1.0 / m;\n}\n\nmat2 inverse_1_0(mat2 m) {\n return mat2(m[1][1],-m[0][1],\n -m[1][0], m[0][0]) / (m[0][0]*m[1][1] - m[0][1]*m[1][0]);\n}\n\nmat3 inverse_1_0(mat3 m) {\n float a00 = m[0][0], a01 = m[0][1], a02 = m[0][2];\n float a10 = m[1][0], a11 = m[1][1], a12 = m[1][2];\n float a20 = m[2][0], a21 = m[2][1], a22 = m[2][2];\n\n float b01 = a22 * a11 - a12 * a21;\n float b11 = -a22 * a10 + a12 * a20;\n float b21 = a21 * a10 - a11 * a20;\n\n float det = a00 * b01 + a01 * b11 + a02 * b21;\n\n return mat3(b01, (-a22 * a01 + a02 * a21), (a12 * a01 - a02 * a11),\n b11, (a22 * a00 - a02 * a20), (-a12 * a00 + a02 * a10),\n b21, (-a21 * a00 + a01 * a20), (a11 * a00 - a01 * a10)) / det;\n}\n\nmat4 inverse_1_0(mat4 m) {\n float\n a00 = m[0][0], a01 = m[0][1], a02 = m[0][2], a03 = m[0][3],\n a10 = m[1][0], a11 = m[1][1], a12 = m[1][2], a13 = m[1][3],\n a20 = m[2][0], a21 = m[2][1], a22 = m[2][2], a23 = m[2][3],\n a30 = m[3][0], a31 = m[3][1], a32 = m[3][2], a33 = m[3][3],\n\n b00 = a00 * a11 - a01 * a10,\n b01 = a00 * a12 - a02 * a10,\n b02 = a00 * a13 - a03 * a10,\n b03 = a01 * a12 - a02 * a11,\n b04 = a01 * a13 - a03 * a11,\n b05 = a02 * a13 - a03 * a12,\n b06 = a20 * a31 - a21 * a30,\n b07 = a20 * a32 - a22 * a30,\n b08 = a20 * a33 - a23 * a30,\n b09 = a21 * a32 - a22 * a31,\n b10 = a21 * a33 - a23 * a31,\n b11 = a22 * a33 - a23 * a32,\n\n det = b00 * b11 - b01 * b10 + b02 * b09 + b03 * b08 - b04 * b07 + b05 * b06;\n\n return mat4(\n a11 * b11 - a12 * b10 + a13 * b09,\n a02 * b10 - a01 * b11 - a03 * b09,\n a31 * b05 - a32 * b04 + a33 * b03,\n a22 * b04 - a21 * b05 - a23 * b03,\n a12 * b08 - a10 * b11 - a13 * b07,\n a00 * b11 - a02 * b08 + a03 * b07,\n a32 * b02 - a30 * b05 - a33 * b01,\n a20 * b05 - a22 * b02 + a23 * b01,\n a10 * b10 - a11 * b08 + a13 * b06,\n a01 * b08 - a00 * b10 - a03 * b06,\n a30 * b04 - a31 * b02 + a33 * b00,\n a21 * b02 - a20 * b04 - a23 * b00,\n a11 * b07 - a10 * b09 - a12 * b06,\n a00 * b09 - a01 * b07 + a02 * b06,\n a31 * b01 - a30 * b03 - a32 * b00,\n a20 * b03 - a21 * b01 + a22 * b00) / det;\n}\n\n\n\nattribute vec2 a, d;\n\nuniform mat3 matrix;\nuniform vec2 screenShape;\nuniform float width;\n\nvarying vec2 direction;\n\nvoid main() {\n vec2 dir = (matrix * vec3(d, 0)).xy;\n vec3 base = matrix * vec3(a, 1);\n vec2 n = 0.5 * width *\n normalize(screenShape.yx * vec2(dir.y, -dir.x)) / screenShape.xy;\n vec2 tangent = normalize(screenShape.xy * dir);\n if(dir.x < 0.0 || (dir.x == 0.0 && dir.y < 0.0)) {\n direction = -tangent;\n } else {\n direction = tangent;\n }\n gl_Position = vec4(base.xy/base.z + n, 0, 1);\n}\n" exports.lineFragment = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec4 color;\nuniform vec2 screenShape;\nuniform sampler2D dashPattern;\nuniform float dashLength;\n\nvarying vec2 direction;\n\nvoid main() {\n float t = fract(dot(direction, gl_FragCoord.xy) / dashLength);\n vec4 pcolor = color * texture2D(dashPattern, vec2(t, 0.0)).r;\n gl_FragColor = vec4(pcolor.rgb * pcolor.a, pcolor.a);\n}\n" exports.mitreVertex = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec2 p;\n\nuniform mat3 matrix;\nuniform vec2 screenShape;\nuniform float radius;\n\nvoid main() {\n vec3 pp = matrix * vec3(p, 1);\n gl_Position = vec4(pp.xy, 0, pp.z);\n gl_PointSize = radius;\n}\n" exports.mitreFragment = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec4 color;\n\nvoid main() {\n if(length(gl_PointCoord.xy - 0.5) > 0.25) {\n discard;\n }\n gl_FragColor = vec4(color.rgb, color.a);\n}\n" exports.pickVertex = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec2 a, d;\nattribute vec4 pick0, pick1;\n\nuniform mat3 matrix;\nuniform vec2 screenShape;\nuniform float width;\n\nvarying vec4 pickA, pickB;\n\nfloat inverse_1_0(float m) {\n return 1.0 / m;\n}\n\nmat2 inverse_1_0(mat2 m) {\n return mat2(m[1][1],-m[0][1],\n -m[1][0], m[0][0]) / (m[0][0]*m[1][1] - m[0][1]*m[1][0]);\n}\n\nmat3 inverse_1_0(mat3 m) {\n float a00 = m[0][0], a01 = m[0][1], a02 = m[0][2];\n float a10 = m[1][0], a11 = m[1][1], a12 = m[1][2];\n float a20 = m[2][0], a21 = m[2][1], a22 = m[2][2];\n\n float b01 = a22 * a11 - a12 * a21;\n float b11 = -a22 * a10 + a12 * a20;\n float b21 = a21 * a10 - a11 * a20;\n\n float det = a00 * b01 + a01 * b11 + a02 * b21;\n\n return mat3(b01, (-a22 * a01 + a02 * a21), (a12 * a01 - a02 * a11),\n b11, (a22 * a00 - a02 * a20), (-a12 * a00 + a02 * a10),\n b21, (-a21 * a00 + a01 * a20), (a11 * a00 - a01 * a10)) / det;\n}\n\nmat4 inverse_1_0(mat4 m) {\n float\n a00 = m[0][0], a01 = m[0][1], a02 = m[0][2], a03 = m[0][3],\n a10 = m[1][0], a11 = m[1][1], a12 = m[1][2], a13 = m[1][3],\n a20 = m[2][0], a21 = m[2][1], a22 = m[2][2], a23 = m[2][3],\n a30 = m[3][0], a31 = m[3][1], a32 = m[3][2], a33 = m[3][3],\n\n b00 = a00 * a11 - a01 * a10,\n b01 = a00 * a12 - a02 * a10,\n b02 = a00 * a13 - a03 * a10,\n b03 = a01 * a12 - a02 * a11,\n b04 = a01 * a13 - a03 * a11,\n b05 = a02 * a13 - a03 * a12,\n b06 = a20 * a31 - a21 * a30,\n b07 = a20 * a32 - a22 * a30,\n b08 = a20 * a33 - a23 * a30,\n b09 = a21 * a32 - a22 * a31,\n b10 = a21 * a33 - a23 * a31,\n b11 = a22 * a33 - a23 * a32,\n\n det = b00 * b11 - b01 * b10 + b02 * b09 + b03 * b08 - b04 * b07 + b05 * b06;\n\n return mat4(\n a11 * b11 - a12 * b10 + a13 * b09,\n a02 * b10 - a01 * b11 - a03 * b09,\n a31 * b05 - a32 * b04 + a33 * b03,\n a22 * b04 - a21 * b05 - a23 * b03,\n a12 * b08 - a10 * b11 - a13 * b07,\n a00 * b11 - a02 * b08 + a03 * b07,\n a32 * b02 - a30 * b05 - a33 * b01,\n a20 * b05 - a22 * b02 + a23 * b01,\n a10 * b10 - a11 * b08 + a13 * b06,\n a01 * b08 - a00 * b10 - a03 * b06,\n a30 * b04 - a31 * b02 + a33 * b00,\n a21 * b02 - a20 * b04 - a23 * b00,\n a11 * b07 - a10 * b09 - a12 * b06,\n a00 * b09 - a01 * b07 + a02 * b06,\n a31 * b01 - a30 * b03 - a32 * b00,\n a20 * b03 - a21 * b01 + a22 * b00) / det;\n}\n\n\n\nvoid main() {\n vec3 base = matrix * vec3(a, 1);\n vec2 n = width *\n normalize(screenShape.yx * vec2(d.y, -d.x)) / screenShape.xy;\n gl_Position = vec4(base.xy/base.z + n, 0, 1);\n pickA = pick0;\n pickB = pick1;\n}\n" exports.pickFragment = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec4 pickOffset;\n\nvarying vec4 pickA, pickB;\n\nvoid main() {\n vec4 fragId = vec4(pickA.xyz, 0.0);\n if(pickB.w > pickA.w) {\n fragId.xyz = pickB.xyz;\n }\n\n fragId += pickOffset;\n\n fragId.y += floor(fragId.x / 256.0);\n fragId.x -= floor(fragId.x / 256.0) * 256.0;\n\n fragId.z += floor(fragId.y / 256.0);\n fragId.y -= floor(fragId.y / 256.0) * 256.0;\n\n fragId.w += floor(fragId.z / 256.0);\n fragId.z -= floor(fragId.z / 256.0) * 256.0;\n\n gl_FragColor = fragId / 255.0;\n}\n" exports.fillVertex = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec2 a, d;\n\nuniform mat3 matrix;\nuniform vec2 projectAxis;\nuniform float projectValue;\nuniform float depth;\n\nvoid main() {\n vec3 base = matrix * vec3(a, 1);\n vec2 p = base.xy / base.z;\n if(d.y < 0.0 || (d.y == 0.0 && d.x < 0.0)) {\n if(dot(p, projectAxis) < projectValue) {\n p = p * (1.0 - abs(projectAxis)) + projectAxis * projectValue;\n }\n }\n gl_Position = vec4(p, depth, 1);\n}\n" exports.fillFragment = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec4 color;\n\nvoid main() {\n gl_FragColor = vec4(color.rgb * color.a, color.a);\n}\n" },{}],82:[function(require,module,exports){ 'use strict' module.exports = createLinePlot var createShader = require('gl-shader') var createBuffer = require('gl-buffer') var createTexture = require('gl-texture2d') var ndarray = require('ndarray') var pool = require('typedarray-pool') var SHADERS = require('./lib/shaders') function GLLine2D( plot, dashPattern, lineBuffer, pickBuffer, lineShader, mitreShader, fillShader, pickShader) { this.plot = plot this.dashPattern = dashPattern this.lineBuffer = lineBuffer this.pickBuffer = pickBuffer this.lineShader = lineShader this.mitreShader = mitreShader this.fillShader = fillShader this.pickShader = pickShader this.usingDashes = false this.bounds = [Infinity, Infinity, -Infinity, -Infinity] this.width = 1 this.color = [0,0,1,1] //Fill to axes this.fill = [false, false, false, false] this.fillColor = [[0,0,0,1], [0,0,0,1], [0,0,0,1], [0,0,0,1]] this.data = null this.numPoints = 0 this.vertCount = 0 this.pickOffset = 0 this.lodBuffer = [] } var proto = GLLine2D.prototype proto.draw = (function() { var MATRIX = [1, 0, 0, 0, 1, 0, 0, 0, 1] var SCREEN_SHAPE = [0,0] var PX_AXIS = [1,0] var NX_AXIS = [-1,0] var PY_AXIS = [0,1] var NY_AXIS = [0,-1] return function() { var plot = this.plot var color = this.color var width = this.width var numPoints = this.numPoints var bounds = this.bounds var count = this.vertCount var gl = plot.gl var viewBox = plot.viewBox var dataBox = plot.dataBox var pixelRatio = plot.pixelRatio var boundX = bounds[2] - bounds[0] var boundY = bounds[3] - bounds[1] var dataX = dataBox[2] - dataBox[0] var dataY = dataBox[3] - dataBox[1] var screenX = viewBox[2] - viewBox[0] var screenY = viewBox[3] - viewBox[1] MATRIX[0] = 2.0 * boundX / dataX MATRIX[4] = 2.0 * boundY / dataY MATRIX[6] = 2.0 * (bounds[0] - dataBox[0]) / dataX - 1.0 MATRIX[7] = 2.0 * (bounds[1] - dataBox[1]) / dataY - 1.0 SCREEN_SHAPE[0] = screenX SCREEN_SHAPE[1] = screenY var buffer = this.lineBuffer buffer.bind() var fill = this.fill if(fill[0] || fill[1] || fill[2] || fill[3]) { var fillShader = this.fillShader fillShader.bind() var fillUniforms = fillShader.uniforms fillUniforms.matrix = MATRIX fillUniforms.depth = plot.nextDepthValue() var fillAttributes = fillShader.attributes fillAttributes.a.pointer(gl.FLOAT, false, 16, 0) fillAttributes.d.pointer(gl.FLOAT, false, 16, 8) gl.depthMask(true) gl.enable(gl.DEPTH_TEST) var fillColor = this.fillColor if(fill[0]) { fillUniforms.color = fillColor[0] fillUniforms.projectAxis = NX_AXIS fillUniforms.projectValue = 1 gl.drawArrays(gl.TRIANGLES, 0, count) } if(fill[1]) { fillUniforms.color = fillColor[1] fillUniforms.projectAxis = NY_AXIS fillUniforms.projectValue = 1 gl.drawArrays(gl.TRIANGLES, 0, count) } if(fill[2]) { fillUniforms.color = fillColor[2] fillUniforms.projectAxis = PX_AXIS fillUniforms.projectValue = 1 gl.drawArrays(gl.TRIANGLES, 0, count) } if(fill[3]) { fillUniforms.color = fillColor[3] fillUniforms.projectAxis = PY_AXIS fillUniforms.projectValue = 1 gl.drawArrays(gl.TRIANGLES, 0, count) } gl.depthMask(false) gl.disable(gl.DEPTH_TEST) } var shader = this.lineShader shader.bind() var uniforms = shader.uniforms uniforms.matrix = MATRIX uniforms.color = color uniforms.width = width * pixelRatio uniforms.screenShape = SCREEN_SHAPE uniforms.dashPattern = this.dashPattern.bind() uniforms.dashLength = this.dashLength * pixelRatio var attributes = shader.attributes attributes.a.pointer(gl.FLOAT, false, 16, 0) attributes.d.pointer(gl.FLOAT, false, 16, 8) gl.drawArrays(gl.TRIANGLES, 0, count) //Draw mitres if(width > 2 && !this.usingDashes) { var mshader = this.mitreShader mshader.bind() var muniforms = mshader.uniforms muniforms.matrix = MATRIX muniforms.color = color muniforms.screenShape = SCREEN_SHAPE muniforms.radius = width * pixelRatio mshader.attributes.p.pointer(gl.FLOAT, false, 48, 0) gl.drawArrays(gl.POINTS, 0, (count/3)|0) } } })() proto.drawPick = (function() { var MATRIX = [1, 0, 0, 0, 1, 0, 0, 0, 1] var SCREEN_SHAPE = [0,0] var PICK_OFFSET = [0,0,0,0] return function(pickOffset) { var plot = this.plot var shader = this.pickShader var buffer = this.lineBuffer var pickBuffer= this.pickBuffer var width = this.width var numPoints = this.numPoints var bounds = this.bounds var count = this.vertCount var gl = plot.gl var viewBox = plot.viewBox var dataBox = plot.dataBox var pixelRatio = plot.pickPixelRatio var boundX = bounds[2] - bounds[0] var boundY = bounds[3] - bounds[1] var dataX = dataBox[2] - dataBox[0] var dataY = dataBox[3] - dataBox[1] var screenX = viewBox[2] - viewBox[0] var screenY = viewBox[3] - viewBox[1] this.pickOffset = pickOffset MATRIX[0] = 2.0 * boundX / dataX MATRIX[4] = 2.0 * boundY / dataY MATRIX[6] = 2.0 * (bounds[0] - dataBox[0]) / dataX - 1.0 MATRIX[7] = 2.0 * (bounds[1] - dataBox[1]) / dataY - 1.0 SCREEN_SHAPE[0] = screenX SCREEN_SHAPE[1] = screenY PICK_OFFSET[0] = pickOffset & 0xff PICK_OFFSET[1] = (pickOffset>>>8) & 0xff PICK_OFFSET[2] = (pickOffset>>>16) & 0xff PICK_OFFSET[3] = pickOffset>>>24 shader.bind() var uniforms = shader.uniforms uniforms.matrix = MATRIX uniforms.width = width * pixelRatio uniforms.pickOffset = PICK_OFFSET uniforms.screenShape = SCREEN_SHAPE var attributes = shader.attributes buffer.bind() attributes.a.pointer(gl.FLOAT, false, 16, 0) attributes.d.pointer(gl.FLOAT, false, 16, 8) pickBuffer.bind() attributes.pick0.pointer(gl.UNSIGNED_BYTE, false, 8, 0) attributes.pick1.pointer(gl.UNSIGNED_BYTE, false, 8, 4) gl.drawArrays(gl.TRIANGLES, 0, count) return pickOffset + numPoints } })() proto.pick = function(x, y, value) { var pickOffset = this.pickOffset var pointCount = this.numPoints if(value < pickOffset || value >= pickOffset + pointCount) { return null } var pointId = value - pickOffset var points = this.data return { object: this, pointId: pointId, dataCoord: [ points[2*pointId], points[2*pointId+1] ] } } function deepCopy(arr) { return arr.map(function(x) { return x.slice() }) } proto.update = function(options) { options = options || {} var gl = this.plot.gl this.color = (options.color || [0,0,1,1]).slice() this.width = +(options.width || 1) this.fill = (options.fill || [false,false,false,false]).slice() this.fillColor = deepCopy(options.fillColor || [[0,0,0,1], [0,0,0,1], [0,0,0,1], [0,0,0,1]]) var dashes = options.dashes || [1] var dashLength = 0 for(var i=0; i 1 this.dashPattern = createTexture(gl, ndarray(dashData, [dashLength, 1, 4], [1, 0, 0])) this.dashPattern.minFilter = gl.NEAREST this.dashPattern.magFilter = gl.NEAREST this.dashLength = dashLength pool.free(dashData) var data = options.positions this.data = data var bounds = this.bounds bounds[0] = bounds[1] = Infinity bounds[2] = bounds[3] = -Infinity var numPoints = this.numPoints = data.length>>>1 if(numPoints === 0) { return } for(var i=0; i 1) { var id = --ptr var ax = data[2*ptr] var ay = data[2*ptr+1] ax = (ax - bounds[0]) / (bounds[2] - bounds[0]) ay = (ay - bounds[1]) / (bounds[3] - bounds[1]) var next = id-1 var bx = data[2*next] var by = data[2*next+1] bx = (bx - bounds[0]) / (bounds[2] - bounds[0]) by = (by - bounds[1]) / (bounds[3] - bounds[1]) var dx = bx - ax var dy = by - ay var akey0 = id | (1<<24) var akey1 = (id-1) var bkey0 = id var bkey1 = (id-1) | (1<<24) lineData[--lineDataPtr] = -dy lineData[--lineDataPtr] = -dx lineData[--lineDataPtr] = ay lineData[--lineDataPtr] = ax pickData[--pickDataPtr] = akey0 pickData[--pickDataPtr] = akey1 lineData[--lineDataPtr] = dy lineData[--lineDataPtr] = dx lineData[--lineDataPtr] = by lineData[--lineDataPtr] = bx pickData[--pickDataPtr] = bkey0 pickData[--pickDataPtr] = bkey1 lineData[--lineDataPtr] = -dy lineData[--lineDataPtr] = -dx lineData[--lineDataPtr] = by lineData[--lineDataPtr] = bx pickData[--pickDataPtr] = bkey0 pickData[--pickDataPtr] = bkey1 lineData[--lineDataPtr] = dy lineData[--lineDataPtr] = dx lineData[--lineDataPtr] = by lineData[--lineDataPtr] = bx pickData[--pickDataPtr] = bkey0 pickData[--pickDataPtr] = bkey1 lineData[--lineDataPtr] = -dy lineData[--lineDataPtr] = -dx lineData[--lineDataPtr] = ay lineData[--lineDataPtr] = ax pickData[--pickDataPtr] = akey0 pickData[--pickDataPtr] = akey1 lineData[--lineDataPtr] = dy lineData[--lineDataPtr] = dx lineData[--lineDataPtr] = ay lineData[--lineDataPtr] = ax pickData[--pickDataPtr] = akey0 pickData[--pickDataPtr] = akey1 } this.lineBuffer.update(lineData) this.pickBuffer.update(pickData) pool.free(lineData) pool.free(pickData) } proto.dispose = function() { this.plot.removeObject(this) this.lineBuffer.dispose() this.pickBuffer.dispose() this.lineShader.dispose() this.mitreShader.dispose() this.fillShader.dispose() this.pickShader.dispose() this.dashPattern.dispose() } function createLinePlot(plot, options) { var gl = plot.gl var lineBuffer = createBuffer(gl) var pickBuffer = createBuffer(gl) var dashPattern = createTexture(gl, [1,1]) var lineShader = createShader(gl, SHADERS.lineVertex, SHADERS.lineFragment) var mitreShader = createShader(gl, SHADERS.mitreVertex, SHADERS.mitreFragment) var fillShader = createShader(gl, SHADERS.fillVertex, SHADERS.fillFragment) var pickShader = createShader(gl, SHADERS.pickVertex, SHADERS.pickFragment) var linePlot = new GLLine2D( plot, dashPattern, lineBuffer, pickBuffer, lineShader, mitreShader, fillShader, pickShader) plot.addObject(linePlot) linePlot.update(options) return linePlot } },{"./lib/shaders":81,"gl-buffer":75,"gl-shader":154,"gl-texture2d":185,"ndarray":208,"typedarray-pool":233}],83:[function(require,module,exports){ var createShader = require('gl-shader') var vertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec3 position, nextPosition;\nattribute float arcLength, lineWidth;\nattribute vec4 color;\n\nuniform vec2 screenShape;\nuniform float pixelRatio;\nuniform mat4 model, view, projection;\n\nvarying vec4 fragColor;\nvarying vec3 worldPosition;\nvarying float pixelArcLength;\n\nvoid main() {\n vec4 projected = projection * view * model * vec4(position, 1.0);\n vec4 tangentClip = projection * view * model * vec4(nextPosition - position, 0.0);\n vec2 tangent = normalize(screenShape * tangentClip.xy);\n vec2 offset = 0.5 * pixelRatio * lineWidth * vec2(tangent.y, -tangent.x) / screenShape;\n\n gl_Position = vec4(projected.xy + projected.w * offset, projected.zw);\n\n worldPosition = position;\n pixelArcLength = arcLength;\n fragColor = color;\n}\n" var forwardFrag = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec3 clipBounds[2];\nuniform sampler2D dashTexture;\nuniform float dashScale;\nuniform float opacity;\n\nvarying vec3 worldPosition;\nvarying float pixelArcLength;\nvarying vec4 fragColor;\n\nvoid main() {\n if(any(lessThan(worldPosition, clipBounds[0])) || any(greaterThan(worldPosition, clipBounds[1]))) {\n discard;\n }\n float dashWeight = texture2D(dashTexture, vec2(dashScale * pixelArcLength, 0)).r;\n if(dashWeight < 0.5) {\n discard;\n }\n gl_FragColor = fragColor * opacity;\n}\n" var pickFrag = "#define GLSLIFY 1\nprecision mediump float;\n\n#define FLOAT_MAX 1.70141184e38\n#define FLOAT_MIN 1.17549435e-38\n\nlowp vec4 encode_float_1_0(highp float v) {\n highp float av = abs(v);\n\n //Handle special cases\n if(av < FLOAT_MIN) {\n return vec4(0.0, 0.0, 0.0, 0.0);\n } else if(v > FLOAT_MAX) {\n return vec4(127.0, 128.0, 0.0, 0.0) / 255.0;\n } else if(v < -FLOAT_MAX) {\n return vec4(255.0, 128.0, 0.0, 0.0) / 255.0;\n }\n\n highp vec4 c = vec4(0,0,0,0);\n\n //Compute exponent and mantissa\n highp float e = floor(log2(av));\n highp float m = av * pow(2.0, -e) - 1.0;\n \n //Unpack mantissa\n c[1] = floor(128.0 * m);\n m -= c[1] / 128.0;\n c[2] = floor(32768.0 * m);\n m -= c[2] / 32768.0;\n c[3] = floor(8388608.0 * m);\n \n //Unpack exponent\n highp float ebias = e + 127.0;\n c[0] = floor(ebias / 2.0);\n ebias -= c[0] * 2.0;\n c[1] += floor(ebias) * 128.0; \n\n //Unpack sign bit\n c[0] += 128.0 * step(0.0, -v);\n\n //Scale back to range\n return c / 255.0;\n}\n\n\n\nuniform float pickId;\nuniform vec3 clipBounds[2];\n\nvarying vec3 worldPosition;\nvarying float pixelArcLength;\nvarying vec4 fragColor;\n\nvoid main() {\n if(any(lessThan(worldPosition, clipBounds[0])) || any(greaterThan(worldPosition, clipBounds[1]))) {\n discard;\n }\n gl_FragColor = vec4(pickId/255.0, encode_float_1_0(pixelArcLength).xyz);\n}" var ATTRIBUTES = [ {name: 'position', type: 'vec3'}, {name: 'nextPosition', type: 'vec3'}, {name: 'arcLength', type: 'float'}, {name: 'lineWidth', type: 'float'}, {name: 'color', type: 'vec4'} ] exports.createShader = function(gl) { return createShader(gl, vertSrc, forwardFrag, null, ATTRIBUTES) } exports.createPickShader = function(gl) { return createShader(gl, vertSrc, pickFrag, null, ATTRIBUTES) } },{"gl-shader":154}],84:[function(require,module,exports){ 'use strict' module.exports = createLinePlot var createBuffer = require('gl-buffer') var createVAO = require('gl-vao') var createTexture = require('gl-texture2d') var unpackFloat = require('glsl-read-float') var bsearch = require('binary-search-bounds') var ndarray = require('ndarray') var shaders = require('./lib/shaders') var createShader = shaders.createShader var createPickShader = shaders.createPickShader var identity = [1,0,0,0, 0,1,0,0, 0,0,1,0, 0,0,0,1] function distance(a, b) { var s = 0.0 for(var i=0; i<3; ++i) { var d = a[i] - b[i] s += d*d } return Math.sqrt(s) } function filterClipBounds(bounds) { var result = [[-1e6,-1e6,-1e6], [1e6,1e6,1e6]] for(var i=0; i<3; ++i) { result[0][i] = Math.max(bounds[0][i], result[0][i]) result[1][i] = Math.min(bounds[1][i], result[1][i]) } return result } function PickResult(tau, position, index, dataCoordinate) { this.arcLength = tau this.position = position this.index = index this.dataCoordinate = dataCoordinate } function LinePlot(gl, shader, pickShader, buffer, vao, texture) { this.gl = gl this.shader = shader this.pickShader = pickShader this.buffer = buffer this.vao = vao this.clipBounds = [[-Infinity,-Infinity,-Infinity], [ Infinity, Infinity, Infinity]] this.points = [] this.arcLength = [] this.vertexCount = 0 this.bounds = [[0,0,0],[0,0,0]] this.pickId = 0 this.lineWidth = 1 this.texture = texture this.dashScale = 1 this.opacity = 1 this.dirty = true this.pixelRatio = 1 } var proto = LinePlot.prototype proto.isTransparent = function() { return this.opacity < 1 } proto.isOpaque = function() { return this.opacity >= 1 } proto.pickSlots = 1 proto.setPickBase = function(id) { this.pickId = id } proto.drawTransparent = proto.draw = function(camera) { var gl = this.gl var shader = this.shader var vao = this.vao shader.bind() shader.uniforms = { model: camera.model || identity, view: camera.view || identity, projection: camera.projection || identity, clipBounds: filterClipBounds(this.clipBounds), dashTexture: this.texture.bind(), dashScale: this.dashScale / this.arcLength[this.arcLength.length-1], opacity: this.opacity, screenShape: [gl.drawingBufferWidth, gl.drawingBufferHeight], pixelRatio: this.pixelRatio } vao.bind() vao.draw(gl.TRIANGLE_STRIP, this.vertexCount) } proto.drawPick = function(camera) { var gl = this.gl var shader = this.pickShader var vao = this.vao shader.bind() shader.uniforms = { model: camera.model || identity, view: camera.view || identity, projection: camera.projection || identity, pickId: this.pickId, clipBounds: filterClipBounds(this.clipBounds), screenShape: [gl.drawingBufferWidth, gl.drawingBufferHeight], pixelRatio: this.pixelRatio } vao.bind() vao.draw(gl.TRIANGLE_STRIP, this.vertexCount) } proto.update = function(options) { this.dirty = true if('dashScale' in options) { this.dashScale = options.dashScale } if('opacity' in options) { this.opacity = +options.opacity } var positions = options.position || options.positions if(!positions) { return } //Default color var colors = options.color || options.colors || [0,0,0,1] var lineWidth = options.lineWidth || 1 //Recalculate buffer data var buffer = [] var arcLengthArray = [] var pointArray = [] var arcLength = 0.0 var vertexCount = 0 var bounds = [[ Infinity, Infinity, Infinity], [-Infinity,-Infinity,-Infinity]] fill_loop: for(var i=1; i 1.0001) { return null } s += weights[i] } if(Math.abs(s - 1.0) > 0.001) { return null } return [closestIndex, interpolate(simplex, weights), weights] } },{"barycentric":108,"polytope-closest-point/lib/closest_point_2d.js":110}],106:[function(require,module,exports){ var triVertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec3 position, normal;\nattribute vec4 color;\nattribute vec2 uv;\n\nuniform mat4 model\n , view\n , projection;\nuniform vec3 eyePosition\n , lightPosition;\n\nvarying vec3 f_normal\n , f_lightDirection\n , f_eyeDirection\n , f_data;\nvarying vec4 f_color;\nvarying vec2 f_uv;\n\nvoid main() {\n vec4 m_position = model * vec4(position, 1.0);\n vec4 t_position = view * m_position;\n gl_Position = projection * t_position;\n f_color = color;\n f_normal = normal;\n f_data = position;\n f_eyeDirection = eyePosition - position;\n f_lightDirection = lightPosition - position;\n f_uv = uv;\n}" var triFragSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nfloat beckmannDistribution_2_0(float x, float roughness) {\n float NdotH = max(x, 0.0001);\n float cos2Alpha = NdotH * NdotH;\n float tan2Alpha = (cos2Alpha - 1.0) / cos2Alpha;\n float roughness2 = roughness * roughness;\n float denom = 3.141592653589793 * roughness2 * cos2Alpha * cos2Alpha;\n return exp(tan2Alpha / roughness2) / denom;\n}\n\n\n\nfloat cookTorranceSpecular_1_1(\n vec3 lightDirection,\n vec3 viewDirection,\n vec3 surfaceNormal,\n float roughness,\n float fresnel) {\n\n float VdotN = max(dot(viewDirection, surfaceNormal), 0.0);\n float LdotN = max(dot(lightDirection, surfaceNormal), 0.0);\n\n //Half angle vector\n vec3 H = normalize(lightDirection + viewDirection);\n\n //Geometric term\n float NdotH = max(dot(surfaceNormal, H), 0.0);\n float VdotH = max(dot(viewDirection, H), 0.000001);\n float LdotH = max(dot(lightDirection, H), 0.000001);\n float G1 = (2.0 * NdotH * VdotN) / VdotH;\n float G2 = (2.0 * NdotH * LdotN) / LdotH;\n float G = min(1.0, min(G1, G2));\n \n //Distribution term\n float D = beckmannDistribution_2_0(NdotH, roughness);\n\n //Fresnel term\n float F = pow(1.0 - VdotN, fresnel);\n\n //Multiply terms and done\n return G * F * D / max(3.14159265 * VdotN, 0.000001);\n}\n\n\n\nuniform vec3 clipBounds[2];\nuniform float roughness\n , fresnel\n , kambient\n , kdiffuse\n , kspecular\n , opacity;\nuniform sampler2D texture;\n\nvarying vec3 f_normal\n , f_lightDirection\n , f_eyeDirection\n , f_data;\nvarying vec4 f_color;\nvarying vec2 f_uv;\n\nvoid main() {\n if(any(lessThan(f_data, clipBounds[0])) || \n any(greaterThan(f_data, clipBounds[1]))) {\n discard;\n }\n\n vec3 N = normalize(f_normal);\n vec3 L = normalize(f_lightDirection);\n vec3 V = normalize(f_eyeDirection);\n \n if(!gl_FrontFacing) {\n N = -N;\n }\n\n float specular = cookTorranceSpecular_1_1(L, V, N, roughness, fresnel);\n float diffuse = min(kambient + kdiffuse * max(dot(N, L), 0.0), 1.0);\n\n vec4 surfaceColor = f_color * texture2D(texture, f_uv);\n vec4 litColor = surfaceColor.a * vec4(diffuse * surfaceColor.rgb + kspecular * vec3(1,1,1) * specular, 1.0);\n\n gl_FragColor = litColor * opacity;\n}" var edgeVertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec3 position;\nattribute vec4 color;\nattribute vec2 uv;\n\nuniform mat4 model, view, projection;\n\nvarying vec4 f_color;\nvarying vec3 f_data;\nvarying vec2 f_uv;\n\nvoid main() {\n gl_Position = projection * view * model * vec4(position, 1.0);\n f_color = color;\n f_data = position;\n f_uv = uv;\n}" var edgeFragSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec3 clipBounds[2];\nuniform sampler2D texture;\nuniform float opacity;\n\nvarying vec4 f_color;\nvarying vec3 f_data;\nvarying vec2 f_uv;\n\nvoid main() {\n if(any(lessThan(f_data, clipBounds[0])) || \n any(greaterThan(f_data, clipBounds[1]))) {\n discard;\n }\n\n gl_FragColor = f_color * texture2D(texture, f_uv) * opacity;\n}" var pointVertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec3 position;\nattribute vec4 color;\nattribute vec2 uv;\nattribute float pointSize;\n\nuniform mat4 model, view, projection;\nuniform vec3 clipBounds[2];\n\nvarying vec4 f_color;\nvarying vec2 f_uv;\n\nvoid main() {\n if(any(lessThan(position, clipBounds[0])) || \n any(greaterThan(position, clipBounds[1]))) {\n gl_Position = vec4(0,0,0,0);\n } else {\n gl_Position = projection * view * model * vec4(position, 1.0);\n }\n gl_PointSize = pointSize;\n f_color = color;\n f_uv = uv;\n}" var pointFragSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform sampler2D texture;\nuniform float opacity;\n\nvarying vec4 f_color;\nvarying vec2 f_uv;\n\nvoid main() {\n vec2 pointR = gl_PointCoord.xy - vec2(0.5,0.5);\n if(dot(pointR, pointR) > 0.25) {\n discard;\n }\n gl_FragColor = f_color * texture2D(texture, f_uv) * opacity;\n}" var pickVertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec3 position;\nattribute vec4 id;\n\nuniform mat4 model, view, projection;\n\nvarying vec3 f_position;\nvarying vec4 f_id;\n\nvoid main() {\n gl_Position = projection * view * model * vec4(position, 1.0);\n f_id = id;\n f_position = position;\n}" var pickFragSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec3 clipBounds[2];\nuniform float pickId;\n\nvarying vec3 f_position;\nvarying vec4 f_id;\n\nvoid main() {\n if(any(lessThan(f_position, clipBounds[0])) || \n any(greaterThan(f_position, clipBounds[1]))) {\n discard;\n }\n gl_FragColor = vec4(pickId, f_id.xyz);\n}" var pickPointVertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec3 position;\nattribute float pointSize;\nattribute vec4 id;\n\nuniform mat4 model, view, projection;\nuniform vec3 clipBounds[2];\n\nvarying vec3 f_position;\nvarying vec4 f_id;\n\nvoid main() {\n if(any(lessThan(position, clipBounds[0])) || \n any(greaterThan(position, clipBounds[1]))) {\n gl_Position = vec4(0,0,0,0);\n } else {\n gl_Position = projection * view * model * vec4(position, 1.0);\n gl_PointSize = pointSize;\n }\n f_id = id;\n f_position = position;\n}" var contourVertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec3 position;\n\nuniform mat4 model, view, projection;\n\nvoid main() {\n gl_Position = projection * view * model * vec4(position, 1.0);\n}" var contourFragSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec3 contourColor;\n\nvoid main() {\n gl_FragColor = vec4(contourColor,1);\n}\n" exports.meshShader = { vertex: triVertSrc, fragment: triFragSrc, attributes: [ {name: 'position', type: 'vec3'}, {name: 'normal', type: 'vec3'}, {name: 'color', type: 'vec4'}, {name: 'uv', type: 'vec2'} ] } exports.wireShader = { vertex: edgeVertSrc, fragment: edgeFragSrc, attributes: [ {name: 'position', type: 'vec3'}, {name: 'color', type: 'vec4'}, {name: 'uv', type: 'vec2'} ] } exports.pointShader = { vertex: pointVertSrc, fragment: pointFragSrc, attributes: [ {name: 'position', type: 'vec3'}, {name: 'color', type: 'vec4'}, {name: 'uv', type: 'vec2'}, {name: 'pointSize', type: 'float'} ] } exports.pickShader = { vertex: pickVertSrc, fragment: pickFragSrc, attributes: [ {name: 'position', type: 'vec3'}, {name: 'id', type: 'vec4'} ] } exports.pointPickShader = { vertex: pickPointVertSrc, fragment: pickFragSrc, attributes: [ {name: 'position', type: 'vec3'}, {name: 'pointSize', type: 'float'}, {name: 'id', type: 'vec4'} ] } exports.contourShader = { vertex: contourVertSrc, fragment: contourFragSrc, attributes: [ {name: 'position', type: 'vec3'} ] } },{}],107:[function(require,module,exports){ 'use strict' var createShader = require('gl-shader') var createBuffer = require('gl-buffer') var createVAO = require('gl-vao') var createTexture = require('gl-texture2d') var normals = require('normals') var multiply = require('gl-mat4/multiply') var invert = require('gl-mat4/invert') var ndarray = require('ndarray') var colormap = require('colormap') var getContour = require('simplicial-complex-contour') var pool = require('typedarray-pool') var shaders = require('./lib/shaders') var closestPoint = require('./lib/closest-point') var meshShader = shaders.meshShader var wireShader = shaders.wireShader var pointShader = shaders.pointShader var pickShader = shaders.pickShader var pointPickShader = shaders.pointPickShader var contourShader = shaders.contourShader var identityMatrix = [ 1,0,0,0, 0,1,0,0, 0,0,1,0, 0,0,0,1] function SimplicialMesh(gl , texture , triShader , lineShader , pointShader , pickShader , pointPickShader , contourShader , trianglePositions , triangleIds , triangleColors , triangleUVs , triangleNormals , triangleVAO , edgePositions , edgeIds , edgeColors , edgeUVs , edgeVAO , pointPositions , pointIds , pointColors , pointUVs , pointSizes , pointVAO , contourPositions , contourVAO) { this.gl = gl this.cells = [] this.positions = [] this.intensity = [] this.texture = texture this.dirty = true this.triShader = triShader this.lineShader = lineShader this.pointShader = pointShader this.pickShader = pickShader this.pointPickShader = pointPickShader this.contourShader = contourShader this.trianglePositions = trianglePositions this.triangleColors = triangleColors this.triangleNormals = triangleNormals this.triangleUVs = triangleUVs this.triangleIds = triangleIds this.triangleVAO = triangleVAO this.triangleCount = 0 this.lineWidth = 1 this.edgePositions = edgePositions this.edgeColors = edgeColors this.edgeUVs = edgeUVs this.edgeIds = edgeIds this.edgeVAO = edgeVAO this.edgeCount = 0 this.pointPositions = pointPositions this.pointColors = pointColors this.pointUVs = pointUVs this.pointSizes = pointSizes this.pointIds = pointIds this.pointVAO = pointVAO this.pointCount = 0 this.contourLineWidth = 1 this.contourPositions = contourPositions this.contourVAO = contourVAO this.contourCount = 0 this.contourColor = [0,0,0] this.contourEnable = true this.pickId = 1 this.bounds = [ [ Infinity, Infinity, Infinity], [-Infinity,-Infinity,-Infinity] ] this.clipBounds = [ [-Infinity,-Infinity,-Infinity], [ Infinity, Infinity, Infinity] ] this.lightPosition = [1e5, 1e5, 0] this.ambientLight = 0.8 this.diffuseLight = 0.8 this.specularLight = 2.0 this.roughness = 0.5 this.fresnel = 1.5 this.opacity = 1.0 this._model = identityMatrix this._view = identityMatrix this._projection = identityMatrix this._resolution = [1,1] } var proto = SimplicialMesh.prototype proto.isOpaque = function() { return this.opacity >= 1 } proto.isTransparent = function() { return this.opacity < 1 } proto.pickSlots = 1 proto.setPickBase = function(id) { this.pickId = id } function genColormap(param) { var colors = colormap({ colormap: param , nshades: 256 , format: 'rgba' }) var result = new Uint8Array(256*4) for(var i=0; i<256; ++i) { var c = colors[i] for(var j=0; j<3; ++j) { result[4*i+j] = c[j] } result[4*i+3] = c[3]*255 } return ndarray(result, [256,256,4], [4,0,1]) } function unpackIntensity(cells, numVerts, cellIntensity) { var result = new Array(numVerts) for(var i=0; i 0) { var shader = this.triShader shader.bind() shader.uniforms = uniforms this.triangleVAO.bind() gl.drawArrays(gl.TRIANGLES, 0, this.triangleCount*3) this.triangleVAO.unbind() } if(this.edgeCount > 0 && this.lineWidth > 0) { var shader = this.lineShader shader.bind() shader.uniforms = uniforms this.edgeVAO.bind() gl.lineWidth(this.lineWidth) gl.drawArrays(gl.LINES, 0, this.edgeCount*2) this.edgeVAO.unbind() } if(this.pointCount > 0) { var shader = this.pointShader shader.bind() shader.uniforms = uniforms this.pointVAO.bind() gl.drawArrays(gl.POINTS, 0, this.pointCount) this.pointVAO.unbind() } if(this.contourEnable && this.contourCount > 0 && this.contourLineWidth > 0) { var shader = this.contourShader shader.bind() shader.uniforms = uniforms this.contourVAO.bind() gl.drawArrays(gl.LINES, 0, this.contourCount) this.contourVAO.unbind() } } proto.drawPick = function(params) { params = params || {} var gl = this.gl var model = params.model || identityMatrix var view = params.view || identityMatrix var projection = params.projection || identityMatrix var clipBounds = [[-1e6,-1e6,-1e6],[1e6,1e6,1e6]] for(var i=0; i<3; ++i) { clipBounds[0][i] = Math.max(clipBounds[0][i], this.clipBounds[0][i]) clipBounds[1][i] = Math.min(clipBounds[1][i], this.clipBounds[1][i]) } //Save camera parameters this._model = [].slice.call(model) this._view = [].slice.call(view) this._projection = [].slice.call(projection) this._resolution = [gl.drawingBufferWidth, gl.drawingBufferHeight] var uniforms = { model: model, view: view, projection: projection, clipBounds: clipBounds, pickId: this.pickId / 255.0, } var shader = this.pickShader shader.bind() shader.uniforms = uniforms if(this.triangleCount > 0) { this.triangleVAO.bind() gl.drawArrays(gl.TRIANGLES, 0, this.triangleCount*3) this.triangleVAO.unbind() } if(this.edgeCount > 0) { this.edgeVAO.bind() gl.lineWidth(this.lineWidth) gl.drawArrays(gl.LINES, 0, this.edgeCount*2) this.edgeVAO.unbind() } if(this.pointCount > 0) { var shader = this.pointPickShader shader.bind() shader.uniforms = uniforms this.pointVAO.bind() gl.drawArrays(gl.POINTS, 0, this.pointCount) this.pointVAO.unbind() } } proto.pick = function(pickData) { if(!pickData) { return null } if(pickData.id !== this.pickId) { return null } var cellId = pickData.value[0] + 256*pickData.value[1] + 65536*pickData.value[2] var cell = this.cells[cellId] var positions = this.positions var simplex = new Array(cell.length) for(var i=0; i EPSILON) { var norm = normals[c]; var w = 1.0 / Math.sqrt(m01 * m21); for(var k=0; k<3; ++k) { var u = (k+1)%3; var v = (k+2)%3; norm[k] += w * (d21[u] * d01[v] - d21[v] * d01[u]); } } } } //Scale all normals to unit length for(var i=0; i EPSILON) { var w = 1.0 / Math.sqrt(m); for(var k=0; k<3; ++k) { norm[k] *= w; } } else { for(var k=0; k<3; ++k) { norm[k] = 0.0; } } } //Return the resulting set of patches return normals; } //Compute face normals of a mesh exports.faceNormals = function(faces, positions) { var N = faces.length; var normals = new Array(N); for(var i=0; i EPSILON) { l = 1.0 / Math.sqrt(l); } else { l = 0.0; } for(var j=0; j<3; ++j) { n[j] *= l; } normals[i] = n; } return normals; } },{}],110:[function(require,module,exports){ //Optimized version for triangle closest point // Based on Eberly's WildMagick codes // http://www.geometrictools.com/LibMathematics/Distance/Distance.html "use strict"; var diff = new Float64Array(4); var edge0 = new Float64Array(4); var edge1 = new Float64Array(4); function closestPoint2d(V0, V1, V2, point, result) { //Reallocate buffers if necessary if(diff.length < point.length) { diff = new Float64Array(point.length); edge0 = new Float64Array(point.length); edge1 = new Float64Array(point.length); } //Compute edges for(var i=0; i= a00) { s = 1.0; sqrDistance = a00 + 2.0*b0 + c; } else { s = -b0/a00; sqrDistance = b0*s + c; } } else { s = 0; if (b1 >= 0) { t = 0; sqrDistance = c; } else if (-b1 >= a11) { t = 1; sqrDistance = a11 + 2.0*b1 + c; } else { t = -b1/a11; sqrDistance = b1*t + c; } } } else { // region 3 s = 0; if (b1 >= 0) { t = 0; sqrDistance = c; } else if (-b1 >= a11) { t = 1; sqrDistance = a11 + 2.0*b1 + c; } else { t = -b1/a11; sqrDistance = b1*t + c; } } } else if (t < 0) { // region 5 t = 0; if (b0 >= 0) { s = 0; sqrDistance = c; } else if (-b0 >= a00) { s = 1; sqrDistance = a00 + 2.0*b0 + c; } else { s = -b0/a00; sqrDistance = b0*s + c; } } else { // region 0 // minimum at interior point var invDet = 1.0 / det; s *= invDet; t *= invDet; sqrDistance = s*(a00*s + a01*t + 2.0*b0) + t*(a01*s + a11*t + 2.0*b1) + c; } } else { var tmp0, tmp1, numer, denom; if (s < 0) { // region 2 tmp0 = a01 + b0; tmp1 = a11 + b1; if (tmp1 > tmp0) { numer = tmp1 - tmp0; denom = a00 - 2.0*a01 + a11; if (numer >= denom) { s = 1; t = 0; sqrDistance = a00 + 2.0*b0 + c; } else { s = numer/denom; t = 1 - s; sqrDistance = s*(a00*s + a01*t + 2.0*b0) + t*(a01*s + a11*t + 2.0*b1) + c; } } else { s = 0; if (tmp1 <= 0) { t = 1; sqrDistance = a11 + 2.0*b1 + c; } else if (b1 >= 0) { t = 0; sqrDistance = c; } else { t = -b1/a11; sqrDistance = b1*t + c; } } } else if (t < 0) { // region 6 tmp0 = a01 + b1; tmp1 = a00 + b0; if (tmp1 > tmp0) { numer = tmp1 - tmp0; denom = a00 - 2.0*a01 + a11; if (numer >= denom) { t = 1; s = 0; sqrDistance = a11 + 2.0*b1 + c; } else { t = numer/denom; s = 1 - t; sqrDistance = s*(a00*s + a01*t + 2.0*b0) + t*(a01*s + a11*t + 2.0*b1) + c; } } else { t = 0; if (tmp1 <= 0) { s = 1; sqrDistance = a00 + 2.0*b0 + c; } else if (b0 >= 0) { s = 0; sqrDistance = c; } else { s = -b0/a00; sqrDistance = b0*s + c; } } } else { // region 1 numer = a11 + b1 - a01 - b0; if (numer <= 0) { s = 0; t = 1; sqrDistance = a11 + 2.0*b1 + c; } else { denom = a00 - 2.0*a01 + a11; if (numer >= denom) { s = 1; t = 0; sqrDistance = a00 + 2.0*b0 + c; } else { s = numer/denom; t = 1 - s; sqrDistance = s*(a00*s + a01*t + 2.0*b0) + t*(a01*s + a11*t + 2.0*b1) + c; } } } } var u = 1.0 - s - t; for(var i=0; i>1,v=E[2*m+1];', 'if(v===b){return m}', 'if(b 0) { code.push(',') } code.push('[') for(var j=0; j 0) { code.push(',') } code.push('B(C,E,c[', f[0], '],c[', f[1], '])') } code.push(']') } code.push(');') } for(var i=d+1; i>1; --i) { if(i < d+1) { code.push('else ') } code.push('if(l===', i, '){') //Generate mask var maskStr = [] for(var j=0; j 1) { var scratch_shape = [] for(var i=1; i 1) { //Copy data into scratch code.push("dptr=0;sptr=ptr") for(var i=order.length-1; i>=0; --i) { var j = order[i] if(j === 0) { continue } code.push(["for(i",j,"=0;i",j,"left){", "dptr=0", "sptr=cptr-s0") for(var i=1; ib){break __l}"].join("")) for(var i=order.length-1; i>=1; --i) { code.push( "sptr+=e"+i, "dptr+=f"+i, "}") } //Copy data back code.push("dptr=cptr;sptr=cptr-s0") for(var i=order.length-1; i>=0; --i) { var j = order[i] if(j === 0) { continue } code.push(["for(i",j,"=0;i",j,"=0; --i) { var j = order[i] if(j === 0) { continue } code.push(["for(i",j,"=0;i",j,"left)&&("+dataRead("cptr-s0")+">scratch)){", dataWrite("cptr", dataRead("cptr-s0")), "cptr-=s0", "}", dataWrite("cptr", "scratch")) } //Close outer loop body code.push("}") if(order.length > 1 && allocator) { code.push("free(scratch)") } code.push("} return " + funcName) //Compile and link function if(allocator) { var result = new Function("malloc", "free", code.join("\n")) return result(allocator[0], allocator[1]) } else { var result = new Function(code.join("\n")) return result() } } function createQuickSort(order, dtype, insertionSort) { var code = [ "'use strict'" ] var funcName = ["ndarrayQuickSort", order.join("d"), dtype].join("") var funcArgs = ["left", "right", "data", "offset" ].concat(shapeArgs(order.length)) var allocator = getMallocFree(dtype) var labelCounter=0 code.push(["function ", funcName, "(", funcArgs.join(","), "){"].join("")) var vars = [ "sixth=((right-left+1)/6)|0", "index1=left+sixth", "index5=right-sixth", "index3=(left+right)>>1", "index2=index3-sixth", "index4=index3+sixth", "el1=index1", "el2=index2", "el3=index3", "el4=index4", "el5=index5", "less=left+1", "great=right-1", "pivots_are_equal=true", "tmp", "tmp0", "x", "y", "z", "k", "ptr0", "ptr1", "ptr2", "comp_pivot1=0", "comp_pivot2=0", "comp=0" ] if(order.length > 1) { var ele_size = [] for(var i=1; i=0; --i) { var j = order[i] if(j === 0) { continue } code.push(["for(i",j,"=0;i",j," 1) { for(var i=0; i1) { code.push("ptr_shift+=d"+j) } else { code.push("ptr0+=d"+j) } code.push("}") } } function lexicoLoop(label, ptrs, usePivot, body) { if(ptrs.length === 1) { code.push("ptr0="+toPointer(ptrs[0])) } else { for(var i=0; i 1) { for(var i=0; i=1; --i) { if(usePivot) { code.push("pivot_ptr+=f"+i) } if(ptrs.length > 1) { code.push("ptr_shift+=e"+i) } else { code.push("ptr0+=e"+i) } code.push("}") } } function cleanUp() { if(order.length > 1 && allocator) { code.push("free(pivot1)", "free(pivot2)") } } function compareSwap(a_id, b_id) { var a = "el"+a_id var b = "el"+b_id if(order.length > 1) { var lbl = "__l" + (++labelCounter) lexicoLoop(lbl, [a, b], false, [ "comp=",dataRead("ptr0"),"-",dataRead("ptr1"),"\n", "if(comp>0){tmp0=", a, ";",a,"=",b,";", b,"=tmp0;break ", lbl,"}\n", "if(comp<0){break ", lbl, "}" ].join("")) } else { code.push(["if(", dataRead(toPointer(a)), ">", dataRead(toPointer(b)), "){tmp0=", a, ";",a,"=",b,";", b,"=tmp0}"].join("")) } } compareSwap(1, 2) compareSwap(4, 5) compareSwap(1, 3) compareSwap(2, 3) compareSwap(1, 4) compareSwap(3, 4) compareSwap(2, 5) compareSwap(2, 3) compareSwap(4, 5) if(order.length > 1) { cacheLoop(["el1", "el2", "el3", "el4", "el5", "index1", "index3", "index5"], true, [ "pivot1[pivot_ptr]=",dataRead("ptr1"),"\n", "pivot2[pivot_ptr]=",dataRead("ptr3"),"\n", "pivots_are_equal=pivots_are_equal&&(pivot1[pivot_ptr]===pivot2[pivot_ptr])\n", "x=",dataRead("ptr0"),"\n", "y=",dataRead("ptr2"),"\n", "z=",dataRead("ptr4"),"\n", dataWrite("ptr5", "x"),"\n", dataWrite("ptr6", "y"),"\n", dataWrite("ptr7", "z") ].join("")) } else { code.push([ "pivot1=", dataRead(toPointer("el2")), "\n", "pivot2=", dataRead(toPointer("el4")), "\n", "pivots_are_equal=pivot1===pivot2\n", "x=", dataRead(toPointer("el1")), "\n", "y=", dataRead(toPointer("el3")), "\n", "z=", dataRead(toPointer("el5")), "\n", dataWrite(toPointer("index1"), "x"), "\n", dataWrite(toPointer("index3"), "y"), "\n", dataWrite(toPointer("index5"), "z") ].join("")) } function moveElement(dst, src) { if(order.length > 1) { cacheLoop([dst, src], false, dataWrite("ptr0", dataRead("ptr1")) ) } else { code.push(dataWrite(toPointer(dst), dataRead(toPointer(src)))) } } moveElement("index2", "left") moveElement("index4", "right") function comparePivot(result, ptr, n) { if(order.length > 1) { var lbl = "__l" + (++labelCounter) lexicoLoop(lbl, [ptr], true, [ result,"=",dataRead("ptr0"),"-pivot",n,"[pivot_ptr]\n", "if(",result,"!==0){break ", lbl, "}" ].join("")) } else { code.push([result,"=", dataRead(toPointer(ptr)), "-pivot", n].join("")) } } function swapElements(a, b) { if(order.length > 1) { cacheLoop([a,b],false,[ "tmp=",dataRead("ptr0"),"\n", dataWrite("ptr0", dataRead("ptr1")),"\n", dataWrite("ptr1", "tmp") ].join("")) } else { code.push([ "ptr0=",toPointer(a),"\n", "ptr1=",toPointer(b),"\n", "tmp=",dataRead("ptr0"),"\n", dataWrite("ptr0", dataRead("ptr1")),"\n", dataWrite("ptr1", "tmp") ].join("")) } } function tripleSwap(k, less, great) { if(order.length > 1) { cacheLoop([k,less,great], false, [ "tmp=",dataRead("ptr0"),"\n", dataWrite("ptr0", dataRead("ptr1")),"\n", dataWrite("ptr1", dataRead("ptr2")),"\n", dataWrite("ptr2", "tmp") ].join("")) code.push("++"+less, "--"+great) } else { code.push([ "ptr0=",toPointer(k),"\n", "ptr1=",toPointer(less),"\n", "ptr2=",toPointer(great),"\n", "++",less,"\n", "--",great,"\n", "tmp=", dataRead("ptr0"), "\n", dataWrite("ptr0", dataRead("ptr1")), "\n", dataWrite("ptr1", dataRead("ptr2")), "\n", dataWrite("ptr2", "tmp") ].join("")) } } function swapAndDecrement(k, great) { swapElements(k, great) code.push("--"+great) } code.push("if(pivots_are_equal){") //Pivots are equal case code.push("for(k=less;k<=great;++k){") comparePivot("comp", "k", 1) code.push("if(comp===0){continue}") code.push("if(comp<0){") code.push("if(k!==less){") swapElements("k", "less") code.push("}") code.push("++less") code.push("}else{") code.push("while(true){") comparePivot("comp", "great", 1) code.push("if(comp>0){") code.push("great--") code.push("}else if(comp<0){") tripleSwap("k", "less", "great") code.push("break") code.push("}else{") swapAndDecrement("k", "great") code.push("break") code.push("}") code.push("}") code.push("}") code.push("}") code.push("}else{") //Pivots not equal case code.push("for(k=less;k<=great;++k){") comparePivot("comp_pivot1", "k", 1) code.push("if(comp_pivot1<0){") code.push("if(k!==less){") swapElements("k", "less") code.push("}") code.push("++less") code.push("}else{") comparePivot("comp_pivot2", "k", 2) code.push("if(comp_pivot2>0){") code.push("while(true){") comparePivot("comp", "great", 2) code.push("if(comp>0){") code.push("if(--great1) { cacheLoop([mem_dest, pivot_dest], true, [ dataWrite("ptr0", dataRead("ptr1")), "\n", dataWrite("ptr1", ["pivot",pivot,"[pivot_ptr]"].join("")) ].join("")) } else { code.push( dataWrite(toPointer(mem_dest), dataRead(toPointer(pivot_dest))), dataWrite(toPointer(pivot_dest), "pivot"+pivot)) } } storePivot("left", "(less-1)", 1) storePivot("right", "(great+1)", 2) //Recursive sort call function doSort(left, right) { code.push([ "if((",right,"-",left,")<=",INSERTION_SORT_THRESHOLD,"){\n", "insertionSort(", left, ",", right, ",data,offset,", shapeArgs(order.length).join(","), ")\n", "}else{\n", funcName, "(", left, ",", right, ",data,offset,", shapeArgs(order.length).join(","), ")\n", "}" ].join("")) } doSort("left", "(less-2)") doSort("(great+2)", "right") //If pivots are equal, then early out code.push("if(pivots_are_equal){") cleanUp() code.push("return") code.push("}") function walkPointer(ptr, pivot, body) { if(order.length > 1) { code.push(["__l",++labelCounter,":while(true){"].join("")) cacheLoop([ptr], true, [ "if(", dataRead("ptr0"), "!==pivot", pivot, "[pivot_ptr]){break __l", labelCounter, "}" ].join("")) code.push(body, "}") } else { code.push(["while(", dataRead(toPointer(ptr)), "===pivot", pivot, "){", body, "}"].join("")) } } //Check bounds code.push("if(lessindex5){") walkPointer("less", 1, "++less") walkPointer("great", 2, "--great") code.push("for(k=less;k<=great;++k){") comparePivot("comp_pivot1", "k", 1) code.push("if(comp_pivot1===0){") code.push("if(k!==less){") swapElements("k", "less") code.push("}") code.push("++less") code.push("}else{") comparePivot("comp_pivot2", "k", 2) code.push("if(comp_pivot2===0){") code.push("while(true){") comparePivot("comp", "great", 2) code.push("if(comp===0){") code.push("if(--great 1 && allocator) { var compiled = new Function("insertionSort", "malloc", "free", code.join("\n")) return compiled(insertionSort, allocator[0], allocator[1]) } var compiled = new Function("insertionSort", code.join("\n")) return compiled(insertionSort) } function compileSort(order, dtype) { var code = ["'use strict'"] var funcName = ["ndarraySortWrapper", order.join("d"), dtype].join("") var funcArgs = [ "array" ] code.push(["function ", funcName, "(", funcArgs.join(","), "){"].join("")) //Unpack local variables from array var vars = ["data=array.data,offset=array.offset|0,shape=array.shape,stride=array.stride"] for(var i=0; i 0) { vars.push(["d",j,"=s",j,"-d",p,"*n",p].join("")) } else { vars.push(["d",j,"=s",j].join("")) } p = j } var k = order.length-1-i if(k !== 0) { if(q > 0) { vars.push(["e",k,"=s",k,"-e",q,"*n",q, ",f",k,"=",scratch_stride[k],"-f",q,"*n",q].join("")) } else { vars.push(["e",k,"=s",k,",f",k,"=",scratch_stride[k]].join("")) } q = k } } //Declare local variables code.push("var " + vars.join(",")) //Create arguments for subroutine var sortArgs = ["0", "n0-1", "data", "offset"].concat(shapeArgs(order.length)) //Call main sorting routine code.push([ "if(n0<=",INSERTION_SORT_THRESHOLD,"){", "insertionSort(", sortArgs.join(","), ")}else{", "quickSort(", sortArgs.join(","), ")}" ].join("")) //Return code.push("}return " + funcName) //Link everything together var result = new Function("insertionSort", "quickSort", code.join("\n")) var insertionSort = createInsertionSort(order, dtype) var quickSort = createQuickSort(order, dtype, insertionSort) return result(insertionSort, quickSort) } module.exports = compileSort },{"typedarray-pool":233}],115:[function(require,module,exports){ "use strict" var compile = require("./lib/compile_sort.js") var CACHE = {} function sort(array) { var order = array.order var dtype = array.dtype var typeSig = [order, dtype ] var typeName = typeSig.join(":") var compiled = CACHE[typeName] if(!compiled) { CACHE[typeName] = compiled = compile(order, dtype) } compiled(array) return array } module.exports = sort },{"./lib/compile_sort.js":114}],116:[function(require,module,exports){ 'use strict' module.exports = createBoxes var createBuffer = require('gl-buffer') var createShader = require('gl-shader') var shaders = require('./shaders') function Boxes(plot, vbo, shader) { this.plot = plot this.vbo = vbo this.shader = shader } var proto = Boxes.prototype proto.bind = function() { var shader = this.shader this.vbo.bind() this.shader.bind() shader.attributes.coord.pointer() shader.uniforms.screenBox = this.plot.screenBox } proto.drawBox = (function() { var lo = [0,0] var hi = [0,0] return function(loX, loY, hiX, hiY, color) { var plot = this.plot var shader = this.shader var gl = plot.gl lo[0] = loX lo[1] = loY hi[0] = hiX hi[1] = hiY shader.uniforms.lo = lo shader.uniforms.hi = hi shader.uniforms.color = color gl.drawArrays(gl.TRIANGLE_STRIP, 0, 4) } }()) proto.dispose = function() { this.vbo.dispose() this.shader.dispose() } function createBoxes(plot) { var gl = plot.gl var vbo = createBuffer(gl, [ 0,0, 0,1, 1,0, 1,1]) var shader = createShader(gl, shaders.boxVert, shaders.lineFrag) return new Boxes(plot, vbo, shader) } },{"./shaders":119,"gl-buffer":75,"gl-shader":154}],117:[function(require,module,exports){ 'use strict' module.exports = createGrid var createBuffer = require('gl-buffer') var createShader = require('gl-shader') var bsearch = require('binary-search-bounds') var shaders = require('./shaders') function Grid(plot, vbo, shader, tickShader) { this.plot = plot this.vbo = vbo this.shader = shader this.tickShader = tickShader this.ticks = [[], []] } function compareTickNum(a, b) { return a - b } var proto = Grid.prototype proto.draw = (function() { var DATA_SHIFT = [0,0] var DATA_SCALE = [0,0] var DATA_AXIS = [0,0] return function() { var plot = this.plot var vbo = this.vbo var shader = this.shader var ticks = this.ticks var gl = plot.gl var bounds = plot._tickBounds var dataBox = plot.dataBox var viewPixels = plot.viewBox var lineWidth = plot.gridLineWidth var gridColor = plot.gridLineColor var gridEnable = plot.gridLineEnable var pixelRatio = plot.pixelRatio for(var i=0; i<2; ++i) { var lo = bounds[i] var hi = bounds[i+2] var boundScale = hi - lo var dataCenter = 0.5 * (dataBox[i+2] + dataBox[i]) var dataWidth = dataBox[i+2] - dataBox[i] DATA_SCALE[i] = 2.0 * boundScale / dataWidth DATA_SHIFT[i] = 2.0 * (lo - dataCenter) / dataWidth } shader.bind() vbo.bind() shader.attributes.dataCoord.pointer() shader.uniforms.dataShift = DATA_SHIFT shader.uniforms.dataScale = DATA_SCALE var offset = 0 for(var i=0; i<2; ++i) { DATA_AXIS[0] = DATA_AXIS[1] = 0 DATA_AXIS[i] = 1 shader.uniforms.dataAxis = DATA_AXIS shader.uniforms.lineWidth = lineWidth[i] / (viewPixels[i+2] - viewPixels[i]) * pixelRatio shader.uniforms.color = gridColor[i] var size = ticks[i].length * 6 if(gridEnable[i]) { gl.drawArrays(gl.TRIANGLES, offset, size) } offset += size } } })() proto.drawTickMarks = (function() { var DATA_SHIFT = [0,0] var DATA_SCALE = [0,0] var X_AXIS = [1,0] var Y_AXIS = [0,1] var SCR_OFFSET = [0,0] var TICK_SCALE = [0,0] return function() { var plot = this.plot var vbo = this.vbo var shader = this.tickShader var ticks = this.ticks var gl = plot.gl var bounds = plot._tickBounds var dataBox = plot.dataBox var viewBox = plot.viewBox var pixelRatio = plot.pixelRatio var screenBox = plot.screenBox var screenWidth = screenBox[2] - screenBox[0] var screenHeight = screenBox[3] - screenBox[1] var viewWidth = viewBox[2] - viewBox[0] var viewHeight = viewBox[3] - viewBox[1] for(var i=0; i<2; ++i) { var lo = bounds[i] var hi = bounds[i+2] var boundScale = hi - lo var dataCenter = 0.5 * (dataBox[i+2] + dataBox[i]) var dataWidth = (dataBox[i+2] - dataBox[i]) DATA_SCALE[i] = 2.0 * boundScale / dataWidth DATA_SHIFT[i] = 2.0 * (lo - dataCenter) / dataWidth } DATA_SCALE[0] *= viewWidth / screenWidth DATA_SHIFT[0] *= viewWidth / screenWidth DATA_SCALE[1] *= viewHeight / screenHeight DATA_SHIFT[1] *= viewHeight / screenHeight shader.bind() vbo.bind() shader.attributes.dataCoord.pointer() var uniforms = shader.uniforms uniforms.dataShift = DATA_SHIFT uniforms.dataScale = DATA_SCALE var tickMarkLength = plot.tickMarkLength var tickMarkWidth = plot.tickMarkWidth var tickMarkColor = plot.tickMarkColor var xTicksOffset = 0 var yTicksOffset = ticks[0].length * 6 var xStart = Math.min(bsearch.ge(ticks[0], (dataBox[0] - bounds[0]) / (bounds[2] - bounds[0]), compareTickNum), ticks[0].length) var xEnd = Math.min(bsearch.gt(ticks[0], (dataBox[2] - bounds[0]) / (bounds[2] - bounds[0]), compareTickNum), ticks[0].length) var xOffset = xTicksOffset + 6 * xStart var xCount = 6 * Math.max(0, xEnd - xStart) var yStart = Math.min(bsearch.ge(ticks[1], (dataBox[1] - bounds[1]) / (bounds[3] - bounds[1]), compareTickNum), ticks[1].length) var yEnd = Math.min(bsearch.gt(ticks[1], (dataBox[3] - bounds[1]) / (bounds[3] - bounds[1]), compareTickNum), ticks[1].length) var yOffset = yTicksOffset + 6 * yStart var yCount = 6 * Math.max(0, yEnd - yStart) SCR_OFFSET[0] = 2.0 * (viewBox[0] - tickMarkLength[1]) / screenWidth - 1.0 SCR_OFFSET[1] = (viewBox[3] + viewBox[1]) / screenHeight - 1.0 TICK_SCALE[0] = tickMarkLength[1] * pixelRatio / screenWidth TICK_SCALE[1] = tickMarkWidth[1] * pixelRatio / screenHeight uniforms.color = tickMarkColor[1] uniforms.tickScale = TICK_SCALE uniforms.dataAxis = Y_AXIS uniforms.screenOffset = SCR_OFFSET gl.drawArrays(gl.TRIANGLES, yOffset, yCount) SCR_OFFSET[0] = (viewBox[2] + viewBox[0]) / screenWidth - 1.0 SCR_OFFSET[1] = 2.0 * (viewBox[1] - tickMarkLength[0]) / screenHeight - 1.0 TICK_SCALE[0] = tickMarkWidth[0] * pixelRatio / screenWidth TICK_SCALE[1] = tickMarkLength[0] * pixelRatio / screenHeight uniforms.color = tickMarkColor[0] uniforms.tickScale = TICK_SCALE uniforms.dataAxis = X_AXIS uniforms.screenOffset = SCR_OFFSET gl.drawArrays(gl.TRIANGLES, xOffset, xCount) SCR_OFFSET[0] = 2.0 * (viewBox[2] + tickMarkLength[3]) / screenWidth - 1.0 SCR_OFFSET[1] = (viewBox[3] + viewBox[1]) / screenHeight - 1.0 TICK_SCALE[0] = tickMarkLength[3] * pixelRatio / screenWidth TICK_SCALE[1] = tickMarkWidth[3] * pixelRatio / screenHeight uniforms.color = tickMarkColor[3] uniforms.tickScale = TICK_SCALE uniforms.dataAxis = Y_AXIS uniforms.screenOffset = SCR_OFFSET gl.drawArrays(gl.TRIANGLES, yOffset, yCount) SCR_OFFSET[0] = (viewBox[2] + viewBox[0]) / screenWidth - 1.0 SCR_OFFSET[1] = 2.0 * (viewBox[3] + tickMarkLength[2]) / screenHeight - 1.0 TICK_SCALE[0] = tickMarkWidth[2] * pixelRatio / screenWidth TICK_SCALE[1] = tickMarkLength[2] * pixelRatio / screenHeight uniforms.color = tickMarkColor[2] uniforms.tickScale = TICK_SCALE uniforms.dataAxis = X_AXIS uniforms.screenOffset = SCR_OFFSET gl.drawArrays(gl.TRIANGLES, xOffset, xCount) } })() proto.update = (function() { var OFFSET_X = [1, 1, -1, -1, 1, -1] var OFFSET_Y = [1, -1, 1, 1, -1, -1] return function(options) { var ticks = options.ticks var bounds = options.bounds var data = new Float32Array(6 * 3 * (ticks[0].length + ticks[1].length)) var zeroLineEnable = this.plot.zeroLineEnable var ptr = 0 var gridTicks = [[], []] for(var dim=0; dim<2; ++dim) { var localTicks = gridTicks[dim] var axisTicks = ticks[dim] var lo = bounds[dim] var hi = bounds[dim+2] for(var i=0; i>>1,x=a[m]"] if(earlyOut) { if(predicate.indexOf("c") < 0) { code.push(";if(x===y){return m}else if(x<=y){") } else { code.push(";var p=c(x,y);if(p===0){return m}else if(p<=0){") } } else { code.push(";if(", predicate, "){i=m;") } if(reversed) { code.push("l=m+1}else{h=m-1}") } else { code.push("h=m-1}else{l=m+1}") } code.push("}") if(earlyOut) { code.push("return -1};") } else { code.push("return i};") } return code.join("") } function compileBoundsSearch(predicate, reversed, suffix, earlyOut) { var result = new Function([ compileSearch("A", "x" + predicate + "y", reversed, ["y"], earlyOut), compileSearch("P", "c(x,y)" + predicate + "0", reversed, ["y", "c"], earlyOut), "function dispatchBsearch", suffix, "(a,y,c,l,h){\ if(typeof(c)==='function'){\ return P(a,(l===void 0)?0:l|0,(h===void 0)?a.length-1:h|0,y,c)\ }else{\ return A(a,(c===void 0)?0:c|0,(l===void 0)?a.length-1:l|0,y)\ }}\ return dispatchBsearch", suffix].join("")) return result() } module.exports = { ge: compileBoundsSearch(">=", false, "GE"), gt: compileBoundsSearch(">", false, "GT"), lt: compileBoundsSearch("<", true, "LT"), le: compileBoundsSearch("<=", true, "LE"), eq: compileBoundsSearch("-", true, "EQ", true) } },{}],122:[function(require,module,exports){ 'use strict' module.exports = createGLPlot2D var createPick = require('gl-select-static') var createGrid = require('./lib/grid') var createText = require('./lib/text') var createLine = require('./lib/line') var createBox = require('./lib/box') function GLPlot2D(gl, pickBuffer) { this.gl = gl this.pickBuffer = pickBuffer this.screenBox = [0, 0, gl.drawingBufferWidth, gl.drawingBufferHeight] this.viewBox = [0, 0, 0, 0] this.dataBox = [-10, -10, 10, 10] this.gridLineEnable = [true,true] this.gridLineWidth = [1,1] this.gridLineColor = [[0,0,0,1], [0,0,0,1]] this.pixelRatio = 1 this.tickMarkLength = [0,0,0,0] this.tickMarkWidth = [0,0,0,0] this.tickMarkColor = [[0,0,0,1], [0,0,0,1], [0,0,0,1], [0,0,0,1]] this.tickPad = [15,15,15,15] this.tickAngle = [0,0,0,0] this.tickEnable = [true,true,true,true] this.tickColor = [[0,0,0,1], [0,0,0,1], [0,0,0,1], [0,0,0,1]] this.labelPad = [15,15,15,15] this.labelAngle = [0,Math.PI/2,0,3.0*Math.PI/2] this.labelEnable = [true,true,true,true] this.labelColor = [[0,0,0,1], [0,0,0,1], [0,0,0,1], [0,0,0,1]] this.titleCenter = [0,0] this.titleEnable = true this.titleAngle = 0 this.titleColor = [0,0,0,1] this.borderColor = [0,0,0,0] this.backgroundColor = [0,0,0,0] this.zeroLineEnable = [true, true] this.zeroLineWidth = [4, 4] this.zeroLineColor = [[0, 0, 0, 1],[0, 0, 0, 1]] this.borderLineEnable = [true,true,true,true] this.borderLineWidth = [2,2,2,2] this.borderLineColor = [[0,0,0,1], [0,0,0,1], [0,0,0,1], [0,0,0,1]] //Drawing parameters this.grid = null this.text = null this.line = null this.box = null this.objects = [] this.overlays = [] this._tickBounds = [Infinity, Infinity, -Infinity, -Infinity] this.dirty = false this.pickDirty = false this.pickDelay = 120 this.pickRadius = 10 this._pickTimeout = null this._drawPick = this.drawPick.bind(this) this._depthCounter = 0 } var proto = GLPlot2D.prototype proto.setDirty = function() { this.dirty = this.pickDirty = true } proto.setOverlayDirty = function() { this.dirty = true } proto.nextDepthValue = function() { return (this._depthCounter++) / 65536.0 } function lerp(a, b, t) { var s = 0.5 * (t + 1.0) return Math.floor((1.0-s)*a + s*b)|0 } proto.draw = (function() { var TICK_MARK_BOX = [0,0,0,0] return function() { var gl = this.gl var screenBox = this.screenBox var viewPixels = this.viewBox var dataBox = this.dataBox var pixelRatio = this.pixelRatio var grid = this.grid var line = this.line var text = this.text var objects = this.objects this._depthCounter = 0 if(this.pickDirty) { if(this._pickTimeout) { clearTimeout(this._pickTimeout) } this.pickDirty = false this._pickTimeout = setTimeout(this._drawPick, this.pickDelay) } if(!this.dirty) { return } this.dirty = false gl.bindFramebuffer(gl.FRAMEBUFFER, null) //Turn on scissor gl.enable(gl.SCISSOR_TEST) //Turn off depth buffer gl.disable(gl.DEPTH_TEST) gl.depthFunc(gl.LESS) gl.depthMask(false) //Configure premultiplied alpha blending gl.enable(gl.BLEND) gl.blendEquation(gl.FUNC_ADD, gl.FUNC_ADD); gl.blendFunc(gl.ONE, gl.ONE_MINUS_SRC_ALPHA); //Draw border gl.scissor( screenBox[0], screenBox[1], screenBox[2]-screenBox[0], screenBox[3]-screenBox[1]) var borderColor = this.borderColor gl.clearColor( borderColor[0]*borderColor[3], borderColor[1]*borderColor[3], borderColor[2]*borderColor[3], borderColor[3]) gl.clear(gl.COLOR_BUFFER_BIT | gl.DEPTH_BUFFER_BIT) //Draw center pane gl.scissor( viewPixels[0], viewPixels[1], viewPixels[2]-viewPixels[0], viewPixels[3]-viewPixels[1]) gl.viewport( viewPixels[0], viewPixels[1], viewPixels[2]-viewPixels[0], viewPixels[3]-viewPixels[1]) var backgroundColor = this.backgroundColor gl.clearColor( backgroundColor[0]*backgroundColor[3], backgroundColor[1]*backgroundColor[3], backgroundColor[2]*backgroundColor[3], backgroundColor[3]) gl.clear(gl.COLOR_BUFFER_BIT) //Draw grid grid.draw() //Draw zero lines separately var zeroLineEnable = this.zeroLineEnable var zeroLineColor = this.zeroLineColor var zeroLineWidth = this.zeroLineWidth if(zeroLineEnable[0] || zeroLineEnable[1]) { line.bind() for(var i=0; i<2; ++i) { if(!zeroLineEnable[i] || !(dataBox[i] <= 0 && dataBox[i+2] >= 0)) { continue } var zeroIntercept = screenBox[i] - dataBox[i] * (screenBox[i+2] - screenBox[i]) / (dataBox[i+2] - dataBox[i]) if(i === 0) { line.drawLine( zeroIntercept, screenBox[1], zeroIntercept, screenBox[3], zeroLineWidth[i], zeroLineColor[i]) } else { line.drawLine( screenBox[0], zeroIntercept, screenBox[2], zeroIntercept, zeroLineWidth[i], zeroLineColor[i]) } } } //Draw traces for(var i=0; i=0; --i) { this.objects[i].dispose() } this.objects.length = 0 for(var i=this.overlays.length-1; i>=0; --i) { this.overlays[i].dispose() } this.overlays.length = 0 this.gl = null } proto.addObject = function(object) { if(this.objects.indexOf(object) < 0) { this.objects.push(object) this.setDirty() } } proto.removeObject = function(object) { var objects = this.objects for(var i=0; i Math.abs(dy)) { view.rotate(t, 0, 0, -dx * flipX * Math.PI * camera.rotateSpeed / window.innerWidth) } else { var kzoom = camera.zoomSpeed * flipY * dy / window.innerHeight * (t - view.lastT()) / 100.0 view.pan(t, 0, 0, distance * (Math.exp(kzoom) - 1)) } }, true) return camera } },{"3d-view":38,"mouse-change":196,"mouse-wheel":200,"right-now":210}],125:[function(require,module,exports){ // Copyright (C) 2011 Google Inc. // // 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. /** * @fileoverview Install a leaky WeakMap emulation on platforms that * don't provide a built-in one. * *

Assumes that an ES5 platform where, if {@code WeakMap} is * already present, then it conforms to the anticipated ES6 * specification. To run this file on an ES5 or almost ES5 * implementation where the {@code WeakMap} specification does not * quite conform, run repairES5.js first. * *

Even though WeakMapModule is not global, the linter thinks it * is, which is why it is in the overrides list below. * *

NOTE: Before using this WeakMap emulation in a non-SES * environment, see the note below about hiddenRecord. * * @author Mark S. Miller * @requires crypto, ArrayBuffer, Uint8Array, navigator, console * @overrides WeakMap, ses, Proxy * @overrides WeakMapModule */ /** * This {@code WeakMap} emulation is observably equivalent to the * ES-Harmony WeakMap, but with leakier garbage collection properties. * *

As with true WeakMaps, in this emulation, a key does not * retain maps indexed by that key and (crucially) a map does not * retain the keys it indexes. A map by itself also does not retain * the values associated with that map. * *

However, the values associated with a key in some map are * retained so long as that key is retained and those associations are * not overridden. For example, when used to support membranes, all * values exported from a given membrane will live for the lifetime * they would have had in the absence of an interposed membrane. Even * when the membrane is revoked, all objects that would have been * reachable in the absence of revocation will still be reachable, as * far as the GC can tell, even though they will no longer be relevant * to ongoing computation. * *

The API implemented here is approximately the API as implemented * in FF6.0a1 and agreed to by MarkM, Andreas Gal, and Dave Herman, * rather than the offially approved proposal page. TODO(erights): * upgrade the ecmascript WeakMap proposal page to explain this API * change and present to EcmaScript committee for their approval. * *

The first difference between the emulation here and that in * FF6.0a1 is the presence of non enumerable {@code get___, has___, * set___, and delete___} methods on WeakMap instances to represent * what would be the hidden internal properties of a primitive * implementation. Whereas the FF6.0a1 WeakMap.prototype methods * require their {@code this} to be a genuine WeakMap instance (i.e., * an object of {@code [[Class]]} "WeakMap}), since there is nothing * unforgeable about the pseudo-internal method names used here, * nothing prevents these emulated prototype methods from being * applied to non-WeakMaps with pseudo-internal methods of the same * names. * *

Another difference is that our emulated {@code * WeakMap.prototype} is not itself a WeakMap. A problem with the * current FF6.0a1 API is that WeakMap.prototype is itself a WeakMap * providing ambient mutability and an ambient communications * channel. Thus, if a WeakMap is already present and has this * problem, repairES5.js wraps it in a safe wrappper in order to * prevent access to this channel. (See * PATCH_MUTABLE_FROZEN_WEAKMAP_PROTO in repairES5.js). */ /** * If this is a full secureable ES5 platform and the ES-Harmony {@code WeakMap} is * absent, install an approximate emulation. * *

If WeakMap is present but cannot store some objects, use our approximate * emulation as a wrapper. * *

If this is almost a secureable ES5 platform, then WeakMap.js * should be run after repairES5.js. * *

See {@code WeakMap} for documentation of the garbage collection * properties of this WeakMap emulation. */ (function WeakMapModule() { "use strict"; if (typeof ses !== 'undefined' && ses.ok && !ses.ok()) { // already too broken, so give up return; } /** * In some cases (current Firefox), we must make a choice betweeen a * WeakMap which is capable of using all varieties of host objects as * keys and one which is capable of safely using proxies as keys. See * comments below about HostWeakMap and DoubleWeakMap for details. * * This function (which is a global, not exposed to guests) marks a * WeakMap as permitted to do what is necessary to index all host * objects, at the cost of making it unsafe for proxies. * * Do not apply this function to anything which is not a genuine * fresh WeakMap. */ function weakMapPermitHostObjects(map) { // identity of function used as a secret -- good enough and cheap if (map.permitHostObjects___) { map.permitHostObjects___(weakMapPermitHostObjects); } } if (typeof ses !== 'undefined') { ses.weakMapPermitHostObjects = weakMapPermitHostObjects; } // IE 11 has no Proxy but has a broken WeakMap such that we need to patch // it using DoubleWeakMap; this flag tells DoubleWeakMap so. var doubleWeakMapCheckSilentFailure = false; // Check if there is already a good-enough WeakMap implementation, and if so // exit without replacing it. if (typeof WeakMap === 'function') { var HostWeakMap = WeakMap; // There is a WeakMap -- is it good enough? if (typeof navigator !== 'undefined' && /Firefox/.test(navigator.userAgent)) { // We're now *assuming not*, because as of this writing (2013-05-06) // Firefox's WeakMaps have a miscellany of objects they won't accept, and // we don't want to make an exhaustive list, and testing for just one // will be a problem if that one is fixed alone (as they did for Event). // If there is a platform that we *can* reliably test on, here's how to // do it: // var problematic = ... ; // var testHostMap = new HostWeakMap(); // try { // testHostMap.set(problematic, 1); // Firefox 20 will throw here // if (testHostMap.get(problematic) === 1) { // return; // } // } catch (e) {} } else { // IE 11 bug: WeakMaps silently fail to store frozen objects. var testMap = new HostWeakMap(); var testObject = Object.freeze({}); testMap.set(testObject, 1); if (testMap.get(testObject) !== 1) { doubleWeakMapCheckSilentFailure = true; // Fall through to installing our WeakMap. } else { module.exports = WeakMap; return; } } } var hop = Object.prototype.hasOwnProperty; var gopn = Object.getOwnPropertyNames; var defProp = Object.defineProperty; var isExtensible = Object.isExtensible; /** * Security depends on HIDDEN_NAME being both unguessable and * undiscoverable by untrusted code. * *

Given the known weaknesses of Math.random() on existing * browsers, it does not generate unguessability we can be confident * of. * *

It is the monkey patching logic in this file that is intended * to ensure undiscoverability. The basic idea is that there are * three fundamental means of discovering properties of an object: * The for/in loop, Object.keys(), and Object.getOwnPropertyNames(), * as well as some proposed ES6 extensions that appear on our * whitelist. The first two only discover enumerable properties, and * we only use HIDDEN_NAME to name a non-enumerable property, so the * only remaining threat should be getOwnPropertyNames and some * proposed ES6 extensions that appear on our whitelist. We monkey * patch them to remove HIDDEN_NAME from the list of properties they * returns. * *

TODO(erights): On a platform with built-in Proxies, proxies * could be used to trap and thereby discover the HIDDEN_NAME, so we * need to monkey patch Proxy.create, Proxy.createFunction, etc, in * order to wrap the provided handler with the real handler which * filters out all traps using HIDDEN_NAME. * *

TODO(erights): Revisit Mike Stay's suggestion that we use an * encapsulated function at a not-necessarily-secret name, which * uses the Stiegler shared-state rights amplification pattern to * reveal the associated value only to the WeakMap in which this key * is associated with that value. Since only the key retains the * function, the function can also remember the key without causing * leakage of the key, so this doesn't violate our general gc * goals. In addition, because the name need not be a guarded * secret, we could efficiently handle cross-frame frozen keys. */ var HIDDEN_NAME_PREFIX = 'weakmap:'; var HIDDEN_NAME = HIDDEN_NAME_PREFIX + 'ident:' + Math.random() + '___'; if (typeof crypto !== 'undefined' && typeof crypto.getRandomValues === 'function' && typeof ArrayBuffer === 'function' && typeof Uint8Array === 'function') { var ab = new ArrayBuffer(25); var u8s = new Uint8Array(ab); crypto.getRandomValues(u8s); HIDDEN_NAME = HIDDEN_NAME_PREFIX + 'rand:' + Array.prototype.map.call(u8s, function(u8) { return (u8 % 36).toString(36); }).join('') + '___'; } function isNotHiddenName(name) { return !( name.substr(0, HIDDEN_NAME_PREFIX.length) == HIDDEN_NAME_PREFIX && name.substr(name.length - 3) === '___'); } /** * Monkey patch getOwnPropertyNames to avoid revealing the * HIDDEN_NAME. * *

The ES5.1 spec requires each name to appear only once, but as * of this writing, this requirement is controversial for ES6, so we * made this code robust against this case. If the resulting extra * search turns out to be expensive, we can probably relax this once * ES6 is adequately supported on all major browsers, iff no browser * versions we support at that time have relaxed this constraint * without providing built-in ES6 WeakMaps. */ defProp(Object, 'getOwnPropertyNames', { value: function fakeGetOwnPropertyNames(obj) { return gopn(obj).filter(isNotHiddenName); } }); /** * getPropertyNames is not in ES5 but it is proposed for ES6 and * does appear in our whitelist, so we need to clean it too. */ if ('getPropertyNames' in Object) { var originalGetPropertyNames = Object.getPropertyNames; defProp(Object, 'getPropertyNames', { value: function fakeGetPropertyNames(obj) { return originalGetPropertyNames(obj).filter(isNotHiddenName); } }); } /** *

To treat objects as identity-keys with reasonable efficiency * on ES5 by itself (i.e., without any object-keyed collections), we * need to add a hidden property to such key objects when we * can. This raises several issues: *

    *
  • Arranging to add this property to objects before we lose the * chance, and *
  • Hiding the existence of this new property from most * JavaScript code. *
  • Preventing certification theft, where one object is * created falsely claiming to be the key of an association * actually keyed by another object. *
  • Preventing value theft, where untrusted code with * access to a key object but not a weak map nevertheless * obtains access to the value associated with that key in that * weak map. *
* We do so by *
    *
  • Making the name of the hidden property unguessable, so "[]" * indexing, which we cannot intercept, cannot be used to access * a property without knowing the name. *
  • Making the hidden property non-enumerable, so we need not * worry about for-in loops or {@code Object.keys}, *
  • monkey patching those reflective methods that would * prevent extensions, to add this hidden property first, *
  • monkey patching those methods that would reveal this * hidden property. *
* Unfortunately, because of same-origin iframes, we cannot reliably * add this hidden property before an object becomes * non-extensible. Instead, if we encounter a non-extensible object * without a hidden record that we can detect (whether or not it has * a hidden record stored under a name secret to us), then we just * use the key object itself to represent its identity in a brute * force leaky map stored in the weak map, losing all the advantages * of weakness for these. */ function getHiddenRecord(key) { if (key !== Object(key)) { throw new TypeError('Not an object: ' + key); } var hiddenRecord = key[HIDDEN_NAME]; if (hiddenRecord && hiddenRecord.key === key) { return hiddenRecord; } if (!isExtensible(key)) { // Weak map must brute force, as explained in doc-comment above. return void 0; } // The hiddenRecord and the key point directly at each other, via // the "key" and HIDDEN_NAME properties respectively. The key // field is for quickly verifying that this hidden record is an // own property, not a hidden record from up the prototype chain. // // NOTE: Because this WeakMap emulation is meant only for systems like // SES where Object.prototype is frozen without any numeric // properties, it is ok to use an object literal for the hiddenRecord. // This has two advantages: // * It is much faster in a performance critical place // * It avoids relying on Object.create(null), which had been // problematic on Chrome 28.0.1480.0. See // https://code.google.com/p/google-caja/issues/detail?id=1687 hiddenRecord = { key: key }; // When using this WeakMap emulation on platforms where // Object.prototype might not be frozen and Object.create(null) is // reliable, use the following two commented out lines instead. // hiddenRecord = Object.create(null); // hiddenRecord.key = key; // Please contact us if you need this to work on platforms where // Object.prototype might not be frozen and // Object.create(null) might not be reliable. try { defProp(key, HIDDEN_NAME, { value: hiddenRecord, writable: false, enumerable: false, configurable: false }); return hiddenRecord; } catch (error) { // Under some circumstances, isExtensible seems to misreport whether // the HIDDEN_NAME can be defined. // The circumstances have not been isolated, but at least affect // Node.js v0.10.26 on TravisCI / Linux, but not the same version of // Node.js on OS X. return void 0; } } /** * Monkey patch operations that would make their argument * non-extensible. * *

The monkey patched versions throw a TypeError if their * argument is not an object, so it should only be done to functions * that should throw a TypeError anyway if their argument is not an * object. */ (function(){ var oldFreeze = Object.freeze; defProp(Object, 'freeze', { value: function identifyingFreeze(obj) { getHiddenRecord(obj); return oldFreeze(obj); } }); var oldSeal = Object.seal; defProp(Object, 'seal', { value: function identifyingSeal(obj) { getHiddenRecord(obj); return oldSeal(obj); } }); var oldPreventExtensions = Object.preventExtensions; defProp(Object, 'preventExtensions', { value: function identifyingPreventExtensions(obj) { getHiddenRecord(obj); return oldPreventExtensions(obj); } }); })(); function constFunc(func) { func.prototype = null; return Object.freeze(func); } var calledAsFunctionWarningDone = false; function calledAsFunctionWarning() { // Future ES6 WeakMap is currently (2013-09-10) expected to reject WeakMap() // but we used to permit it and do it ourselves, so warn only. if (!calledAsFunctionWarningDone && typeof console !== 'undefined') { calledAsFunctionWarningDone = true; console.warn('WeakMap should be invoked as new WeakMap(), not ' + 'WeakMap(). This will be an error in the future.'); } } var nextId = 0; var OurWeakMap = function() { if (!(this instanceof OurWeakMap)) { // approximate test for new ...() calledAsFunctionWarning(); } // We are currently (12/25/2012) never encountering any prematurely // non-extensible keys. var keys = []; // brute force for prematurely non-extensible keys. var values = []; // brute force for corresponding values. var id = nextId++; function get___(key, opt_default) { var index; var hiddenRecord = getHiddenRecord(key); if (hiddenRecord) { return id in hiddenRecord ? hiddenRecord[id] : opt_default; } else { index = keys.indexOf(key); return index >= 0 ? values[index] : opt_default; } } function has___(key) { var hiddenRecord = getHiddenRecord(key); if (hiddenRecord) { return id in hiddenRecord; } else { return keys.indexOf(key) >= 0; } } function set___(key, value) { var index; var hiddenRecord = getHiddenRecord(key); if (hiddenRecord) { hiddenRecord[id] = value; } else { index = keys.indexOf(key); if (index >= 0) { values[index] = value; } else { // Since some browsers preemptively terminate slow turns but // then continue computing with presumably corrupted heap // state, we here defensively get keys.length first and then // use it to update both the values and keys arrays, keeping // them in sync. index = keys.length; values[index] = value; // If we crash here, values will be one longer than keys. keys[index] = key; } } return this; } function delete___(key) { var hiddenRecord = getHiddenRecord(key); var index, lastIndex; if (hiddenRecord) { return id in hiddenRecord && delete hiddenRecord[id]; } else { index = keys.indexOf(key); if (index < 0) { return false; } // Since some browsers preemptively terminate slow turns but // then continue computing with potentially corrupted heap // state, we here defensively get keys.length first and then use // it to update both the keys and the values array, keeping // them in sync. We update the two with an order of assignments, // such that any prefix of these assignments will preserve the // key/value correspondence, either before or after the delete. // Note that this needs to work correctly when index === lastIndex. lastIndex = keys.length - 1; keys[index] = void 0; // If we crash here, there's a void 0 in the keys array, but // no operation will cause a "keys.indexOf(void 0)", since // getHiddenRecord(void 0) will always throw an error first. values[index] = values[lastIndex]; // If we crash here, values[index] cannot be found here, // because keys[index] is void 0. keys[index] = keys[lastIndex]; // If index === lastIndex and we crash here, then keys[index] // is still void 0, since the aliasing killed the previous key. keys.length = lastIndex; // If we crash here, keys will be one shorter than values. values.length = lastIndex; return true; } } return Object.create(OurWeakMap.prototype, { get___: { value: constFunc(get___) }, has___: { value: constFunc(has___) }, set___: { value: constFunc(set___) }, delete___: { value: constFunc(delete___) } }); }; OurWeakMap.prototype = Object.create(Object.prototype, { get: { /** * Return the value most recently associated with key, or * opt_default if none. */ value: function get(key, opt_default) { return this.get___(key, opt_default); }, writable: true, configurable: true }, has: { /** * Is there a value associated with key in this WeakMap? */ value: function has(key) { return this.has___(key); }, writable: true, configurable: true }, set: { /** * Associate value with key in this WeakMap, overwriting any * previous association if present. */ value: function set(key, value) { return this.set___(key, value); }, writable: true, configurable: true }, 'delete': { /** * Remove any association for key in this WeakMap, returning * whether there was one. * *

Note that the boolean return here does not work like the * {@code delete} operator. The {@code delete} operator returns * whether the deletion succeeds at bringing about a state in * which the deleted property is absent. The {@code delete} * operator therefore returns true if the property was already * absent, whereas this {@code delete} method returns false if * the association was already absent. */ value: function remove(key) { return this.delete___(key); }, writable: true, configurable: true } }); if (typeof HostWeakMap === 'function') { (function() { // If we got here, then the platform has a WeakMap but we are concerned // that it may refuse to store some key types. Therefore, make a map // implementation which makes use of both as possible. // In this mode we are always using double maps, so we are not proxy-safe. // This combination does not occur in any known browser, but we had best // be safe. if (doubleWeakMapCheckSilentFailure && typeof Proxy !== 'undefined') { Proxy = undefined; } function DoubleWeakMap() { if (!(this instanceof OurWeakMap)) { // approximate test for new ...() calledAsFunctionWarning(); } // Preferable, truly weak map. var hmap = new HostWeakMap(); // Our hidden-property-based pseudo-weak-map. Lazily initialized in the // 'set' implementation; thus we can avoid performing extra lookups if // we know all entries actually stored are entered in 'hmap'. var omap = undefined; // Hidden-property maps are not compatible with proxies because proxies // can observe the hidden name and either accidentally expose it or fail // to allow the hidden property to be set. Therefore, we do not allow // arbitrary WeakMaps to switch to using hidden properties, but only // those which need the ability, and unprivileged code is not allowed // to set the flag. // // (Except in doubleWeakMapCheckSilentFailure mode in which case we // disable proxies.) var enableSwitching = false; function dget(key, opt_default) { if (omap) { return hmap.has(key) ? hmap.get(key) : omap.get___(key, opt_default); } else { return hmap.get(key, opt_default); } } function dhas(key) { return hmap.has(key) || (omap ? omap.has___(key) : false); } var dset; if (doubleWeakMapCheckSilentFailure) { dset = function(key, value) { hmap.set(key, value); if (!hmap.has(key)) { if (!omap) { omap = new OurWeakMap(); } omap.set(key, value); } return this; }; } else { dset = function(key, value) { if (enableSwitching) { try { hmap.set(key, value); } catch (e) { if (!omap) { omap = new OurWeakMap(); } omap.set___(key, value); } } else { hmap.set(key, value); } return this; }; } function ddelete(key) { var result = !!hmap['delete'](key); if (omap) { return omap.delete___(key) || result; } return result; } return Object.create(OurWeakMap.prototype, { get___: { value: constFunc(dget) }, has___: { value: constFunc(dhas) }, set___: { value: constFunc(dset) }, delete___: { value: constFunc(ddelete) }, permitHostObjects___: { value: constFunc(function(token) { if (token === weakMapPermitHostObjects) { enableSwitching = true; } else { throw new Error('bogus call to permitHostObjects___'); } })} }); } DoubleWeakMap.prototype = OurWeakMap.prototype; module.exports = DoubleWeakMap; // define .constructor to hide OurWeakMap ctor Object.defineProperty(WeakMap.prototype, 'constructor', { value: WeakMap, enumerable: false, // as default .constructor is configurable: true, writable: true }); })(); } else { // There is no host WeakMap, so we must use the emulation. // Emulated WeakMaps are incompatible with native proxies (because proxies // can observe the hidden name), so we must disable Proxy usage (in // ArrayLike and Domado, currently). if (typeof Proxy !== 'undefined') { Proxy = undefined; } module.exports = OurWeakMap; } })(); },{}],126:[function(require,module,exports){ 'use strict' var weakMap = typeof WeakMap === 'undefined' ? require('weak-map') : WeakMap var createBuffer = require('gl-buffer') var createVAO = require('gl-vao') var TriangleCache = new weakMap() function createABigTriangle(gl) { var triangleVAO = TriangleCache.get(gl) if(!triangleVAO || !gl.isBuffer(triangleVAO._triangleBuffer.buffer)) { var buf = createBuffer(gl, new Float32Array([-1, -1, -1, 4, 4, -1])) triangleVAO = createVAO(gl, [ { buffer: buf, type: gl.FLOAT, size: 2 } ]) triangleVAO._triangleBuffer = buf TriangleCache.set(gl, triangleVAO) } triangleVAO.bind() gl.drawArrays(gl.TRIANGLES, 0, 3) triangleVAO.unbind() } module.exports = createABigTriangle },{"gl-buffer":75,"gl-vao":189,"weak-map":125}],127:[function(require,module,exports){ 'use strict' module.exports = createAxes var createText = require('./lib/text.js') var createLines = require('./lib/lines.js') var createBackground = require('./lib/background.js') var getCubeProperties = require('./lib/cube.js') var Ticks = require('./lib/ticks.js') var identity = new Float32Array([ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1]) function copyVec3(a, b) { a[0] = b[0] a[1] = b[1] a[2] = b[2] return a } function Axes(gl) { this.gl = gl this.pixelRatio = 1 this.bounds = [ [-10, -10, -10], [ 10, 10, 10] ] this.ticks = [ [], [], [] ] this.autoTicks = true this.tickSpacing = [ 1, 1, 1 ] this.tickEnable = [ true, true, true ] this.tickFont = [ 'sans-serif', 'sans-serif', 'sans-serif' ] this.tickSize = [ 12, 12, 12 ] this.tickAngle = [ 0, 0, 0 ] this.tickColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ] this.tickPad = [ 10, 10, 10 ] this.lastCubeProps = { cubeEdges: [0,0,0], axis: [0,0,0] } this.labels = [ 'x', 'y', 'z' ] this.labelEnable = [ true, true, true ] this.labelFont = 'sans-serif' this.labelSize = [ 20, 20, 20 ] this.labelAngle = [ 0, 0, 0 ] this.labelColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ] this.labelPad = [ 10, 10, 10 ] this.lineEnable = [ true, true, true ] this.lineMirror = [ false, false, false ] this.lineWidth = [ 1, 1, 1 ] this.lineColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ] this.lineTickEnable = [ true, true, true ] this.lineTickMirror = [ false, false, false ] this.lineTickLength = [ 0, 0, 0 ] this.lineTickWidth = [ 1, 1, 1 ] this.lineTickColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ] this.gridEnable = [ true, true, true ] this.gridWidth = [ 1, 1, 1 ] this.gridColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ] this.zeroEnable = [ true, true, true ] this.zeroLineColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ] this.zeroLineWidth = [ 2, 2, 2 ] this.backgroundEnable = [ false, false, false ] this.backgroundColor = [ [0.8, 0.8, 0.8, 0.5], [0.8, 0.8, 0.8, 0.5], [0.8, 0.8, 0.8, 0.5] ] this._firstInit = true this._text = null this._lines = null this._background = createBackground(gl) } var proto = Axes.prototype proto.update = function(options) { options = options || {} //Option parsing helper functions function parseOption(nest, cons, name) { if(name in options) { var opt = options[name] var prev = this[name] var next if(nest ? (Array.isArray(opt) && Array.isArray(opt[0])) : Array.isArray(opt) ) { this[name] = next = [ cons(opt[0]), cons(opt[1]), cons(opt[2]) ] } else { this[name] = next = [ cons(opt), cons(opt), cons(opt) ] } for(var i=0; i<3; ++i) { if(next[i] !== prev[i]) { return true } } } return false } var NUMBER = parseOption.bind(this, false, Number) var BOOLEAN = parseOption.bind(this, false, Boolean) var STRING = parseOption.bind(this, false, String) var COLOR = parseOption.bind(this, true, function(v) { if(Array.isArray(v)) { if(v.length === 3) { return [ +v[0], +v[1], +v[2], 1.0 ] } else if(v.length === 4) { return [ +v[0], +v[1], +v[2], +v[3] ] } } return [ 0, 0, 0, 1 ] }) //Tick marks and bounds var nextTicks var ticksUpdate = false var boundsChanged = false if('bounds' in options) { var bounds = options.bounds i_loop: for(var i=0; i<2; ++i) { for(var j=0; j<3; ++j) { if(bounds[i][j] !== this.bounds[i][j]) { boundsChanged = true } this.bounds[i][j] = bounds[i][j] } } } if('ticks' in options) { nextTicks = options.ticks ticksUpdate = true this.autoTicks = false for(var i=0; i<3; ++i) { this.tickSpacing[i] = 0.0 } } else if(NUMBER('tickSpacing')) { this.autoTicks = true boundsChanged = true } if(this._firstInit) { if(!('ticks' in options || 'tickSpacing' in options)) { this.autoTicks = true } //Force tick recomputation on first update boundsChanged = true ticksUpdate = true this._firstInit = false } if(boundsChanged && this.autoTicks) { nextTicks = Ticks.create(this.bounds, this.tickSpacing) ticksUpdate = true } //Compare next ticks to previous ticks, only update if needed if(ticksUpdate) { for(var i=0; i<3; ++i) { nextTicks[i].sort(function(a,b) { return a.x-b.x }) } if(Ticks.equal(nextTicks, this.ticks)) { ticksUpdate = false } else { this.ticks = nextTicks } } //Parse tick properties BOOLEAN('tickEnable') if(STRING('tickFont')) { ticksUpdate = true //If font changes, must rebuild vbo } NUMBER('tickSize') NUMBER('tickAngle') NUMBER('tickPad') COLOR('tickColor') //Axis labels var labelUpdate = STRING('labels') if(STRING('labelFont')) { labelUpdate = true } BOOLEAN('labelEnable') NUMBER('labelSize') NUMBER('labelPad') COLOR('labelColor') //Axis lines BOOLEAN('lineEnable') BOOLEAN('lineMirror') NUMBER('lineWidth') COLOR('lineColor') //Axis line ticks BOOLEAN('lineTickEnable') BOOLEAN('lineTickMirror') NUMBER('lineTickLength') NUMBER('lineTickWidth') COLOR('lineTickColor') //Grid lines BOOLEAN('gridEnable') NUMBER('gridWidth') COLOR('gridColor') //Zero line BOOLEAN('zeroEnable') COLOR('zeroLineColor') NUMBER('zeroLineWidth') //Background BOOLEAN('backgroundEnable') COLOR('backgroundColor') //Update text if necessary if(!this._text) { this._text = createText( this.gl, this.bounds, this.labels, this.labelFont, this.ticks, this.tickFont) } else if(this._text && (labelUpdate || ticksUpdate)) { this._text.update( this.bounds, this.labels, this.labelFont, this.ticks, this.tickFont) } //Update lines if necessary if(this._lines && ticksUpdate) { this._lines.dispose() this._lines = null } if(!this._lines) { this._lines = createLines(this.gl, this.bounds, this.ticks) } } function OffsetInfo() { this.primalOffset = [0,0,0] this.primalMinor = [0,0,0] this.mirrorOffset = [0,0,0] this.mirrorMinor = [0,0,0] } var LINE_OFFSET = [ new OffsetInfo(), new OffsetInfo(), new OffsetInfo() ] function computeLineOffset(result, i, bounds, cubeEdges, cubeAxis) { var primalOffset = result.primalOffset var primalMinor = result.primalMinor var dualOffset = result.mirrorOffset var dualMinor = result.mirrorMinor var e = cubeEdges[i] //Calculate offsets for(var j=0; j<3; ++j) { if(i === j) { continue } var a = primalOffset, b = dualOffset, c = primalMinor, d = dualMinor if(e & (1< 0) { c[j] = -1 d[j] = 0 } else { c[j] = 0 d[j] = +1 } } } var CUBE_ENABLE = [0,0,0] var DEFAULT_PARAMS = { model: identity, view: identity, projection: identity } proto.isOpaque = function() { return true } proto.isTransparent = function() { return false } proto.drawTransparent = function(params) {} var PRIMAL_MINOR = [0,0,0] var MIRROR_MINOR = [0,0,0] var PRIMAL_OFFSET = [0,0,0] proto.draw = function(params) { params = params || DEFAULT_PARAMS var gl = this.gl //Geometry for camera and axes var model = params.model || identity var view = params.view || identity var projection = params.projection || identity var bounds = this.bounds //Unpack axis info var cubeParams = getCubeProperties(model, view, projection, bounds) var cubeEdges = cubeParams.cubeEdges var cubeAxis = cubeParams.axis var cx = view[12] var cy = view[13] var cz = view[14] var cw = view[15] var pixelScaleF = this.pixelRatio * (projection[3]*cx + projection[7]*cy + projection[11]*cz + projection[15]*cw) / gl.drawingBufferHeight for(var i=0; i<3; ++i) { this.lastCubeProps.cubeEdges[i] = cubeEdges[i] this.lastCubeProps.axis[i] = cubeAxis[i] } //Compute axis info var lineOffset = LINE_OFFSET for(var i=0; i<3; ++i) { computeLineOffset( LINE_OFFSET[i], i, this.bounds, cubeEdges, cubeAxis) } //Set up state parameters var gl = this.gl //Draw background first var cubeEnable = CUBE_ENABLE for(var i=0; i<3; ++i) { if(this.backgroundEnable[i]) { cubeEnable[i] = cubeAxis[i] } else { cubeEnable[i] = 0 } } this._background.draw( model, view, projection, bounds, cubeEnable, this.backgroundColor) //Draw lines this._lines.bind( model, view, projection, this) //First draw grid lines and zero lines for(var i=0; i<3; ++i) { var x = [0,0,0] if(cubeAxis[i] > 0) { x[i] = bounds[1][i] } else { x[i] = bounds[0][i] } //Draw grid lines for(var j=0; j<2; ++j) { var u = (i + 1 + j) % 3 var v = (i + 1 + (j^1)) % 3 if(this.gridEnable[u]) { this._lines.drawGrid(u, v, this.bounds, x, this.gridColor[u], this.gridWidth[u]*this.pixelRatio) } } //Draw zero lines (need to do this AFTER all grid lines are drawn) for(var j=0; j<2; ++j) { var u = (i + 1 + j) % 3 var v = (i + 1 + (j^1)) % 3 if(this.zeroEnable[v]) { //Check if zero line in bounds if(bounds[0][v] <= 0 && bounds[1][v] >= 0) { this._lines.drawZero(u, v, this.bounds, x, this.zeroLineColor[v], this.zeroLineWidth[v]*this.pixelRatio) } } } } //Then draw axis lines and tick marks for(var i=0; i<3; ++i) { //Draw axis lines if(this.lineEnable[i]) { this._lines.drawAxisLine(i, this.bounds, lineOffset[i].primalOffset, this.lineColor[i], this.lineWidth[i]*this.pixelRatio) } if(this.lineMirror[i]) { this._lines.drawAxisLine(i, this.bounds, lineOffset[i].mirrorOffset, this.lineColor[i], this.lineWidth[i]*this.pixelRatio) } //Compute minor axes var primalMinor = copyVec3(PRIMAL_MINOR, lineOffset[i].primalMinor) var mirrorMinor = copyVec3(MIRROR_MINOR, lineOffset[i].mirrorMinor) var tickLength = this.lineTickLength var op = 0 for(var j=0; j<3; ++j) { var scaleFactor = pixelScaleF / model[5*j] primalMinor[j] *= tickLength[j] * scaleFactor mirrorMinor[j] *= tickLength[j] * scaleFactor } //Draw axis line ticks if(this.lineTickEnable[i]) { this._lines.drawAxisTicks(i, lineOffset[i].primalOffset, primalMinor, this.lineTickColor[i], this.lineTickWidth[i]*this.pixelRatio) } if(this.lineTickMirror[i]) { this._lines.drawAxisTicks(i, lineOffset[i].mirrorOffset, mirrorMinor, this.lineTickColor[i], this.lineTickWidth[i]*this.pixelRatio) } } //Draw text sprites this._text.bind( model, view, projection, this.pixelRatio) for(var i=0; i<3; ++i) { var minor = lineOffset[i].primalMinor var offset = copyVec3(PRIMAL_OFFSET, lineOffset[i].primalOffset) for(var j=0; j<3; ++j) { if(this.lineTickEnable[i]) { offset[j] += pixelScaleF * minor[j] * Math.max(this.lineTickLength[j], 0) / model[5*j] } } //Draw tick text if(this.tickEnable[i]) { //Add tick padding for(var j=0; j<3; ++j) { offset[j] += pixelScaleF * minor[j] * this.tickPad[j] / model[5*j] } //Draw axis this._text.drawTicks( i, this.tickSize[i], this.tickAngle[i], offset, this.tickColor[i]) } //Draw labels if(this.labelEnable[i]) { //Add label padding for(var j=0; j<3; ++j) { offset[j] += pixelScaleF * minor[j] * this.labelPad[j] / model[5*j] } offset[i] += 0.5 * (bounds[0][i] + bounds[1][i]) //Draw axis this._text.drawLabel( i, this.labelSize[i], this.labelAngle[i], offset, this.labelColor[i]) } } } proto.dispose = function() { this._text.dispose() this._lines.dispose() this._background.dispose() this._lines = null this._text = null this._background = null this.gl = null } function createAxes(gl, options) { var axes = new Axes(gl) axes.update(options) return axes } },{"./lib/background.js":128,"./lib/cube.js":129,"./lib/lines.js":130,"./lib/text.js":132,"./lib/ticks.js":133}],128:[function(require,module,exports){ 'use strict' module.exports = createBackgroundCube var createBuffer = require('gl-buffer') var createVAO = require('gl-vao') var createShader = require('./shaders').bg function BackgroundCube(gl, buffer, vao, shader) { this.gl = gl this.buffer = buffer this.vao = vao this.shader = shader } var proto = BackgroundCube.prototype proto.draw = function(model, view, projection, bounds, enable, colors) { var needsBG = false for(var i=0; i<3; ++i) { needsBG = needsBG || enable[i] } if(!needsBG) { return } var gl = this.gl gl.enable(gl.POLYGON_OFFSET_FILL) gl.polygonOffset(1, 2) this.shader.bind() this.shader.uniforms = { model: model, view: view, projection: projection, bounds: bounds, enable: enable, colors: colors } this.vao.bind() this.vao.draw(this.gl.TRIANGLES, 36) gl.disable(gl.POLYGON_OFFSET_FILL) } proto.dispose = function() { this.vao.dispose() this.buffer.dispose() this.shader.dispose() } function createBackgroundCube(gl) { //Create cube vertices var vertices = [] var indices = [] var ptr = 0 for(var d=0; d<3; ++d) { var u = (d+1) % 3 var v = (d+2) % 3 var x = [0,0,0] var c = [0,0,0] for(var s=-1; s<=1; s+=2) { indices.push(ptr, ptr+2, ptr+1, ptr+1, ptr+2, ptr+3) x[d] = s c[d] = s for(var i=-1; i<=1; i+=2) { x[u] = i for(var j=-1; j<=1; j+=2) { x[v] = j vertices.push(x[0], x[1], x[2], c[0], c[1], c[2]) ptr += 1 } } //Swap u and v var tt = u u = v v = tt } } //Allocate buffer and vertex array var buffer = createBuffer(gl, new Float32Array(vertices)) var elements = createBuffer(gl, new Uint16Array(indices), gl.ELEMENT_ARRAY_BUFFER) var vao = createVAO(gl, [ { buffer: buffer, type: gl.FLOAT, size: 3, offset: 0, stride: 24 }, { buffer: buffer, type: gl.FLOAT, size: 3, offset: 12, stride: 24 } ], elements) //Create shader object var shader = createShader(gl) shader.attributes.position.location = 0 shader.attributes.normal.location = 1 return new BackgroundCube(gl, buffer, vao, shader) } },{"./shaders":131,"gl-buffer":75,"gl-vao":189}],129:[function(require,module,exports){ "use strict" module.exports = getCubeEdges var bits = require('bit-twiddle') var multiply = require('gl-mat4/multiply') var invert = require('gl-mat4/invert') var splitPoly = require('split-polygon') var orient = require('robust-orientation') var mvp = new Array(16) var imvp = new Array(16) var pCubeVerts = new Array(8) var cubeVerts = new Array(8) var x = new Array(3) var zero3 = [0,0,0] ;(function() { for(var i=0; i<8; ++i) { pCubeVerts[i] =[1,1,1,1] cubeVerts[i] = [1,1,1] } })() function transformHg(result, x, mat) { for(var i=0; i<4; ++i) { result[i] = mat[12+i] for(var j=0; j<3; ++j) { result[i] += x[j]*mat[4*j+i] } } } var FRUSTUM_PLANES = [ [ 0, 0, 1, 0, 0], [ 0, 0,-1, 1, 0], [ 0,-1, 0, 1, 0], [ 0, 1, 0, 1, 0], [-1, 0, 0, 1, 0], [ 1, 0, 0, 1, 0] ] function polygonArea(p) { for(var i=0; i o0) { closest |= 1< o0) { closest |= 1< cubeVerts[i][1]) { bottom = i } } //Find left/right neighbors of bottom vertex var left = -1 for(var i=0; i<3; ++i) { var idx = bottom ^ (1< cubeVerts[right][0]) { right = idx } } //Determine edge axis coordinates var cubeEdges = CUBE_EDGES cubeEdges[0] = cubeEdges[1] = cubeEdges[2] = 0 cubeEdges[bits.log2(left^bottom)] = bottom&left cubeEdges[bits.log2(bottom^right)] = bottom&right var top = right ^ 7 if(top === closest || top === farthest) { top = left ^ 7 cubeEdges[bits.log2(right^top)] = top&right } else { cubeEdges[bits.log2(left^top)] = top&left } //Determine visible faces var axis = CUBE_AXIS var cutCorner = closest for(var d=0; d<3; ++d) { if(cutCorner & (1<=0; --j) { var p = positions[c[j]] data.push(scale*p[0], -scale*p[1], t) } } } //Generate sprites for all 3 axes, store data in texture atlases var tickOffset = [0,0,0] var tickCount = [0,0,0] var labelOffset = [0,0,0] var labelCount = [0,0,0] for(var d=0; d<3; ++d) { //Generate label labelOffset[d] = (data.length/VERTEX_SIZE)|0 addItem(0.5*(bounds[0][d]+bounds[1][d]), labels[d], labelFont) labelCount[d] = ((data.length/VERTEX_SIZE)|0) - labelOffset[d] //Generate sprites for tick marks tickOffset[d] = (data.length/VERTEX_SIZE)|0 for(var i=0; i= 0) { sigFigs = stepStr.length - u - 1 } var shift = Math.pow(10, sigFigs) var x = Math.round(spacing * i * shift) var xstr = x + "" if(xstr.indexOf("e") >= 0) { return xstr } var xi = x / shift, xf = x % shift if(x < 0) { xi = -Math.ceil(xi)|0 xf = (-xf)|0 } else { xi = Math.floor(xi)|0 xf = xf|0 } var xis = "" + xi if(x < 0) { xis = "-" + xis } if(sigFigs) { var xs = "" + xf while(xs.length < sigFigs) { xs = "0" + xs } return xis + "." + xs } else { return xis } } function defaultTicks(bounds, tickSpacing) { var array = [] for(var d=0; d<3; ++d) { var ticks = [] var m = 0.5*(bounds[0][d]+bounds[1][d]) for(var t=0; t*tickSpacing[d]<=bounds[1][d]; ++t) { ticks.push({x: t*tickSpacing[d], text: prettyPrint(tickSpacing[d], t)}) } for(var t=-1; t*tickSpacing[d]>=bounds[0][d]; --t) { ticks.push({x: t*tickSpacing[d], text: prettyPrint(tickSpacing[d], t)}) } array.push(ticks) } return array } function ticksEqual(ticksA, ticksB) { for(var i=0; i<3; ++i) { if(ticksA[i].length !== ticksB[i].length) { return false } for(var j=0; j 1.0) { t = 1.0 } var ti = 1.0 - t var n = a.length var r = new Array(n) for(var i=0; i 0) || (a > 0 && b < 0)) { var p = lerpW(s, b, t, a) pos.push(p) neg.push(p.slice()) } if(b < 0) { neg.push(t.slice()) } else if(b > 0) { pos.push(t.slice()) } else { pos.push(t.slice()) neg.push(t.slice()) } a = b } return { positive: pos, negative: neg } } function positive(points, plane) { var pos = [] var a = planeT(points[points.length-1], plane) for(var s=points[points.length-1], t=points[0], i=0; i 0) || (a > 0 && b < 0)) { pos.push(lerpW(s, b, t, a)) } if(b >= 0) { pos.push(t.slice()) } a = b } return pos } function negative(points, plane) { var neg = [] var a = planeT(points[points.length-1], plane) for(var s=points[points.length-1], t=points[0], i=0; i 0) || (a > 0 && b < 0)) { neg.push(lerpW(s, b, t, a)) } if(b <= 0) { neg.push(t.slice()) } a = b } return neg } },{"robust-dot-product":136,"robust-sum":217}],136:[function(require,module,exports){ "use strict" var twoProduct = require("two-product") var robustSum = require("robust-sum") module.exports = robustDotProduct function robustDotProduct(a, b) { var r = twoProduct(a[0], b[0]) for(var i=1; i 0) { var base = Math.round(Math.pow(10, y)) return Math.ceil(x/base) * base } return Math.ceil(x) } function defaultBool(x) { if(typeof x === 'boolean') { return x } return true } function createScene(options) { options = options || {} var stopped = false var pixelRatio = options.pixelRatio || parseFloat(window.devicePixelRatio) var canvas = options.canvas if(!canvas) { canvas = document.createElement('canvas') if(options.container) { var container = options.container container.appendChild(canvas) } else { document.body.appendChild(canvas) } } var gl = options.gl if(!gl) { gl = getContext(canvas, options.glOptions || { premultipliedAlpha: true, antialias: true }) } if(!gl) { throw new Error('webgl not supported') } //Initial bounds var bounds = options.bounds || [[-10,-10,-10], [10,10,10]] //Create selection var selection = new MouseSelect() //Accumulation buffer var accumBuffer = createFBO(gl, [gl.drawingBufferWidth, gl.drawingBufferHeight], { preferFloat: true }) var accumShader = createShader(gl) //Create a camera var cameraOptions = options.camera || { eye: [2,0,0], center: [0,0,0], up: [0,1,0], zoomMin: 0.1, zoomMax: 100, mode: 'turntable' } //Create axes var axesOptions = options.axes || {} var axes = createAxes(gl, axesOptions) axes.enable = !axesOptions.disable //Create spikes var spikeOptions = options.spikes || {} var spikes = createSpikes(gl, spikeOptions) //Object list is empty initially var objects = [] var pickBufferIds = [] var pickBufferCount = [] var pickBuffers = [] //Dirty flag, skip redraw if scene static var dirty = true var pickDirty = true var projection = new Array(16) var model = new Array(16) var cameraParams = { view: null, projection: projection, model: model } var pickDirty = true var viewShape = [ gl.drawingBufferWidth, gl.drawingBufferHeight ] //Create scene object var scene = { gl: gl, contextLost: false, pixelRatio: options.pixelRatio || parseFloat(window.devicePixelRatio), canvas: canvas, selection: selection, camera: createCamera(canvas, cameraOptions), axes: axes, axesPixels: null, spikes: spikes, bounds: bounds, objects: objects, shape: viewShape, aspect: options.aspectRatio || [1,1,1], pickRadius: options.pickRadius || 10, zNear: options.zNear || 0.01, zFar: options.zFar || 1000, fovy: options.fovy || Math.PI/4, clearColor: options.clearColor || [0,0,0,0], autoResize: defaultBool(options.autoResize), autoBounds: defaultBool(options.autoBounds), autoScale: !!options.autoScale, autoCenter: defaultBool(options.autoCenter), clipToBounds: defaultBool(options.clipToBounds), snapToData: !!options.snapToData, onselect: options.onselect || null, onrender: options.onrender || null, onclick: options.onclick || null, cameraParams: cameraParams, oncontextloss: null, mouseListener: null } var pickShape = [ (gl.drawingBufferWidth/scene.pixelRatio)|0, (gl.drawingBufferHeight/scene.pixelRatio)|0 ] function resizeListener() { if(stopped) { return } if(!scene.autoResize) { return } var parent = canvas.parentNode var width = 1 var height = 1 if(parent && parent !== document.body) { width = parent.clientWidth height = parent.clientHeight } else { width = window.innerWidth height = window.innerHeight } var nextWidth = Math.ceil(width * scene.pixelRatio)|0 var nextHeight = Math.ceil(height * scene.pixelRatio)|0 if(nextWidth !== canvas.width || nextHeight !== canvas.height) { canvas.width = nextWidth canvas.height = nextHeight var style = canvas.style style.position = style.position || 'absolute' style.left = '0px' style.top = '0px' style.width = width + 'px' style.height = height + 'px' dirty = true } } if(scene.autoResize) { resizeListener() } window.addEventListener('resize', resizeListener) function reallocPickIds() { var numObjs = objects.length var numPick = pickBuffers.length for(var i=0; i 0 && pickBufferCount[numPick-1] === 0) { pickBufferCount.pop() pickBuffers.pop().dispose() } } scene.update = function(options) { if(stopped) { return } options = options || {} dirty = true pickDirty = true } scene.add = function(obj) { if(stopped) { return } obj.axes = axes objects.push(obj) pickBufferIds.push(-1) dirty = true pickDirty = true reallocPickIds() } scene.remove = function(obj) { if(stopped) { return } var idx = objects.indexOf(obj) if(idx < 0) { return } objects.splice(idx, 1) pickBufferIds.pop() dirty = true pickDirty = true reallocPickIds() } scene.dispose = function() { if(stopped) { return } stopped = true window.removeEventListener('resize', resizeListener) canvas.removeEventListener('webglcontextlost', checkContextLoss) scene.mouseListener.enabled = false if(scene.contextLost) { return } //Destroy objects axes.dispose() spikes.dispose() for(var i=0; i selection.distance) { continue } for(var j=0; j>(i*8)) & 0xff) } calcScales.call(this) shader.bind() shader.uniforms.pixelScale = PIXEL_SCALE shader.uniforms.viewTransform = MATRIX shader.uniforms.pickOffset = PICK_OFFSET this.positionBuffer.bind() shader.attributes.position.pointer() this.offsetBuffer.bind() shader.attributes.offset.pointer() this.idBuffer.bind() shader.attributes.id.pointer(gl.UNSIGNED_BYTE, false) gl.drawArrays(gl.TRIANGLES, 0, numVertices) return offset + this.numPoints } })() proto.pick = function(x, y, value) { var pickOffset = this.pickOffset var pointCount = this.numPoints if(value < pickOffset || value >= pickOffset + pointCount) { return null } var pointId = value - pickOffset var points = this.points return { object: this, pointId: pointId, dataCoord: [ points[2*pointId], points[2*pointId+1] ] } } proto.update = function(options) { options = options || {} var positions = options.positions || [] var colors = options.colors || [] var glyphs = options.glyphs || [] var sizes = options.sizes || [] var borderWidths = options.borderWidths || [] var borderColors = options.borderColors || [] this.points = positions var bounds = this.bounds = [Infinity, Infinity, -Infinity, -Infinity] var numVertices = 0 for(var i=0; i> 1 for(var j=0; j<2; ++j) { bounds[j] = Math.min(bounds[j], positions[2*i+j]) bounds[2+j] = Math.max(bounds[2+j], positions[2*i+j]) } } if(bounds[0] === bounds[2]) { bounds[2] += 1 } if(bounds[3] === bounds[1]) { bounds[3] += 1 } var sx = 1/(bounds[2] - bounds[0]) var sy = 1/(bounds[3] - bounds[1]) var tx = bounds[0] var ty = bounds[1] var v_position = pool.mallocFloat32(2 * numVertices) var v_offset = pool.mallocFloat32(2 * numVertices) var v_color = pool.mallocUint8(4 * numVertices) var v_ids = pool.mallocUint32(numVertices) var ptr = 0 for(var i=0; i left) { var b_level = data_levels[j-1] var b_x = data_points[2*(j-1)] if(((b_level - a_level) || (a_x - b_x)) >= 0) { break } data_levels[j] = b_level data_points[2*j] = b_x data_points[2*j+1] = data_points[2*j-1] data_ids[j] = data_ids[j-1] data_weights[j] = data_weights[j-1] j -= 1 } data_levels[j] = a_level data_points[2*j] = a_x data_points[2*j+1] = a_y data_ids[j] = a_id data_weights[j] = a_weight } } function swap(i, j, data_levels, data_points, data_ids, data_weights) { var a_level = data_levels[i] var a_x = data_points[2*i] var a_y = data_points[2*i+1] var a_id = data_ids[i] var a_weight = data_weights[i] data_levels[i] = data_levels[j] data_points[2*i] = data_points[2*j] data_points[2*i+1] = data_points[2*j+1] data_ids[i] = data_ids[j] data_weights[i] = data_weights[j] data_levels[j] = a_level data_points[2*j] = a_x data_points[2*j+1] = a_y data_ids[j] = a_id data_weights[j] = a_weight } function move(i, j, data_levels, data_points, data_ids, data_weights) { data_levels[i] = data_levels[j] data_points[2*i] = data_points[2*j] data_points[2*i+1] = data_points[2*j+1] data_ids[i] = data_ids[j] data_weights[i] = data_weights[j] } function rotate(i, j, k, data_levels, data_points, data_ids, data_weights) { var a_level = data_levels[i] var a_x = data_points[2*i] var a_y = data_points[2*i+1] var a_id = data_ids[i] var a_weight = data_weights[i] data_levels[i] = data_levels[j] data_points[2*i] = data_points[2*j] data_points[2*i+1] = data_points[2*j+1] data_ids[i] = data_ids[j] data_weights[i] = data_weights[j] data_levels[j] = data_levels[k] data_points[2*j] = data_points[2*k] data_points[2*j+1] = data_points[2*k+1] data_ids[j] = data_ids[k] data_weights[j] = data_weights[k] data_levels[k] = a_level data_points[2*k] = a_x data_points[2*k+1] = a_y data_ids[k] = a_id data_weights[k] = a_weight } function shufflePivot( i, j, a_level, a_x, a_y, a_id, a_weight, data_levels, data_points, data_ids, data_weights) { data_levels[i] = data_levels[j] data_points[2*i] = data_points[2*j] data_points[2*i+1] = data_points[2*j+1] data_ids[i] = data_ids[j] data_weights[i] = data_weights[j] data_levels[j] = a_level data_points[2*j] = a_x data_points[2*j+1] = a_y data_ids[j] = a_id data_weights[j] = a_weight } function compare(i, j, data_levels, data_points, data_ids) { return ((data_levels[i] - data_levels[j]) || (data_points[2*j] - data_points[2*i]) || (data_ids[i] - data_ids[j])) < 0 } function comparePivot(i, level, x, y, id, data_levels, data_points, data_ids) { return ((level - data_levels[i]) || (data_points[2*i] - x) || (id - data_ids[i])) < 0 } function quickSort(left, right, data_levels, data_points, data_ids, data_weights) { var sixth = (right - left + 1) / 6 | 0, index1 = left + sixth, index5 = right - sixth, index3 = left + right >> 1, index2 = index3 - sixth, index4 = index3 + sixth, el1 = index1, el2 = index2, el3 = index3, el4 = index4, el5 = index5, less = left + 1, great = right - 1, tmp = 0 if(compare(el1, el2, data_levels, data_points, data_ids, data_weights)) { tmp = el1 el1 = el2 el2 = tmp } if(compare(el4, el5, data_levels, data_points, data_ids, data_weights)) { tmp = el4 el4 = el5 el5 = tmp } if(compare(el1, el3, data_levels, data_points, data_ids, data_weights)) { tmp = el1 el1 = el3 el3 = tmp } if(compare(el2, el3, data_levels, data_points, data_ids, data_weights)) { tmp = el2 el2 = el3 el3 = tmp } if(compare(el1, el4, data_levels, data_points, data_ids, data_weights)) { tmp = el1 el1 = el4 el4 = tmp } if(compare(el3, el4, data_levels, data_points, data_ids, data_weights)) { tmp = el3 el3 = el4 el4 = tmp } if(compare(el2, el5, data_levels, data_points, data_ids, data_weights)) { tmp = el2 el2 = el5 el5 = tmp } if(compare(el2, el3, data_levels, data_points, data_ids, data_weights)) { tmp = el2 el2 = el3 el3 = tmp } if(compare(el4, el5, data_levels, data_points, data_ids, data_weights)) { tmp = el4 el4 = el5 el5 = tmp } var pivot1_level = data_levels[el2] var pivot1_x = data_points[2*el2] var pivot1_y = data_points[2*el2+1] var pivot1_id = data_ids[el2] var pivot1_weight = data_weights[el2] var pivot2_level = data_levels[el4] var pivot2_x = data_points[2*el4] var pivot2_y = data_points[2*el4+1] var pivot2_id = data_ids[el4] var pivot2_weight = data_weights[el4] var ptr0 = el1 var ptr2 = el3 var ptr4 = el5 var ptr5 = index1 var ptr6 = index3 var ptr7 = index5 var level_x = data_levels[ptr0] var level_y = data_levels[ptr2] var level_z = data_levels[ptr4] data_levels[ptr5] = level_x data_levels[ptr6] = level_y data_levels[ptr7] = level_z for (var i1 = 0; i1 < 2; ++i1) { var x = data_points[2*ptr0+i1] var y = data_points[2*ptr2+i1] var z = data_points[2*ptr4+i1] data_points[2*ptr5+i1] = x data_points[2*ptr6+i1] = y data_points[2*ptr7+i1] = z } var id_x = data_ids[ptr0] var id_y = data_ids[ptr2] var id_z = data_ids[ptr4] data_ids[ptr5] = id_x data_ids[ptr6] = id_y data_ids[ptr7] = id_z var weight_x = data_weights[ptr0] var weight_y = data_weights[ptr2] var weight_z = data_weights[ptr4] data_weights[ptr5] = weight_x data_weights[ptr6] = weight_y data_weights[ptr7] = weight_z move(index2, left, data_levels, data_points, data_ids, data_weights) move(index4, right, data_levels, data_points, data_ids, data_weights) for (var k = less; k <= great; ++k) { if (comparePivot(k, pivot1_level, pivot1_x, pivot1_y, pivot1_id, data_levels, data_points, data_ids)) { if (k !== less) { swap(k, less, data_levels, data_points, data_ids, data_weights) } ++less; } else { if (!comparePivot(k, pivot2_level, pivot2_x, pivot2_y, pivot2_id, data_levels, data_points, data_ids)) { while (true) { if (!comparePivot(great, pivot2_level, pivot2_x, pivot2_y, pivot2_id, data_levels, data_points, data_ids)) { if (--great < k) { break; } continue; } else { if (comparePivot(great, pivot1_level, pivot1_x, pivot1_y, pivot1_id, data_levels, data_points, data_ids)) { rotate(k, less, great, data_levels, data_points, data_ids, data_weights) ++less; --great; } else { swap(k, great, data_levels, data_points, data_ids, data_weights) --great; } break; } } } } } shufflePivot(left, less-1, pivot1_level, pivot1_x, pivot1_y, pivot1_id, pivot1_weight, data_levels, data_points, data_ids, data_weights) shufflePivot(right, great+1, pivot2_level, pivot2_x, pivot2_y, pivot2_id, pivot2_weight, data_levels, data_points, data_ids, data_weights) if (less - 2 - left <= INSERT_SORT_CUTOFF) { insertionSort(left, less - 2, data_levels, data_points, data_ids, data_weights) } else { quickSort(left, less - 2, data_levels, data_points, data_ids, data_weights) } if (right - (great + 2) <= INSERT_SORT_CUTOFF) { insertionSort(great + 2, right, data_levels, data_points, data_ids, data_weights) } else { quickSort(great + 2, right, data_levels, data_points, data_ids, data_weights) } if (great - less <= INSERT_SORT_CUTOFF) { insertionSort(less, great, data_levels, data_points, data_ids, data_weights) } else { quickSort(less, great, data_levels, data_points, data_ids, data_weights) } } },{}],146:[function(require,module,exports){ 'use strict' var pool = require('typedarray-pool') var sortLevels = require('./lib/sort') module.exports = snapPoints function partition(points, ids, start, end, lox, loy, hix, hiy) { var mid = start for(var i=start; i>> 1 if(n < 1) { return [] } var lox = Infinity, loy = Infinity var hix = -Infinity, hiy = -Infinity for(var i=0; i= Math.max(0.9 * count, 32)) { var mid = (end + start)>>>1 snapRec(nx, ny, diam_2, offset, mid, level+1) offset = mid } snapRec(nx, ny, diam_2, offset, nextOffset, level+1) offset = nextOffset } } } snapRec(lox, loy, diam, 0, n, 0) sortLevels(levels, points, ids, weights, n) var lod = [] var lastLevel = 0 var prevOffset = n for(var ptr=n-1; ptr>=0; --ptr) { points[2*ptr] = (points[2*ptr] - lox) * scaleX points[2*ptr+1] = (points[2*ptr+1] - loy) * scaleY var level = levels[ptr] if(level === lastLevel) { continue } lod.push(new SnapInterval( diam * Math.pow(0.5, level), ptr+1, prevOffset - (ptr+1) )) prevOffset = ptr+1 lastLevel = level } lod.push(new SnapInterval(diam * Math.pow(0.5, level+1), 0, prevOffset)) pool.free(levels) return lod } },{"./lib/sort":145,"typedarray-pool":233}],147:[function(require,module,exports){ 'use strict' var createShader = require('gl-shader') var createBuffer = require('gl-buffer') var bsearch = require('binary-search-bounds') var snapPoints = require('snap-points-2d') var pool = require('typedarray-pool') var SHADERS = require('./lib/shader') module.exports = createScatter2D function Scatter2D(plot, offsetBuffer, pickBuffer, weightBuffer, shader, pickShader) { this.plot = plot this.offsetBuffer = offsetBuffer this.pickBuffer = pickBuffer this.weightBuffer = weightBuffer this.shader = shader this.pickShader = pickShader this.scales = [] this.size = 12.0 this.borderSize = 1.0 this.pointCount = 0 this.color = [1,0,0,1] this.borderColor = [0,0,0,1] this.bounds = [Infinity,Infinity,-Infinity,-Infinity] this.pickOffset = 0 this.points = null this.xCoords = null } var proto = Scatter2D.prototype proto.dispose = function() { this.shader.dispose() this.pickShader.dispose() this.offsetBuffer.dispose() this.pickBuffer.dispose() if(this.xCoords) { pool.free(this.xCoords) } this.plot.removeObject(this) } proto.update = function(options) { options = options || {} function dflt(opt, value) { if(opt in options) { return options[opt] } return value } this.size = dflt('size', 12.0) this.color = dflt('color', [1,0,0,1]).slice() this.borderSize = dflt('borderSize', 1) this.borderColor = dflt('borderColor', [0,0,0,1]).slice() //Update point data if(this.xCoords) { pool.free(this.xCoords) } var data = options.positions var packed = pool.mallocFloat32(data.length) var packedId = pool.mallocInt32(data.length>>>1) packed.set(data) var packedW = pool.mallocFloat32(data.length) this.points = data this.scales = snapPoints(packed, packedId, packedW, this.bounds) this.offsetBuffer.update(packed) this.pickBuffer.update(packedId) this.weightBuffer.update(packedW) var xCoords = pool.mallocFloat32(data.length>>>1) for(var i=0,j=0; i>> 1 this.pickOffset = 0 } proto.drawPick = (function() { var MATRIX = [1,0,0, 0,1,0, 0,0,1] var PICK_VEC4 = [0,0,0,0] return function(pickOffset) { var plot = this.plot var shader = this.pickShader var scales = this.scales var offsetBuffer = this.offsetBuffer var pickBuffer = this.pickBuffer var bounds = this.bounds var size = this.size var borderSize = this.borderSize var gl = plot.gl var pixelRatio = plot.pickPixelRatio var viewBox = plot.viewBox var dataBox = plot.dataBox if(this.pointCount === 0) { return pickOffset } var boundX = bounds[2] - bounds[0] var boundY = bounds[3] - bounds[1] var dataX = dataBox[2] - dataBox[0] var dataY = dataBox[3] - dataBox[1] var screenX = (viewBox[2] - viewBox[0]) * pixelRatio / plot.pixelRatio var screenY = (viewBox[3] - viewBox[1]) * pixelRatio / plot.pixelRatio var pixelSize = Math.min(dataX / screenX, dataY / screenY) var targetScale = pixelSize MATRIX[0] = 2.0 * boundX / dataX MATRIX[4] = 2.0 * boundY / dataY MATRIX[6] = 2.0 * (bounds[0] - dataBox[0]) / dataX - 1.0 MATRIX[7] = 2.0 * (bounds[1] - dataBox[1]) / dataY - 1.0 this.pickOffset = pickOffset PICK_VEC4[0] = ( pickOffset & 0xff) PICK_VEC4[1] = ((pickOffset>>8) & 0xff) PICK_VEC4[2] = ((pickOffset>>16) & 0xff) PICK_VEC4[3] = ((pickOffset>>24) & 0xff) shader.bind() shader.uniforms.matrix = MATRIX shader.uniforms.color = this.color shader.uniforms.borderColor = this.borderColor shader.uniforms.pointSize = pixelRatio * (size + borderSize) shader.uniforms.pickOffset = PICK_VEC4 if(this.borderSize === 0) { shader.uniforms.centerFraction = 2.0; } else { shader.uniforms.centerFraction = size / (size + borderSize + 1.25) } offsetBuffer.bind() shader.attributes.position.pointer() pickBuffer.bind() shader.attributes.pickId.pointer(gl.UNSIGNED_BYTE) var xCoords = this.xCoords var xStart = (dataBox[0] - bounds[0] - pixelSize * size * pixelRatio) / boundX var xEnd = (dataBox[2] - bounds[0] + pixelSize * size * pixelRatio) / boundX for(var scaleNum = scales.length-1; scaleNum >= 0; --scaleNum) { var lod = scales[scaleNum] if(lod.pixelSize < pixelSize && scaleNum > 1) { continue } var intervalStart = lod.offset var intervalEnd = lod.count + intervalStart var startOffset = bsearch.ge(xCoords, xStart, intervalStart, intervalEnd-1) var endOffset = bsearch.lt(xCoords, xEnd, startOffset, intervalEnd-1)+1 gl.drawArrays(gl.POINTS, startOffset, endOffset - startOffset) } return pickOffset + this.pointCount } })() proto.draw = (function() { var MATRIX = [1, 0, 0, 0, 1, 0, 0, 0, 1] return function() { var plot = this.plot var shader = this.shader var scales = this.scales var offsetBuffer = this.offsetBuffer var bounds = this.bounds var size = this.size var borderSize = this.borderSize var gl = plot.gl var pixelRatio = plot.pixelRatio var viewBox = plot.viewBox var dataBox = plot.dataBox if(this.pointCount === 0) { return } var boundX = bounds[2] - bounds[0] var boundY = bounds[3] - bounds[1] var dataX = dataBox[2] - dataBox[0] var dataY = dataBox[3] - dataBox[1] var screenX = viewBox[2] - viewBox[0] var screenY = viewBox[3] - viewBox[1] var pixelSize = Math.min(dataX / screenX, dataY / screenY) var targetScale = pixelSize MATRIX[0] = 2.0 * boundX / dataX MATRIX[4] = 2.0 * boundY / dataY MATRIX[6] = 2.0 * (bounds[0] - dataBox[0]) / dataX - 1.0 MATRIX[7] = 2.0 * (bounds[1] - dataBox[1]) / dataY - 1.0 shader.bind() shader.uniforms.matrix = MATRIX shader.uniforms.color = this.color shader.uniforms.borderColor = this.borderColor shader.uniforms.pointSize = pixelRatio * (size + borderSize) shader.uniforms.useWeight = 1 if(this.borderSize === 0) { shader.uniforms.centerFraction = 2.0; } else { shader.uniforms.centerFraction = size / (size + borderSize + 1.25) } offsetBuffer.bind() shader.attributes.position.pointer() this.weightBuffer.bind() shader.attributes.weight.pointer() var xCoords = this.xCoords var xStart = (dataBox[0] - bounds[0] - pixelSize * size * pixelRatio) / boundX var xEnd = (dataBox[2] - bounds[0] + pixelSize * size * pixelRatio) / boundX var firstLevel = true for(var scaleNum = scales.length-1; scaleNum >= 0; --scaleNum) { var lod = scales[scaleNum] if(lod.pixelSize < pixelSize && scaleNum > 1) { continue } var intervalStart = lod.offset var intervalEnd = lod.count + intervalStart var startOffset = bsearch.ge(xCoords, xStart, intervalStart, intervalEnd-1) var endOffset = bsearch.lt(xCoords, xEnd, startOffset, intervalEnd-1)+1 gl.drawArrays(gl.POINTS, startOffset, endOffset - startOffset) if(firstLevel) { firstLevel = false shader.uniforms.useWeight = 0 } } } })() proto.pick = function(x, y, value) { var pickOffset = this.pickOffset var pointCount = this.pointCount if(value < pickOffset || value >= pickOffset + pointCount) { return null } var pointId = value - pickOffset var points = this.points return { object: this, pointId: pointId, dataCoord: [ points[2*pointId], points[2*pointId+1] ] } } function createScatter2D(plot, options) { var gl = plot.gl var buffer = createBuffer(gl) var pickBuffer = createBuffer(gl) var weightBuffer = createBuffer(gl) var shader = createShader(gl, SHADERS.pointVertex, SHADERS.pointFragment) var pickShader = createShader(gl, SHADERS.pickVertex, SHADERS.pickFragment) var result = new Scatter2D( plot, buffer, pickBuffer, weightBuffer, shader, pickShader) result.update(options) //Register with plot plot.addObject(result) return result } },{"./lib/shader":143,"binary-search-bounds":144,"gl-buffer":75,"gl-shader":154,"snap-points-2d":146,"typedarray-pool":233}],148:[function(require,module,exports){ "use strict" var vectorizeText = require("vectorize-text") module.exports = getGlyph var GLYPH_CACHE = {} function getGlyph(symbol, font) { var fontCache = GLYPH_CACHE[font] if(!fontCache) { fontCache = GLYPH_CACHE[font] = {} } if(symbol in fontCache) { return fontCache[symbol] } //Get line and triangle meshes for glyph var lineSymbol = vectorizeText(symbol, { textAlign: "center", textBaseline: "middle", lineHeight: 1.0, font: font }) var triSymbol = vectorizeText(symbol, { triangles: true, textAlign: "center", textBaseline: "middle", lineHeight: 1.0, font: font }) //Calculate bounding box var bounds = [[Infinity,Infinity], [-Infinity,-Infinity]] for(var i=0; i= 1) { return true } for(var i=0; i<3; ++i) { if(this.axesProject[i] && this.projectOpacity[i] >= 1) { return true } } return false } var VIEW_SHAPE = [0,0] var U_VEC = [0,0,0] var V_VEC = [0,0,0] var MU_VEC = [0,0,0,1] var MV_VEC = [0,0,0,1] var SCRATCH_MATRIX = IDENTITY.slice() var SCRATCH_VEC = [0,0,0] var CLIP_BOUNDS = [[0,0,0], [0,0,0]] function zeroVec(a) { a[0] = a[1] = a[2] = 0 return a } function augment(hg, af) { hg[0] = af[0] hg[1] = af[1] hg[2] = af[2] hg[3] = 1 return hg } function setComponent(out, v, i, x) { out[0] = v[0] out[1] = v[1] out[2] = v[2] out[i] = x return out } function getClipBounds(bounds) { var result = CLIP_BOUNDS for(var i=0; i<2; ++i) { for(var j=0; j<3; ++j) { result[i][j] = Math.max(Math.min(bounds[i][j], 1e8), -1e8) } } return result } function drawProject(shader, points, camera, transparent, forceDraw) { var axesProject = points.axesProject var gl = points.gl var uniforms = shader.uniforms var model = camera.model || IDENTITY var view = camera.view || IDENTITY var projection = camera.projection || IDENTITY var bounds = points.axesBounds var clipBounds = getClipBounds(points.clipBounds) var cubeAxis if(points.axes) { cubeAxis = points.axes.lastCubeProps.axis } else { cubeAxis = [1,1,1] } VIEW_SHAPE[0] = 2.0/gl.drawingBufferWidth VIEW_SHAPE[1] = 2.0/gl.drawingBufferHeight shader.bind() uniforms.view = view uniforms.projection = projection uniforms.screenSize = VIEW_SHAPE uniforms.highlightId = points.highlightId uniforms.highlightScale = points.highlightScale uniforms.clipBounds = clipBounds uniforms.pickGroup = points.pickId / 255.0 uniforms.pixelRatio = points.pixelRatio for(var i=0; i<3; ++i) { if(!axesProject[i]) { continue } if((points.projectOpacity[i] < 1) !== transparent) { continue } uniforms.scale = points.projectScale[i] uniforms.opacity = points.projectOpacity[i] //Project model matrix var pmodel = SCRATCH_MATRIX for(var j=0; j<16; ++j) { pmodel[j] = 0 } for(var j=0; j<4; ++j) { pmodel[5*j] = 1 } pmodel[5*i] = 0 if(cubeAxis[i] < 0) { pmodel[12+i] = bounds[0][i] } else { pmodel[12+i] = bounds[1][i] } mat4mult(pmodel, model, pmodel) uniforms.model = pmodel //Compute initial axes var u = (i+1)%3 var v = (i+2)%3 var du = zeroVec(U_VEC) var dv = zeroVec(V_VEC) du[u] = 1 dv[v] = 1 //Align orientation relative to viewer var mdu = project(projection, view, model, augment(MU_VEC, du)) var mdv = project(projection, view, model, augment(MV_VEC, dv)) if(Math.abs(mdu[1]) > Math.abs(mdv[1])) { var tmp = mdu mdu = mdv mdv = tmp tmp = du du = dv dv = tmp var t = u u = v v = t } if(mdu[0] < 0) { du[u] = -1 } if(mdv[1] > 0) { dv[v] = -1 } var su = 0.0 var sv = 0.0 for(var j=0; j<4; ++j) { su += Math.pow(model[4*u+j], 2) sv += Math.pow(model[4*v+j], 2) } du[u] /= Math.sqrt(su) dv[v] /= Math.sqrt(sv) uniforms.axes[0] = du uniforms.axes[1] = dv //Update fragment clip bounds uniforms.fragClipBounds[0] = setComponent(SCRATCH_VEC, clipBounds[0], i, -1e8) uniforms.fragClipBounds[1] = setComponent(SCRATCH_VEC, clipBounds[1], i, 1e8) //Draw interior points.vao.draw(gl.TRIANGLES, points.vertexCount) //Draw edges if(points.lineWidth > 0) { gl.lineWidth(points.lineWidth) points.vao.draw(gl.LINES, points.lineVertexCount, points.vertexCount) } } } var NEG_INFINITY3 = [-1e8, -1e8, -1e8] var POS_INFINITY3 = [1e8, 1e8, 1e8] var CLIP_GROUP = [NEG_INFINITY3, POS_INFINITY3] function drawFull(shader, pshader, points, camera, transparent, forceDraw) { var gl = points.gl points.vao.bind() if(transparent === (points.opacity < 1) || forceDraw) { shader.bind() var uniforms = shader.uniforms uniforms.model = camera.model || IDENTITY uniforms.view = camera.view || IDENTITY uniforms.projection = camera.projection || IDENTITY VIEW_SHAPE[0] = 2.0/gl.drawingBufferWidth VIEW_SHAPE[1] = 2.0/gl.drawingBufferHeight uniforms.screenSize = VIEW_SHAPE uniforms.highlightId = points.highlightId uniforms.highlightScale = points.highlightScale uniforms.fragClipBounds = CLIP_GROUP uniforms.clipBounds = points.axes.bounds uniforms.opacity = points.opacity uniforms.pickGroup = points.pickId / 255.0 uniforms.pixelRatio = points.pixelRatio //Draw interior points.vao.draw(gl.TRIANGLES, points.vertexCount) //Draw edges if(points.lineWidth > 0) { gl.lineWidth(points.lineWidth) points.vao.draw(gl.LINES, points.lineVertexCount, points.vertexCount) } } drawProject(pshader, points, camera, transparent, forceDraw) points.vao.unbind() } proto.draw = function(camera) { var shader = this.useOrtho ? this.orthoShader : this.shader drawFull(shader, this.projectShader, this, camera, false, false) } proto.drawTransparent = function(camera) { var shader = this.useOrtho ? this.orthoShader : this.shader drawFull(shader, this.projectShader, this, camera, true, false) } proto.drawPick = function(camera) { var shader = this.useOrtho ? this.pickOrthoShader : this.pickPerspectiveShader drawFull(shader, this.pickProjectShader, this, camera, false, true) } proto.pick = function(selected) { if(!selected) { return null } if(selected.id !== this.pickId) { return null } var x = selected.value[2] + (selected.value[1]<<8) + (selected.value[0]<<16) if(x >= this.pointCount || x < 0) { return null } //Unpack result var coord = this.points[x] var result = this._selectResult result.index = x for(var i=0; i<3; ++i) { result.position[i] = result.dataCoordinate[i] = coord[i] } return result } proto.highlight = function(selection) { if(!selection) { this.highlightId = [1,1,1,1] } else { var pointId = selection.index var a0 = pointId &0xff var a1 = (pointId>>8) &0xff var a2 = (pointId>>16)&0xff this.highlightId = [a0/255.0, a1/255.0, a2/255.0, 0] } } proto.update = function(options) { options = options || {} if('perspective' in options) { this.useOrtho = !options.perspective } if('orthographic' in options) { this.useOrtho = !!options.orthographic } if('lineWidth' in options) { this.lineWidth = options.lineWidth } if('project' in options) { if(Array.isArray(options.project)) { this.axesProject = options.project } else { var v = !!options.project this.axesProject = [v,v,v] } } if('projectScale' in options) { if(Array.isArray(options.projectScale)) { this.projectScale = options.projectScale.slice() } else { var s = +options.projectScale this.projectScale = [s,s,s] } } if('projectOpacity' in options) { if(Array.isArray(options.projectOpacity)) { this.projectOpacity = options.projectOpacity.slice() } else { var s = +options.projectOpacity this.projectOpacity = [s,s,s] } } if('opacity' in options) { this.opacity = options.opacity } //Set dirty flag this.dirty = true //Create new buffers var points = options.position if(!points) { return } //Text font var font = options.font || 'normal' var alignment = options.alignment || [0,0] //Bounds var lowerBound = [ Infinity, Infinity, Infinity] var upperBound = [-Infinity,-Infinity,-Infinity] //Unpack options var glyphs = options.glyph var colors = options.color var sizes = options.size var angles = options.angle var lineColors = options.lineColor //Picking geometry var pickCounter = 0 //First do pass to compute buffer sizes var triVertexCount = 0 var lineVertexCount = 0 //Count number of points and buffer size var numPoints = points.length count_loop: for(var i=0; i 0) { textOffset[0] = -alignment[0] * (1+glyphBounds[0][0]) } //Write out inner marker var cells = glyphMesh.cells var verts = glyphMesh.positions for(var j=0; j 0) { //Draw border var w = lineWidth * pixelRatio boxes.drawBox(loX-w, loY-w, hiX+w, loY+w, borderColor) boxes.drawBox(loX-w, hiY-w, hiX+w, hiY+w, borderColor) boxes.drawBox(loX-w, loY-w, loX+w, hiY+w, borderColor) boxes.drawBox(hiX-w, loY-w, hiX+w, hiY+w, borderColor) } } proto.update = function(options) { options = options || {} this.innerFill = !!options.innerFill this.outerFill = !!options.outerFill this.innerColor = (options.innerColor || [0,0,0,0.5]).slice() this.outerColor = (options.outerColor || [0,0,0,0.5]).slice() this.borderColor = (options.borderColor || [0,0,0,1]).slice() this.borderWidth = options.borderWidth || 0 this.selectBox = (options.selectBox || this.selectBox).slice() } proto.dispose = function() { this.boxBuffer.dispose() this.boxShader.dispose() this.plot.removeOverlay(this) } function createSelectBox(plot, options) { var gl = plot.gl var buffer = createBuffer(gl, [ 0, 0, 0, 1, 1, 0, 1, 1 ]) var shader = createShader(gl, SHADERS.boxVertex, SHADERS.boxFragment) var selectBox = new SelectBox(plot, buffer, shader) selectBox.update(options) plot.addOverlay(selectBox) return selectBox } },{"./lib/shaders":151,"gl-buffer":75,"gl-shader":154}],153:[function(require,module,exports){ 'use strict' module.exports = createSelectBuffer var createFBO = require('gl-fbo') var pool = require('typedarray-pool') var ndarray = require('ndarray') var nextPow2 = require('bit-twiddle').nextPow2 var selectRange = require('cwise/lib/wrapper')({"args":["array",{"offset":[0,0,1],"array":0},{"offset":[0,0,2],"array":0},{"offset":[0,0,3],"array":0},"scalar","scalar","index"],"pre":{"body":"{this_closestD2=1e8,this_closestX=-1,this_closestY=-1}","args":[],"thisVars":["this_closestD2","this_closestX","this_closestY"],"localVars":[]},"body":{"body":"{if(255>_inline_31_arg0_||255>_inline_31_arg1_||255>_inline_31_arg2_||255>_inline_31_arg3_){var _inline_31_l=_inline_31_arg4_-_inline_31_arg6_[0],_inline_31_a=_inline_31_arg5_-_inline_31_arg6_[1],_inline_31_f=_inline_31_l*_inline_31_l+_inline_31_a*_inline_31_a;_inline_31_f this.buffer.length) { pool.free(this.buffer) var buffer = this.buffer = pool.mallocUint8(nextPow2(r*c*4)) for(var i=0; i= 0) { var size = attr.type.charAt(attr.type.length-1)|0 var locVector = new Array(size) for(var j=0; j= 0) { curLocation += 1 } attributeLocations[i] = curLocation } } //Rebuild program and recompute all uniform locations var uniformLocations = new Array(uniforms.length) function relink() { wrapper.program = shaderCache.program( gl , wrapper._vref , wrapper._fref , attributeNames , attributeLocations) for(var i=0; i= 0) { var d = type.charCodeAt(type.length-1) - 48 if(d < 2 || d > 4) { throw new GLError('', 'Invalid data type for attribute ' + name + ': ' + type) } addVectorAttribute( gl , wrapper , locs[0] , locations , d , obj , name) } else if(type.indexOf('mat') >= 0) { var d = type.charCodeAt(type.length-1) - 48 if(d < 2 || d > 4) { throw new GLError('', 'Invalid data type for attribute ' + name + ': ' + type) } addMatrixAttribute( gl , wrapper , locs , locations , d , obj , name) } else { throw new GLError('', 'Unknown data type for attribute ' + name + ': ' + type) } break } } return obj } },{"./GLError":155}],157:[function(require,module,exports){ 'use strict' var coallesceUniforms = require('./reflect') var GLError = require("./GLError") module.exports = createUniformWrapper //Binds a function and returns a value function identity(x) { var c = new Function('y', 'return function(){return y}') return c(x) } function makeVector(length, fill) { var result = new Array(length) for(var i=0; i 4) { throw new GLError('', 'Invalid data type') } switch(type.charAt(0)) { case 'b': case 'i': return 'gl.uniform' + d + 'iv(locations[' + index + '],obj' + path + ')' case 'v': return 'gl.uniform' + d + 'fv(locations[' + index + '],obj' + path + ')' default: throw new GLError('', 'Unrecognized data type for vector ' + name + ': ' + type) } } else if(type.indexOf('mat') === 0 && type.length === 4) { var d = type.charCodeAt(type.length-1) - 48 if(d < 2 || d > 4) { throw new GLError('', 'Invalid uniform dimension type for matrix ' + name + ': ' + type) } return 'gl.uniformMatrix' + d + 'fv(locations[' + index + '],false,obj' + path + ')' } else { throw new GLError('', 'Unknown uniform data type for ' + name + ': ' + type) } break } } function enumerateIndices(prefix, type) { if(typeof type !== 'object') { return [ [prefix, type] ] } var indices = [] for(var id in type) { var prop = type[id] var tprefix = prefix if(parseInt(id) + '' === id) { tprefix += '[' + id + ']' } else { tprefix += '.' + id } if(typeof prop === 'object') { indices.push.apply(indices, enumerateIndices(tprefix, prop)) } else { indices.push([tprefix, prop]) } } return indices } function makeSetter(type) { var code = [ 'return function updateProperty(obj){' ] var indices = enumerateIndices('', type) for(var i=0; i 4) { throw new GLError('', 'Invalid data type') } if(type.charAt(0) === 'b') { return makeVector(d, false) } return makeVector(d, 0) } else if(type.indexOf('mat') === 0 && type.length === 4) { var d = type.charCodeAt(type.length-1) - 48 if(d < 2 || d > 4) { throw new GLError('', 'Invalid uniform dimension type for matrix ' + name + ': ' + type) } return makeVector(d*d, 0) } else { throw new GLError('', 'Unknown uniform data type for ' + name + ': ' + type) } break } } function storeProperty(obj, prop, type) { if(typeof type === 'object') { var child = processObject(type) Object.defineProperty(obj, prop, { get: identity(child), set: makeSetter(type), enumerable: true, configurable: false }) } else { if(locations[type]) { Object.defineProperty(obj, prop, { get: makeGetter(type), set: makeSetter(type), enumerable: true, configurable: false }) } else { obj[prop] = defaultValue(uniforms[type].type) } } } function processObject(obj) { var result if(Array.isArray(obj)) { result = new Array(obj.length) for(var i=0; i 1) { if(!(x[0] in o)) { o[x[0]] = [] } o = o[x[0]] for(var k=1; k 1) { for(var j=0; j * * Copyright (c) 2014-2015, Jon Schlinkert. * Licensed under the MIT license. */ 'use strict'; var repeat = require('repeat-string'); module.exports = function padLeft(str, num, ch) { ch = typeof ch !== 'undefined' ? (ch + '') : ' '; return repeat(ch, num) + str; }; },{"repeat-string":164}],164:[function(require,module,exports){ /*! * repeat-string * * Copyright (c) 2014-2015, Jon Schlinkert. * Licensed under the MIT License. */ 'use strict'; /** * Expose `repeat` */ module.exports = repeat; /** * Repeat the given `string` the specified `number` * of times. * * **Example:** * * ```js * var repeat = require('repeat-string'); * repeat('A', 5); * //=> AAAAA * ``` * * @param {String} `string` The string to repeat * @param {Number} `number` The number of times to repeat the string * @return {String} Repeated string * @api public */ function repeat(str, num) { if (typeof str !== 'string') { throw new TypeError('repeat-string expects a string.'); } if (num === 1) return str; if (num === 2) return str + str; var max = str.length * num; if (cache !== str || typeof cache === 'undefined') { cache = str; res = ''; } while (max > res.length && num > 0) { if (num & 1) { res += str; } num >>= 1; if (!num) break; str += str; } return res.substr(0, max); } /** * Results cache */ var res = ''; var cache; },{}],165:[function(require,module,exports){ module.exports = { 0: 'NONE', 1: 'ONE', 2: 'LINE_LOOP', 3: 'LINE_STRIP', 4: 'TRIANGLES', 5: 'TRIANGLE_STRIP', 6: 'TRIANGLE_FAN', 256: 'DEPTH_BUFFER_BIT', 512: 'NEVER', 513: 'LESS', 514: 'EQUAL', 515: 'LEQUAL', 516: 'GREATER', 517: 'NOTEQUAL', 518: 'GEQUAL', 519: 'ALWAYS', 768: 'SRC_COLOR', 769: 'ONE_MINUS_SRC_COLOR', 770: 'SRC_ALPHA', 771: 'ONE_MINUS_SRC_ALPHA', 772: 'DST_ALPHA', 773: 'ONE_MINUS_DST_ALPHA', 774: 'DST_COLOR', 775: 'ONE_MINUS_DST_COLOR', 776: 'SRC_ALPHA_SATURATE', 1024: 'STENCIL_BUFFER_BIT', 1028: 'FRONT', 1029: 'BACK', 1032: 'FRONT_AND_BACK', 1280: 'INVALID_ENUM', 1281: 'INVALID_VALUE', 1282: 'INVALID_OPERATION', 1285: 'OUT_OF_MEMORY', 1286: 'INVALID_FRAMEBUFFER_OPERATION', 2304: 'CW', 2305: 'CCW', 2849: 'LINE_WIDTH', 2884: 'CULL_FACE', 2885: 'CULL_FACE_MODE', 2886: 'FRONT_FACE', 2928: 'DEPTH_RANGE', 2929: 'DEPTH_TEST', 2930: 'DEPTH_WRITEMASK', 2931: 'DEPTH_CLEAR_VALUE', 2932: 'DEPTH_FUNC', 2960: 'STENCIL_TEST', 2961: 'STENCIL_CLEAR_VALUE', 2962: 'STENCIL_FUNC', 2963: 'STENCIL_VALUE_MASK', 2964: 'STENCIL_FAIL', 2965: 'STENCIL_PASS_DEPTH_FAIL', 2966: 'STENCIL_PASS_DEPTH_PASS', 2967: 'STENCIL_REF', 2968: 'STENCIL_WRITEMASK', 2978: 'VIEWPORT', 3024: 'DITHER', 3042: 'BLEND', 3088: 'SCISSOR_BOX', 3089: 'SCISSOR_TEST', 3106: 'COLOR_CLEAR_VALUE', 3107: 'COLOR_WRITEMASK', 3317: 'UNPACK_ALIGNMENT', 3333: 'PACK_ALIGNMENT', 3379: 'MAX_TEXTURE_SIZE', 3386: 'MAX_VIEWPORT_DIMS', 3408: 'SUBPIXEL_BITS', 3410: 'RED_BITS', 3411: 'GREEN_BITS', 3412: 'BLUE_BITS', 3413: 'ALPHA_BITS', 3414: 'DEPTH_BITS', 3415: 'STENCIL_BITS', 3553: 'TEXTURE_2D', 4352: 'DONT_CARE', 4353: 'FASTEST', 4354: 'NICEST', 5120: 'BYTE', 5121: 'UNSIGNED_BYTE', 5122: 'SHORT', 5123: 'UNSIGNED_SHORT', 5124: 'INT', 5125: 'UNSIGNED_INT', 5126: 'FLOAT', 5386: 'INVERT', 5890: 'TEXTURE', 6401: 'STENCIL_INDEX', 6402: 'DEPTH_COMPONENT', 6406: 'ALPHA', 6407: 'RGB', 6408: 'RGBA', 6409: 'LUMINANCE', 6410: 'LUMINANCE_ALPHA', 7680: 'KEEP', 7681: 'REPLACE', 7682: 'INCR', 7683: 'DECR', 7936: 'VENDOR', 7937: 'RENDERER', 7938: 'VERSION', 9728: 'NEAREST', 9729: 'LINEAR', 9984: 'NEAREST_MIPMAP_NEAREST', 9985: 'LINEAR_MIPMAP_NEAREST', 9986: 'NEAREST_MIPMAP_LINEAR', 9987: 'LINEAR_MIPMAP_LINEAR', 10240: 'TEXTURE_MAG_FILTER', 10241: 'TEXTURE_MIN_FILTER', 10242: 'TEXTURE_WRAP_S', 10243: 'TEXTURE_WRAP_T', 10497: 'REPEAT', 10752: 'POLYGON_OFFSET_UNITS', 16384: 'COLOR_BUFFER_BIT', 32769: 'CONSTANT_COLOR', 32770: 'ONE_MINUS_CONSTANT_COLOR', 32771: 'CONSTANT_ALPHA', 32772: 'ONE_MINUS_CONSTANT_ALPHA', 32773: 'BLEND_COLOR', 32774: 'FUNC_ADD', 32777: 'BLEND_EQUATION_RGB', 32778: 'FUNC_SUBTRACT', 32779: 'FUNC_REVERSE_SUBTRACT', 32819: 'UNSIGNED_SHORT_4_4_4_4', 32820: 'UNSIGNED_SHORT_5_5_5_1', 32823: 'POLYGON_OFFSET_FILL', 32824: 'POLYGON_OFFSET_FACTOR', 32854: 'RGBA4', 32855: 'RGB5_A1', 32873: 'TEXTURE_BINDING_2D', 32926: 'SAMPLE_ALPHA_TO_COVERAGE', 32928: 'SAMPLE_COVERAGE', 32936: 'SAMPLE_BUFFERS', 32937: 'SAMPLES', 32938: 'SAMPLE_COVERAGE_VALUE', 32939: 'SAMPLE_COVERAGE_INVERT', 32968: 'BLEND_DST_RGB', 32969: 'BLEND_SRC_RGB', 32970: 'BLEND_DST_ALPHA', 32971: 'BLEND_SRC_ALPHA', 33071: 'CLAMP_TO_EDGE', 33170: 'GENERATE_MIPMAP_HINT', 33189: 'DEPTH_COMPONENT16', 33306: 'DEPTH_STENCIL_ATTACHMENT', 33635: 'UNSIGNED_SHORT_5_6_5', 33648: 'MIRRORED_REPEAT', 33901: 'ALIASED_POINT_SIZE_RANGE', 33902: 'ALIASED_LINE_WIDTH_RANGE', 33984: 'TEXTURE0', 33985: 'TEXTURE1', 33986: 'TEXTURE2', 33987: 'TEXTURE3', 33988: 'TEXTURE4', 33989: 'TEXTURE5', 33990: 'TEXTURE6', 33991: 'TEXTURE7', 33992: 'TEXTURE8', 33993: 'TEXTURE9', 33994: 'TEXTURE10', 33995: 'TEXTURE11', 33996: 'TEXTURE12', 33997: 'TEXTURE13', 33998: 'TEXTURE14', 33999: 'TEXTURE15', 34000: 'TEXTURE16', 34001: 'TEXTURE17', 34002: 'TEXTURE18', 34003: 'TEXTURE19', 34004: 'TEXTURE20', 34005: 'TEXTURE21', 34006: 'TEXTURE22', 34007: 'TEXTURE23', 34008: 'TEXTURE24', 34009: 'TEXTURE25', 34010: 'TEXTURE26', 34011: 'TEXTURE27', 34012: 'TEXTURE28', 34013: 'TEXTURE29', 34014: 'TEXTURE30', 34015: 'TEXTURE31', 34016: 'ACTIVE_TEXTURE', 34024: 'MAX_RENDERBUFFER_SIZE', 34041: 'DEPTH_STENCIL', 34055: 'INCR_WRAP', 34056: 'DECR_WRAP', 34067: 'TEXTURE_CUBE_MAP', 34068: 'TEXTURE_BINDING_CUBE_MAP', 34069: 'TEXTURE_CUBE_MAP_POSITIVE_X', 34070: 'TEXTURE_CUBE_MAP_NEGATIVE_X', 34071: 'TEXTURE_CUBE_MAP_POSITIVE_Y', 34072: 'TEXTURE_CUBE_MAP_NEGATIVE_Y', 34073: 'TEXTURE_CUBE_MAP_POSITIVE_Z', 34074: 'TEXTURE_CUBE_MAP_NEGATIVE_Z', 34076: 'MAX_CUBE_MAP_TEXTURE_SIZE', 34338: 'VERTEX_ATTRIB_ARRAY_ENABLED', 34339: 'VERTEX_ATTRIB_ARRAY_SIZE', 34340: 'VERTEX_ATTRIB_ARRAY_STRIDE', 34341: 'VERTEX_ATTRIB_ARRAY_TYPE', 34342: 'CURRENT_VERTEX_ATTRIB', 34373: 'VERTEX_ATTRIB_ARRAY_POINTER', 34466: 'NUM_COMPRESSED_TEXTURE_FORMATS', 34467: 'COMPRESSED_TEXTURE_FORMATS', 34660: 'BUFFER_SIZE', 34661: 'BUFFER_USAGE', 34816: 'STENCIL_BACK_FUNC', 34817: 'STENCIL_BACK_FAIL', 34818: 'STENCIL_BACK_PASS_DEPTH_FAIL', 34819: 'STENCIL_BACK_PASS_DEPTH_PASS', 34877: 'BLEND_EQUATION_ALPHA', 34921: 'MAX_VERTEX_ATTRIBS', 34922: 'VERTEX_ATTRIB_ARRAY_NORMALIZED', 34930: 'MAX_TEXTURE_IMAGE_UNITS', 34962: 'ARRAY_BUFFER', 34963: 'ELEMENT_ARRAY_BUFFER', 34964: 'ARRAY_BUFFER_BINDING', 34965: 'ELEMENT_ARRAY_BUFFER_BINDING', 34975: 'VERTEX_ATTRIB_ARRAY_BUFFER_BINDING', 35040: 'STREAM_DRAW', 35044: 'STATIC_DRAW', 35048: 'DYNAMIC_DRAW', 35632: 'FRAGMENT_SHADER', 35633: 'VERTEX_SHADER', 35660: 'MAX_VERTEX_TEXTURE_IMAGE_UNITS', 35661: 'MAX_COMBINED_TEXTURE_IMAGE_UNITS', 35663: 'SHADER_TYPE', 35664: 'FLOAT_VEC2', 35665: 'FLOAT_VEC3', 35666: 'FLOAT_VEC4', 35667: 'INT_VEC2', 35668: 'INT_VEC3', 35669: 'INT_VEC4', 35670: 'BOOL', 35671: 'BOOL_VEC2', 35672: 'BOOL_VEC3', 35673: 'BOOL_VEC4', 35674: 'FLOAT_MAT2', 35675: 'FLOAT_MAT3', 35676: 'FLOAT_MAT4', 35678: 'SAMPLER_2D', 35680: 'SAMPLER_CUBE', 35712: 'DELETE_STATUS', 35713: 'COMPILE_STATUS', 35714: 'LINK_STATUS', 35715: 'VALIDATE_STATUS', 35716: 'INFO_LOG_LENGTH', 35717: 'ATTACHED_SHADERS', 35718: 'ACTIVE_UNIFORMS', 35719: 'ACTIVE_UNIFORM_MAX_LENGTH', 35720: 'SHADER_SOURCE_LENGTH', 35721: 'ACTIVE_ATTRIBUTES', 35722: 'ACTIVE_ATTRIBUTE_MAX_LENGTH', 35724: 'SHADING_LANGUAGE_VERSION', 35725: 'CURRENT_PROGRAM', 36003: 'STENCIL_BACK_REF', 36004: 'STENCIL_BACK_VALUE_MASK', 36005: 'STENCIL_BACK_WRITEMASK', 36006: 'FRAMEBUFFER_BINDING', 36007: 'RENDERBUFFER_BINDING', 36048: 'FRAMEBUFFER_ATTACHMENT_OBJECT_TYPE', 36049: 'FRAMEBUFFER_ATTACHMENT_OBJECT_NAME', 36050: 'FRAMEBUFFER_ATTACHMENT_TEXTURE_LEVEL', 36051: 'FRAMEBUFFER_ATTACHMENT_TEXTURE_CUBE_MAP_FACE', 36053: 'FRAMEBUFFER_COMPLETE', 36054: 'FRAMEBUFFER_INCOMPLETE_ATTACHMENT', 36055: 'FRAMEBUFFER_INCOMPLETE_MISSING_ATTACHMENT', 36057: 'FRAMEBUFFER_INCOMPLETE_DIMENSIONS', 36061: 'FRAMEBUFFER_UNSUPPORTED', 36064: 'COLOR_ATTACHMENT0', 36096: 'DEPTH_ATTACHMENT', 36128: 'STENCIL_ATTACHMENT', 36160: 'FRAMEBUFFER', 36161: 'RENDERBUFFER', 36162: 'RENDERBUFFER_WIDTH', 36163: 'RENDERBUFFER_HEIGHT', 36164: 'RENDERBUFFER_INTERNAL_FORMAT', 36168: 'STENCIL_INDEX8', 36176: 'RENDERBUFFER_RED_SIZE', 36177: 'RENDERBUFFER_GREEN_SIZE', 36178: 'RENDERBUFFER_BLUE_SIZE', 36179: 'RENDERBUFFER_ALPHA_SIZE', 36180: 'RENDERBUFFER_DEPTH_SIZE', 36181: 'RENDERBUFFER_STENCIL_SIZE', 36194: 'RGB565', 36336: 'LOW_FLOAT', 36337: 'MEDIUM_FLOAT', 36338: 'HIGH_FLOAT', 36339: 'LOW_INT', 36340: 'MEDIUM_INT', 36341: 'HIGH_INT', 36346: 'SHADER_COMPILER', 36347: 'MAX_VERTEX_UNIFORM_VECTORS', 36348: 'MAX_VARYING_VECTORS', 36349: 'MAX_FRAGMENT_UNIFORM_VECTORS', 37440: 'UNPACK_FLIP_Y_WEBGL', 37441: 'UNPACK_PREMULTIPLY_ALPHA_WEBGL', 37442: 'CONTEXT_LOST_WEBGL', 37443: 'UNPACK_COLORSPACE_CONVERSION_WEBGL', 37444: 'BROWSER_DEFAULT_WEBGL' } },{}],166:[function(require,module,exports){ var gl10 = require('./1.0/numbers') module.exports = function lookupConstant (number) { return gl10[number] } },{"./1.0/numbers":165}],167:[function(require,module,exports){ var tokenize = require('glsl-tokenizer') var atob = require('atob-lite') module.exports = getName function getName(src) { var tokens = Array.isArray(src) ? src : tokenize(src) for (var i = 0; i < tokens.length; i++) { var token = tokens[i] if (token.type !== 'preprocessor') continue var match = token.data.match(/\#define\s+SHADER_NAME(_B64)?\s+(.+)$/) if (!match) continue if (!match[2]) continue var b64 = match[1] var name = match[2] return (b64 ? atob(name) : name).trim() } } },{"atob-lite":168,"glsl-tokenizer":173}],168:[function(require,module,exports){ module.exports = function _atob(str) { return atob(str) } },{}],169:[function(require,module,exports){ module.exports = tokenize var literals = require('./lib/literals') , operators = require('./lib/operators') , builtins = require('./lib/builtins') var NORMAL = 999 // <-- never emitted , TOKEN = 9999 // <-- never emitted , BLOCK_COMMENT = 0 , LINE_COMMENT = 1 , PREPROCESSOR = 2 , OPERATOR = 3 , INTEGER = 4 , FLOAT = 5 , IDENT = 6 , BUILTIN = 7 , KEYWORD = 8 , WHITESPACE = 9 , EOF = 10 , HEX = 11 var map = [ 'block-comment' , 'line-comment' , 'preprocessor' , 'operator' , 'integer' , 'float' , 'ident' , 'builtin' , 'keyword' , 'whitespace' , 'eof' , 'integer' ] function tokenize() { var i = 0 , total = 0 , mode = NORMAL , c , last , content = [] , tokens = [] , token_idx = 0 , token_offs = 0 , line = 1 , col = 0 , start = 0 , isnum = false , isoperator = false , input = '' , len return function(data) { tokens = [] if (data !== null) return write(data) return end() } function token(data) { if (data.length) { tokens.push({ type: map[mode] , data: data , position: start , line: line , column: col }) } } function write(chunk) { i = 0 input += chunk len = input.length var last while(c = input[i], i < len) { last = i switch(mode) { case BLOCK_COMMENT: i = block_comment(); break case LINE_COMMENT: i = line_comment(); break case PREPROCESSOR: i = preprocessor(); break case OPERATOR: i = operator(); break case INTEGER: i = integer(); break case HEX: i = hex(); break case FLOAT: i = decimal(); break case TOKEN: i = readtoken(); break case WHITESPACE: i = whitespace(); break case NORMAL: i = normal(); break } if(last !== i) { switch(input[last]) { case '\n': col = 0; ++line; break default: ++col; break } } } total += i input = input.slice(i) return tokens } function end(chunk) { if(content.length) { token(content.join('')) } mode = EOF token('(eof)') return tokens } function normal() { content = content.length ? [] : content if(last === '/' && c === '*') { start = total + i - 1 mode = BLOCK_COMMENT last = c return i + 1 } if(last === '/' && c === '/') { start = total + i - 1 mode = LINE_COMMENT last = c return i + 1 } if(c === '#') { mode = PREPROCESSOR start = total + i return i } if(/\s/.test(c)) { mode = WHITESPACE start = total + i return i } isnum = /\d/.test(c) isoperator = /[^\w_]/.test(c) start = total + i mode = isnum ? INTEGER : isoperator ? OPERATOR : TOKEN return i } function whitespace() { if(/[^\s]/g.test(c)) { token(content.join('')) mode = NORMAL return i } content.push(c) last = c return i + 1 } function preprocessor() { if(c === '\n' && last !== '\\') { token(content.join('')) mode = NORMAL return i } content.push(c) last = c return i + 1 } function line_comment() { return preprocessor() } function block_comment() { if(c === '/' && last === '*') { content.push(c) token(content.join('')) mode = NORMAL return i + 1 } content.push(c) last = c return i + 1 } function operator() { if(last === '.' && /\d/.test(c)) { mode = FLOAT return i } if(last === '/' && c === '*') { mode = BLOCK_COMMENT return i } if(last === '/' && c === '/') { mode = LINE_COMMENT return i } if(c === '.' && content.length) { while(determine_operator(content)); mode = FLOAT return i } if(c === ';' || c === ')' || c === '(') { if(content.length) while(determine_operator(content)); token(c) mode = NORMAL return i + 1 } var is_composite_operator = content.length === 2 && c !== '=' if(/[\w_\d\s]/.test(c) || is_composite_operator) { while(determine_operator(content)); mode = NORMAL return i } content.push(c) last = c return i + 1 } function determine_operator(buf) { var j = 0 , idx , res do { idx = operators.indexOf(buf.slice(0, buf.length + j).join('')) res = operators[idx] if(idx === -1) { if(j-- + buf.length > 0) continue res = buf.slice(0, 1).join('') } token(res) start += res.length content = content.slice(res.length) return content.length } while(1) } function hex() { if(/[^a-fA-F0-9]/.test(c)) { token(content.join('')) mode = NORMAL return i } content.push(c) last = c return i + 1 } function integer() { if(c === '.') { content.push(c) mode = FLOAT last = c return i + 1 } if(/[eE]/.test(c)) { content.push(c) mode = FLOAT last = c return i + 1 } if(c === 'x' && content.length === 1 && content[0] === '0') { mode = HEX content.push(c) last = c return i + 1 } if(/[^\d]/.test(c)) { token(content.join('')) mode = NORMAL return i } content.push(c) last = c return i + 1 } function decimal() { if(c === 'f') { content.push(c) last = c i += 1 } if(/[eE]/.test(c)) { content.push(c) last = c return i + 1 } if(/[^\d]/.test(c)) { token(content.join('')) mode = NORMAL return i } content.push(c) last = c return i + 1 } function readtoken() { if(/[^\d\w_]/.test(c)) { var contentstr = content.join('') if(literals.indexOf(contentstr) > -1) { mode = KEYWORD } else if(builtins.indexOf(contentstr) > -1) { mode = BUILTIN } else { mode = IDENT } token(content.join('')) mode = NORMAL return i } content.push(c) last = c return i + 1 } } },{"./lib/builtins":170,"./lib/literals":171,"./lib/operators":172}],170:[function(require,module,exports){ module.exports = [ 'gl_Position' , 'gl_PointSize' , 'gl_ClipVertex' , 'gl_FragCoord' , 'gl_FrontFacing' , 'gl_FragColor' , 'gl_FragData' , 'gl_FragDepth' , 'gl_Color' , 'gl_SecondaryColor' , 'gl_Normal' , 'gl_Vertex' , 'gl_MultiTexCoord0' , 'gl_MultiTexCoord1' , 'gl_MultiTexCoord2' , 'gl_MultiTexCoord3' , 'gl_MultiTexCoord4' , 'gl_MultiTexCoord5' , 'gl_MultiTexCoord6' , 'gl_MultiTexCoord7' , 'gl_FogCoord' , 'gl_MaxLights' , 'gl_MaxClipPlanes' , 'gl_MaxTextureUnits' , 'gl_MaxTextureCoords' , 'gl_MaxVertexAttribs' , 'gl_MaxVertexUniformComponents' , 'gl_MaxVaryingFloats' , 'gl_MaxVertexTextureImageUnits' , 'gl_MaxCombinedTextureImageUnits' , 'gl_MaxTextureImageUnits' , 'gl_MaxFragmentUniformComponents' , 'gl_MaxDrawBuffers' , 'gl_ModelViewMatrix' , 'gl_ProjectionMatrix' , 'gl_ModelViewProjectionMatrix' , 'gl_TextureMatrix' , 'gl_NormalMatrix' , 'gl_ModelViewMatrixInverse' , 'gl_ProjectionMatrixInverse' , 'gl_ModelViewProjectionMatrixInverse' , 'gl_TextureMatrixInverse' , 'gl_ModelViewMatrixTranspose' , 'gl_ProjectionMatrixTranspose' , 'gl_ModelViewProjectionMatrixTranspose' , 'gl_TextureMatrixTranspose' , 'gl_ModelViewMatrixInverseTranspose' , 'gl_ProjectionMatrixInverseTranspose' , 'gl_ModelViewProjectionMatrixInverseTranspose' , 'gl_TextureMatrixInverseTranspose' , 'gl_NormalScale' , 'gl_DepthRangeParameters' , 'gl_DepthRange' , 'gl_ClipPlane' , 'gl_PointParameters' , 'gl_Point' , 'gl_MaterialParameters' , 'gl_FrontMaterial' , 'gl_BackMaterial' , 'gl_LightSourceParameters' , 'gl_LightSource' , 'gl_LightModelParameters' , 'gl_LightModel' , 'gl_LightModelProducts' , 'gl_FrontLightModelProduct' , 'gl_BackLightModelProduct' , 'gl_LightProducts' , 'gl_FrontLightProduct' , 'gl_BackLightProduct' , 'gl_FogParameters' , 'gl_Fog' , 'gl_TextureEnvColor' , 'gl_EyePlaneS' , 'gl_EyePlaneT' , 'gl_EyePlaneR' , 'gl_EyePlaneQ' , 'gl_ObjectPlaneS' , 'gl_ObjectPlaneT' , 'gl_ObjectPlaneR' , 'gl_ObjectPlaneQ' , 'gl_FrontColor' , 'gl_BackColor' , 'gl_FrontSecondaryColor' , 'gl_BackSecondaryColor' , 'gl_TexCoord' , 'gl_FogFragCoord' , 'gl_Color' , 'gl_SecondaryColor' , 'gl_TexCoord' , 'gl_FogFragCoord' , 'gl_PointCoord' , 'radians' , 'degrees' , 'sin' , 'cos' , 'tan' , 'asin' , 'acos' , 'atan' , 'pow' , 'exp' , 'log' , 'exp2' , 'log2' , 'sqrt' , 'inversesqrt' , 'abs' , 'sign' , 'floor' , 'ceil' , 'fract' , 'mod' , 'min' , 'max' , 'clamp' , 'mix' , 'step' , 'smoothstep' , 'length' , 'distance' , 'dot' , 'cross' , 'normalize' , 'faceforward' , 'reflect' , 'refract' , 'matrixCompMult' , 'lessThan' , 'lessThanEqual' , 'greaterThan' , 'greaterThanEqual' , 'equal' , 'notEqual' , 'any' , 'all' , 'not' , 'texture2D' , 'texture2DProj' , 'texture2DLod' , 'texture2DProjLod' , 'textureCube' , 'textureCubeLod' , 'dFdx' , 'dFdy' ] },{}],171:[function(require,module,exports){ module.exports = [ // current 'precision' , 'highp' , 'mediump' , 'lowp' , 'attribute' , 'const' , 'uniform' , 'varying' , 'break' , 'continue' , 'do' , 'for' , 'while' , 'if' , 'else' , 'in' , 'out' , 'inout' , 'float' , 'int' , 'void' , 'bool' , 'true' , 'false' , 'discard' , 'return' , 'mat2' , 'mat3' , 'mat4' , 'vec2' , 'vec3' , 'vec4' , 'ivec2' , 'ivec3' , 'ivec4' , 'bvec2' , 'bvec3' , 'bvec4' , 'sampler1D' , 'sampler2D' , 'sampler3D' , 'samplerCube' , 'sampler1DShadow' , 'sampler2DShadow' , 'struct' // future , 'asm' , 'class' , 'union' , 'enum' , 'typedef' , 'template' , 'this' , 'packed' , 'goto' , 'switch' , 'default' , 'inline' , 'noinline' , 'volatile' , 'public' , 'static' , 'extern' , 'external' , 'interface' , 'long' , 'short' , 'double' , 'half' , 'fixed' , 'unsigned' , 'input' , 'output' , 'hvec2' , 'hvec3' , 'hvec4' , 'dvec2' , 'dvec3' , 'dvec4' , 'fvec2' , 'fvec3' , 'fvec4' , 'sampler2DRect' , 'sampler3DRect' , 'sampler2DRectShadow' , 'sizeof' , 'cast' , 'namespace' , 'using' ] },{}],172:[function(require,module,exports){ module.exports = [ '<<=' , '>>=' , '++' , '--' , '<<' , '>>' , '<=' , '>=' , '==' , '!=' , '&&' , '||' , '+=' , '-=' , '*=' , '/=' , '%=' , '&=' , '^^' , '^=' , '|=' , '(' , ')' , '[' , ']' , '.' , '!' , '~' , '*' , '/' , '%' , '+' , '-' , '<' , '>' , '&' , '^' , '|' , '?' , ':' , '=' , ',' , ';' , '{' , '}' ] },{}],173:[function(require,module,exports){ var tokenize = require('./index') module.exports = tokenizeString function tokenizeString(str) { var generator = tokenize() var tokens = [] tokens = tokens.concat(generator(str)) tokens = tokens.concat(generator(null)) return tokens } },{"./index":169}],174:[function(require,module,exports){ (function(window) { var re = { not_string: /[^s]/, number: /[diefg]/, json: /[j]/, not_json: /[^j]/, text: /^[^\x25]+/, modulo: /^\x25{2}/, placeholder: /^\x25(?:([1-9]\d*)\$|\(([^\)]+)\))?(\+)?(0|'[^$])?(-)?(\d+)?(?:\.(\d+))?([b-gijosuxX])/, key: /^([a-z_][a-z_\d]*)/i, key_access: /^\.([a-z_][a-z_\d]*)/i, index_access: /^\[(\d+)\]/, sign: /^[\+\-]/ } function sprintf() { var key = arguments[0], cache = sprintf.cache if (!(cache[key] && cache.hasOwnProperty(key))) { cache[key] = sprintf.parse(key) } return sprintf.format.call(null, cache[key], arguments) } sprintf.format = function(parse_tree, argv) { var cursor = 1, tree_length = parse_tree.length, node_type = "", arg, output = [], i, k, match, pad, pad_character, pad_length, is_positive = true, sign = "" for (i = 0; i < tree_length; i++) { node_type = get_type(parse_tree[i]) if (node_type === "string") { output[output.length] = parse_tree[i] } else if (node_type === "array") { match = parse_tree[i] // convenience purposes only if (match[2]) { // keyword argument arg = argv[cursor] for (k = 0; k < match[2].length; k++) { if (!arg.hasOwnProperty(match[2][k])) { throw new Error(sprintf("[sprintf] property '%s' does not exist", match[2][k])) } arg = arg[match[2][k]] } } else if (match[1]) { // positional argument (explicit) arg = argv[match[1]] } else { // positional argument (implicit) arg = argv[cursor++] } if (get_type(arg) == "function") { arg = arg() } if (re.not_string.test(match[8]) && re.not_json.test(match[8]) && (get_type(arg) != "number" && isNaN(arg))) { throw new TypeError(sprintf("[sprintf] expecting number but found %s", get_type(arg))) } if (re.number.test(match[8])) { is_positive = arg >= 0 } switch (match[8]) { case "b": arg = arg.toString(2) break case "c": arg = String.fromCharCode(arg) break case "d": case "i": arg = parseInt(arg, 10) break case "j": arg = JSON.stringify(arg, null, match[6] ? parseInt(match[6]) : 0) break case "e": arg = match[7] ? arg.toExponential(match[7]) : arg.toExponential() break case "f": arg = match[7] ? parseFloat(arg).toFixed(match[7]) : parseFloat(arg) break case "g": arg = match[7] ? parseFloat(arg).toPrecision(match[7]) : parseFloat(arg) break case "o": arg = arg.toString(8) break case "s": arg = ((arg = String(arg)) && match[7] ? arg.substring(0, match[7]) : arg) break case "u": arg = arg >>> 0 break case "x": arg = arg.toString(16) break case "X": arg = arg.toString(16).toUpperCase() break } if (re.json.test(match[8])) { output[output.length] = arg } else { if (re.number.test(match[8]) && (!is_positive || match[3])) { sign = is_positive ? "+" : "-" arg = arg.toString().replace(re.sign, "") } else { sign = "" } pad_character = match[4] ? match[4] === "0" ? "0" : match[4].charAt(1) : " " pad_length = match[6] - (sign + arg).length pad = match[6] ? (pad_length > 0 ? str_repeat(pad_character, pad_length) : "") : "" output[output.length] = match[5] ? sign + arg + pad : (pad_character === "0" ? sign + pad + arg : pad + sign + arg) } } } return output.join("") } sprintf.cache = {} sprintf.parse = function(fmt) { var _fmt = fmt, match = [], parse_tree = [], arg_names = 0 while (_fmt) { if ((match = re.text.exec(_fmt)) !== null) { parse_tree[parse_tree.length] = match[0] } else if ((match = re.modulo.exec(_fmt)) !== null) { parse_tree[parse_tree.length] = "%" } else if ((match = re.placeholder.exec(_fmt)) !== null) { if (match[2]) { arg_names |= 1 var field_list = [], replacement_field = match[2], field_match = [] if ((field_match = re.key.exec(replacement_field)) !== null) { field_list[field_list.length] = field_match[1] while ((replacement_field = replacement_field.substring(field_match[0].length)) !== "") { if ((field_match = re.key_access.exec(replacement_field)) !== null) { field_list[field_list.length] = field_match[1] } else if ((field_match = re.index_access.exec(replacement_field)) !== null) { field_list[field_list.length] = field_match[1] } else { throw new SyntaxError("[sprintf] failed to parse named argument key") } } } else { throw new SyntaxError("[sprintf] failed to parse named argument key") } match[2] = field_list } else { arg_names |= 2 } if (arg_names === 3) { throw new Error("[sprintf] mixing positional and named placeholders is not (yet) supported") } parse_tree[parse_tree.length] = match } else { throw new SyntaxError("[sprintf] unexpected placeholder") } _fmt = _fmt.substring(match[0].length) } return parse_tree } var vsprintf = function(fmt, argv, _argv) { _argv = (argv || []).slice(0) _argv.splice(0, 0, fmt) return sprintf.apply(null, _argv) } /** * helpers */ function get_type(variable) { return Object.prototype.toString.call(variable).slice(8, -1).toLowerCase() } function str_repeat(input, multiplier) { return Array(multiplier + 1).join(input) } /** * export to either browser or node.js */ if (typeof exports !== "undefined") { exports.sprintf = sprintf exports.vsprintf = vsprintf } else { window.sprintf = sprintf window.vsprintf = vsprintf if (typeof define === "function" && define.amd) { define(function() { return { sprintf: sprintf, vsprintf: vsprintf } }) } } })(typeof window === "undefined" ? this : window); },{}],175:[function(require,module,exports){ var hiddenStore = require('./hidden-store.js'); module.exports = createStore; function createStore() { var key = {}; return function (obj) { if ((typeof obj !== 'object' || obj === null) && typeof obj !== 'function' ) { throw new Error('Weakmap-shim: Key must be object') } var store = obj.valueOf(key); return store && store.identity === key ? store : hiddenStore(obj, key); }; } },{"./hidden-store.js":176}],176:[function(require,module,exports){ module.exports = hiddenStore; function hiddenStore(obj, key) { var store = { identity: key }; var valueOf = obj.valueOf; Object.defineProperty(obj, "valueOf", { value: function (value) { return value !== key ? valueOf.apply(this, arguments) : store; }, writable: true }); return store; } },{}],177:[function(require,module,exports){ // Original - @Gozola. // https://gist.github.com/Gozala/1269991 // This is a reimplemented version (with a few bug fixes). var createStore = require('./create-store.js'); module.exports = weakMap; function weakMap() { var privates = createStore(); return { 'get': function (key, fallback) { var store = privates(key) return store.hasOwnProperty('value') ? store.value : fallback }, 'set': function (key, value) { privates(key).value = value; }, 'has': function(key) { return 'value' in privates(key); }, 'delete': function (key) { return delete privates(key).value; } } } },{"./create-store.js":175}],178:[function(require,module,exports){ 'use strict' module.exports = createSpikes2D function GLSpikes2D(plot) { this.plot = plot this.enable = [true, true, false, false] this.width = [1, 1, 1, 1] this.color = [[0,0,0,1], [0,0,0,1], [0,0,0,1], [0,0,0,1]] this.center = [Infinity, Infinity] } var proto = GLSpikes2D.prototype proto.update = function(options) { options = options || {} this.enable = (options.enable || [true,true,false,false]).slice() this.width = (options.width || [1,1,1,1]).slice() this.color = (options.color || [ [0,0,0,1], [0,0,0,1], [0,0,0,1], [0,0,0,1]]).map(function(x) { return x.slice() }) this.center = (options.center || [Infinity,Infinity]).slice() this.plot.setOverlayDirty() } proto.draw = function() { var spikeEnable = this.enable var spikeWidth = this.width var spikeColor = this.color var spikeCenter = this.center var plot = this.plot var line = plot.line var dataBox = plot.dataBox var viewPixels = plot.viewBox line.bind() if(dataBox[0] <= spikeCenter[0] && spikeCenter[0] <= dataBox[2] && dataBox[1] <= spikeCenter[1] && spikeCenter[1] <= dataBox[3]) { var centerX = viewPixels[0] + (spikeCenter[0] - dataBox[0]) / (dataBox[2] - dataBox[0]) * (viewPixels[2] - viewPixels[0]) var centerY = viewPixels[1] + (spikeCenter[1] - dataBox[1]) / (dataBox[3] - dataBox[1]) * (viewPixels[3] - viewPixels[1]) if(spikeEnable[0]) { line.drawLine( centerX, centerY, viewPixels[0], centerY, spikeWidth[0], spikeColor[0]) } if(spikeEnable[1]) { line.drawLine( centerX, centerY, centerX, viewPixels[1], spikeWidth[1], spikeColor[1]) } if(spikeEnable[2]) { line.drawLine( centerX, centerY, viewPixels[2], centerY, spikeWidth[2], spikeColor[2]) } if(spikeEnable[3]) { line.drawLine( centerX, centerY, centerX, viewPixels[3], spikeWidth[3], spikeColor[3]) } } } proto.dispose = function() { this.plot.removeOverlay(this) } function createSpikes2D(plot, options) { var spikes = new GLSpikes2D(plot) spikes.update(options) plot.addOverlay(spikes) return spikes } },{}],179:[function(require,module,exports){ var createShader = require('gl-shader') var vertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec4 uv;\nattribute vec2 f;\nattribute vec3 normal;\n\nuniform mat4 model, view, projection, inverseModel;\nuniform vec3 lightPosition, eyePosition;\n\nvarying float value, kill;\nvarying vec3 worldCoordinate;\nvarying vec2 planeCoordinate;\nvarying vec3 lightDirection, eyeDirection, surfaceNormal;\n\nvoid main() {\n worldCoordinate = vec3(uv.zw, f.x);\n vec4 worldPosition = model * vec4(worldCoordinate, 1.0);\n vec4 clipPosition = projection * view * worldPosition;\n gl_Position = clipPosition;\n value = f.x;\n kill = f.y;\n planeCoordinate = uv.xy;\n \n //Lighting geometry parameters\n vec4 cameraCoordinate = view * worldPosition;\n cameraCoordinate.xyz /= cameraCoordinate.w;\n lightDirection = lightPosition - cameraCoordinate.xyz;\n eyeDirection = eyePosition - cameraCoordinate.xyz;\n surfaceNormal = normalize((vec4(normal,0) * inverseModel).xyz);\n}" var fragSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nfloat beckmannDistribution_2_0(float x, float roughness) {\n float NdotH = max(x, 0.0001);\n float cos2Alpha = NdotH * NdotH;\n float tan2Alpha = (cos2Alpha - 1.0) / cos2Alpha;\n float roughness2 = roughness * roughness;\n float denom = 3.141592653589793 * roughness2 * cos2Alpha * cos2Alpha;\n return exp(tan2Alpha / roughness2) / denom;\n}\n\n\n\nfloat beckmannSpecular_1_1(\n vec3 lightDirection,\n vec3 viewDirection,\n vec3 surfaceNormal,\n float roughness) {\n return beckmannDistribution_2_0(dot(surfaceNormal, normalize(lightDirection + viewDirection)), roughness);\n}\n\n\n\nuniform vec3 lowerBound, upperBound;\nuniform float contourTint;\nuniform vec4 contourColor;\nuniform sampler2D colormap;\nuniform vec3 clipBounds[2];\nuniform float roughness, fresnel, kambient, kdiffuse, kspecular, opacity;\n\nvarying float value, kill;\nvarying vec3 worldCoordinate;\nvarying vec3 lightDirection, eyeDirection, surfaceNormal;\n\nvoid main() {\n if(kill > 0.0 ||\n any(lessThan(worldCoordinate, clipBounds[0])) || any(greaterThan(worldCoordinate, clipBounds[1]))) {\n discard;\n }\n\n vec3 N = normalize(surfaceNormal);\n vec3 V = normalize(eyeDirection);\n vec3 L = normalize(lightDirection);\n\n if(gl_FrontFacing) {\n N = -N;\n }\n\n float specular = beckmannSpecular_1_1(L, V, N, roughness);\n float diffuse = min(kambient + kdiffuse * max(dot(N, L), 0.0), 1.0);\n\n float interpValue = (value - lowerBound.z) / (upperBound.z - lowerBound.z);\n vec4 surfaceColor = texture2D(colormap, vec2(interpValue, interpValue));\n vec4 litColor = surfaceColor.a * vec4(diffuse * surfaceColor.rgb + kspecular * vec3(1,1,1) * specular, 1.0);\n\n gl_FragColor = mix(litColor, contourColor, contourTint) * opacity;\n}\n" var contourVertSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nattribute vec4 uv;\n\nuniform mat3 permutation;\nuniform mat4 model, view, projection;\nuniform float height, zOffset;\n\nvarying float value, kill;\nvarying vec3 worldCoordinate;\nvarying vec2 planeCoordinate;\nvarying vec3 lightDirection, eyeDirection, surfaceNormal;\n\nvoid main() {\n vec3 dataCoordinate = permutation * vec3(uv.xy, height);\n vec4 worldPosition = model * vec4(dataCoordinate, 1.0);\n\n vec4 clipPosition = projection * view * worldPosition;\n clipPosition.z = clipPosition.z + zOffset;\n\n gl_Position = clipPosition;\n value = dataCoordinate.z;\n kill = -1.0;\n worldCoordinate = dataCoordinate;\n planeCoordinate = uv.zw;\n\n //Don't do lighting for contours\n surfaceNormal = vec3(1,0,0);\n eyeDirection = vec3(0,1,0);\n lightDirection = vec3(0,0,1);\n}\n" var pickSrc = "#define GLSLIFY 1\nprecision mediump float;\n\nuniform vec2 shape;\nuniform vec3 clipBounds[2];\nuniform float pickId;\n\nvarying float value, kill;\nvarying vec3 worldCoordinate;\nvarying vec2 planeCoordinate;\nvarying vec3 surfaceNormal;\n\nvec2 splitFloat(float v) {\n float vh = 255.0 * v;\n float upper = floor(vh);\n float lower = fract(vh);\n return vec2(upper / 255.0, floor(lower * 16.0) / 16.0);\n}\n\nvoid main() {\n if(kill > 0.0 || \n any(lessThan(worldCoordinate, clipBounds[0])) || any(greaterThan(worldCoordinate, clipBounds[1]))) {\n discard;\n }\n vec2 ux = splitFloat(planeCoordinate.x / shape.x);\n vec2 uy = splitFloat(planeCoordinate.y / shape.y);\n gl_FragColor = vec4(pickId, ux.x, uy.x, ux.y + (uy.y/16.0));\n}" exports.createShader = function(gl) { var shader = createShader(gl, vertSrc, fragSrc, null, [ {name: 'uv', type: 'vec4'}, {name: 'f', type: 'vec2'}, {name: 'normal', type: 'vec3'} ]) shader.attributes.uv.location = 0 shader.attributes.f.location = 1 shader.attributes.normal.location = 2 return shader } exports.createPickShader = function(gl) { var shader = createShader(gl, vertSrc, pickSrc, null, [ {name: 'uv', type: 'vec4'}, {name: 'f', type: 'vec2'}, {name: 'normal', type: 'vec3'} ]) shader.attributes.uv.location = 0 shader.attributes.f.location = 1 shader.attributes.normal.location = 2 return shader } exports.createContourShader = function(gl) { var shader = createShader(gl, contourVertSrc, fragSrc, null, [ {name: 'uv', type: 'vec4'} ]) shader.attributes.uv.location = 0 return shader } exports.createPickContourShader = function(gl) { var shader = createShader(gl, contourVertSrc, pickSrc, null, [ {name: 'uv', type: 'vec4'} ]) shader.attributes.uv.location = 0 return shader } },{"gl-shader":154}],180:[function(require,module,exports){ arguments[4][20][0].apply(exports,arguments) },{"dup":20}],181:[function(require,module,exports){ 'use strict' module.exports = gradient var dup = require('dup') var cwiseCompiler = require('cwise-compiler') var TEMPLATE_CACHE = {} var GRADIENT_CACHE = {} var EmptyProc = { body: "", args: [], thisVars: [], localVars: [] } var centralDiff = cwiseCompiler({ args: [ 'array', 'array', 'array' ], pre: EmptyProc, post: EmptyProc, body: { args: [ { name: 'out', lvalue: true, rvalue: false, count: 1 }, { name: 'left', lvalue: false, rvalue: true, count: 1 }, { name: 'right', lvalue: false, rvalue: true, count: 1 }], body: "out=0.5*(left-right)", thisVars: [], localVars: [] }, funcName: 'cdiff' }) var zeroOut = cwiseCompiler({ args: [ 'array' ], pre: EmptyProc, post: EmptyProc, body: { args: [ { name: 'out', lvalue: true, rvalue: false, count: 1 }], body: "out=0", thisVars: [], localVars: [] }, funcName: 'zero' }) function generateTemplate(d) { if(d in TEMPLATE_CACHE) { return TEMPLATE_CACHE[d] } var code = [] for(var i=0; i= 0) { pickStr.push('0') } else if(facet.indexOf(-(i+1)) >= 0) { pickStr.push('s['+i+']-1') } else { pickStr.push('-1') loStr.push('1') hiStr.push('s['+i+']-2') } } var boundStr = '.lo(' + loStr.join() + ').hi(' + hiStr.join() + ')' if(loStr.length === 0) { boundStr = '' } if(cod > 0) { code.push('if(1') for(var i=0; i= 0 || facet.indexOf(-(i+1)) >= 0) { continue } code.push('&&s[', i, ']>2') } code.push('){grad', cod, '(src.pick(', pickStr.join(), ')', boundStr) for(var i=0; i= 0 || facet.indexOf(-(i+1)) >= 0) { continue } code.push(',dst.pick(', pickStr.join(), ',', i, ')', boundStr) } code.push(');') } for(var i=0; i1){dst.set(', pickStr.join(), ',', bnd, ',0.5*(src.get(', cPickStr.join(), ')-src.get(', dPickStr.join(), ')))}else{dst.set(', pickStr.join(), ',', bnd, ',0)};') } else { code.push('if(s[', bnd, ']>1){diff(', outStr, ',src.pick(', cPickStr.join(), ')', boundStr, ',src.pick(', dPickStr.join(), ')', boundStr, ');}else{zero(', outStr, ');};') } break case 'mirror': if(cod === 0) { code.push('dst.set(', pickStr.join(), ',', bnd, ',0);') } else { code.push('zero(', outStr, ');') } break case 'wrap': var aPickStr = pickStr.slice() var bPickStr = pickStr.slice() if(facet[i] < 0) { aPickStr[bnd] = 's[' + bnd + ']-2' bPickStr[bnd] = '0' } else { aPickStr[bnd] = 's[' + bnd + ']-1' bPickStr[bnd] = '1' } if(cod === 0) { code.push('if(s[', bnd, ']>2){dst.set(', pickStr.join(), ',', bnd, ',0.5*(src.get(', aPickStr.join(), ')-src.get(', bPickStr.join(), ')))}else{dst.set(', pickStr.join(), ',', bnd, ',0)};') } else { code.push('if(s[', bnd, ']>2){diff(', outStr, ',src.pick(', aPickStr.join(), ')', boundStr, ',src.pick(', bPickStr.join(), ')', boundStr, ');}else{zero(', outStr, ');};') } break default: throw new Error('ndarray-gradient: Invalid boundary condition') } } if(cod > 0) { code.push('};') } } //Enumerate ridges, facets, etc. of hypercube for(var i=0; i<(1<= 1) { return true } for(var i=0; i<3; ++i) { if(this._contourCounts[i].length > 0 || this._dynamicCounts[i] > 0) { return true } } return false } proto.pickSlots = 1 proto.setPickBase = function(id) { this.pickId = id } var ZERO_VEC = [0,0,0] var PROJECT_DATA = { showSurface: false, showContour: false, projections: [IDENTITY.slice(), IDENTITY.slice(), IDENTITY.slice()], clipBounds: [ [[0,0,0], [0,0,0]], [[0,0,0], [0,0,0]], [[0,0,0], [0,0,0]]] } function computeProjectionData(camera, obj) { //Compute cube properties var cubeAxis = (obj.axes && obj.axes.lastCubeProps.axis) || ZERO_VEC var showSurface = obj.showSurface var showContour = obj.showContour for(var i=0; i<3; ++i) { showSurface = showSurface || obj.surfaceProject[i] for(var j=0; j<3; ++j) { showContour = showContour || obj.contourProject[i][j] } } for(var i=0; i<3; ++i) { //Construct projection onto axis var axisSquish = PROJECT_DATA.projections[i] for(var j=0; j<16; ++j) { axisSquish[j] = 0 } for(var j=0; j<4; ++j) { axisSquish[5*j] = 1 } axisSquish[5*i] = 0 axisSquish[12+i] = obj.axesBounds[+(cubeAxis[i]>0)][i] multiply(axisSquish, camera.model, axisSquish) var nclipBounds = PROJECT_DATA.clipBounds[i] for(var k=0; k<2; ++k) { for(var j=0; j<3; ++j) { nclipBounds[k][j] = camera.clipBounds[k][j] } } nclipBounds[0][i] = -1e8 nclipBounds[1][i] = 1e8 } PROJECT_DATA.showSurface = showSurface PROJECT_DATA.showContour = showContour return PROJECT_DATA } var UNIFORMS = { model: IDENTITY, view: IDENTITY, projection: IDENTITY, inverseModel: IDENTITY.slice(), lowerBound: [0,0,0], upperBound: [0,0,0], colorMap: 0, clipBounds: [[0,0,0], [0,0,0]], height: 0.0, contourTint: 0, contourColor: [0,0,0,1], permutation: [1,0,0,0,1,0,0,0,1], zOffset: -1e-4, kambient: 1, kdiffuse: 1, kspecular: 1, lightPosition: [1000,1000,1000], eyePosition: [0,0,0], roughness: 1, fresnel: 1, opacity: 1 } var MATRIX_INVERSE = IDENTITY.slice() var DEFAULT_PERM = [1,0,0,0,1,0,0,0,1] function drawCore(params, transparent) { params = params || {} var gl = this.gl gl.disable(gl.CULL_FACE) this._colorMap.bind(0) var uniforms = UNIFORMS uniforms.model = params.model || IDENTITY uniforms.view = params.view || IDENTITY uniforms.projection = params.projection || IDENTITY uniforms.lowerBound = [this.bounds[0][0], this.bounds[0][1], this.colorBounds[0] || this.bounds[0][2]] uniforms.upperBound = [this.bounds[1][0], this.bounds[1][1], this.colorBounds[1] || this.bounds[1][2]] uniforms.contourColor = this.contourColor[0] uniforms.inverseModel = invert(uniforms.inverseModel, uniforms.model) for(var i=0; i<2; ++i) { var clipClamped = uniforms.clipBounds[i] for(var j=0; j<3; ++j) { clipClamped[j] = Math.min(Math.max(this.clipBounds[i][j], -1e8), 1e8) } } uniforms.kambient = this.ambientLight uniforms.kdiffuse = this.diffuseLight uniforms.kspecular = this.specularLight uniforms.shape = uniforms.roughness = this.roughness uniforms.fresnel = this.fresnel uniforms.opacity = this.opacity uniforms.height = 0.0 uniforms.permutation = DEFAULT_PERM //Compute camera matrix inverse var invCameraMatrix = MATRIX_INVERSE multiply(invCameraMatrix, uniforms.view, uniforms.model) multiply(invCameraMatrix, uniforms.projection, invCameraMatrix) invert(invCameraMatrix, invCameraMatrix) for(var i=0; i<3; ++i) { uniforms.eyePosition[i] = invCameraMatrix[12+i] / invCameraMatrix[15] } var w = invCameraMatrix[15] for(var i=0; i<3; ++i) { w += this.lightPosition[i] * invCameraMatrix[4*i+3] } for(var i=0; i<3; ++i) { var s = invCameraMatrix[12+i] for(var j=0; j<3; ++j) { s += invCameraMatrix[4*j+i] * this.lightPosition[j] } uniforms.lightPosition[i] = s / w } var projectData = computeProjectionData(uniforms, this) if(projectData.showSurface && (transparent === (this.opacity < 1))) { //Set up uniforms this._shader.bind() this._shader.uniforms = uniforms //Draw it this._vao.bind() if(this.showSurface) { this._vao.draw(gl.TRIANGLES, this._vertexCount) } //Draw projections of surface for(var i=0; i<3; ++i) { if(!this.surfaceProject[i]) { continue } this._shader.uniforms.model = projectData.projections[i] this._shader.uniforms.clipBounds = projectData.clipBounds[i] this._vao.draw(gl.TRIANGLES, this._vertexCount) } this._vao.unbind() } if(projectData.showContour && !transparent) { var shader = this._contourShader //Don't apply lighting to contours uniforms.kambient = 1.0 uniforms.kdiffuse = 0.0 uniforms.kspecular = 0.0 uniforms.opacity = 1.0 shader.bind() shader.uniforms = uniforms //Draw contour lines var vao = this._contourVAO vao.bind() //Draw contour levels for(var i=0; i<3; ++i) { shader.uniforms.permutation = PERMUTATIONS[i] gl.lineWidth(this.contourWidth[i]) for(var j=0; j>4)/16.0)/255.0 var ix = Math.floor(x) var fx = x - ix var y = shape[1] * (selection.value[1] + (selection.value[2]&15)/16.0)/255.0 var iy = Math.floor(y) var fy = y - iy ix += 1 iy += 1 //Compute xyz coordinate var pos = result.position pos[0] = pos[1] = pos[2] = 0 for(var dx=0; dx<2; ++dx) { var s = dx ? fx : 1.0 - fx for(var dy=0; dy<2; ++dy) { var t = dy ? fy : 1.0 - fy var r = ix + dx var c = iy + dy var w = s * t for(var i=0; i<3; ++i) { pos[i] += this._field[i].get(r,c) * w } } } //Find closest level var levelIndex = this._pickResult.level for(var j=0; j<3; ++j) { levelIndex[j] = bsearch.le(this.contourLevels[j], pos[j]) if(levelIndex[j] < 0) { if(this.contourLevels[j].length > 0) { levelIndex[j] = 0 } } else if(levelIndex[j] < this.contourLevels[j].length-1) { var a = this.contourLevels[j][levelIndex[j]] var b = this.contourLevels[j][levelIndex[j]+1] if(Math.abs(a-pos[j]) > Math.abs(b-pos[j])) { levelIndex[j] += 1 } } } result.index[0] = fx<0.5 ? ix : (ix+1) result.index[1] = fy<0.5 ? iy : (iy+1) result.uv[0] = x/shape[0] result.uv[1] = y/shape[1] for(var i=0; i<3; ++i) { result.dataCoordinate[i] = this._field[i].get(result.index[0], result.index[1]) } return result } function padField(nfield, field) { var shape = field.shape.slice() var nshape = nfield.shape.slice() //Center ops.assign(nfield.lo(1,1).hi(shape[0], shape[1]), field) //Edges ops.assign(nfield.lo(1).hi(shape[0], 1), field.hi(shape[0], 1)) ops.assign(nfield.lo(1,nshape[1]-1).hi(shape[0],1), field.lo(0,shape[1]-1).hi(shape[0],1)) ops.assign(nfield.lo(0,1).hi(1,shape[1]), field.hi(1)) ops.assign(nfield.lo(nshape[0]-1,1).hi(1,shape[1]), field.lo(shape[0]-1)) //Corners nfield.set(0,0, field.get(0,0)) nfield.set(0,nshape[1]-1, field.get(0,shape[1]-1)) nfield.set(nshape[0]-1,0, field.get(shape[0]-1,0)) nfield.set(nshape[0]-1,nshape[1]-1, field.get(shape[0]-1,shape[1]-1)) } function handleArray(param, ctor) { if(Array.isArray(param)) { return [ ctor(param[0]), ctor(param[1]), ctor(param[2]) ] } return [ ctor(param), ctor(param), ctor(param) ] } function toColor(x) { if(Array.isArray(x)) { if(x.length === 3) { return [x[0], x[1], x[2], 1] } return [x[0], x[1], x[2], x[3]] } return [0,0,0,1] } function handleColor(param) { if(Array.isArray(param)) { if(Array.isArray(param)) { return [ toColor(param[0]), toColor(param[1]), toColor(param[2]) ] } else { var c = toColor(param) return [ c.slice(), c.slice(), c.slice() ] } } } proto.update = function(params) { params = params || {} this.dirty = true if('contourWidth' in params) { this.contourWidth = handleArray(params.contourWidth, Number) } if('showContour' in params) { this.showContour = handleArray(params.showContour, Boolean) } if('showSurface' in params) { this.showSurface = !!params.showSurface } if('contourTint' in params) { this.contourTint = handleArray(params.contourTint, Boolean) } if('contourColor' in params) { this.contourColor = handleColor(params.contourColor) } if('contourProject' in params) { this.contourProject = handleArray(params.contourProject, function(x) { return handleArray(x, Boolean) }) } if('surfaceProject' in params) { this.surfaceProject = params.surfaceProject } if('dynamicColor' in params) { this.dynamicColor = handleColor(params.dynamicColor) } if('dynamicTint' in params) { this.dynamicTint = handleArray(params.dynamicTint, Number) } if('dynamicWidth' in params) { this.dynamicWidth = handleArray(params.dynamicWidth, Number) } if('opacity' in params) { this.opacity = params.opacity } if('colorBounds' in params) { this.colorBounds = params.colorBounds } var field = params.field || (params.coords && params.coords[2]) || null if(!field) { if(this._field[2].shape[0] || this._field[2].shape[2]) { field = this._field[2].lo(1,1).hi(this._field[2].shape[0]-2, this._field[2].shape[1]-2) } else { field = this._field[2].hi(0,0) } } //Update field if('field' in params || 'coords' in params) { var fsize = (field.shape[0]+2)*(field.shape[1]+2) //Resize if necessary if(fsize > this._field[2].data.length) { pool.freeFloat(this._field[2].data) this._field[2].data = pool.mallocFloat(bits.nextPow2(fsize)) } //Pad field this._field[2] = ndarray(this._field[2].data, [field.shape[0]+2, field.shape[1]+2]) padField(this._field[2], field) //Save shape of field this.shape = field.shape.slice() var shape = this.shape //Resize coordinate fields if necessary for(var i=0; i<2; ++i) { if(this._field[2].size > this._field[i].data.length) { pool.freeFloat(this._field[i].data) this._field[i].data = pool.mallocFloat(this._field[2].size) } this._field[i] = ndarray(this._field[i].data, [shape[0]+2, shape[1]+2]) } //Generate x/y coordinates if(params.coords) { var coords = params.coords if(!Array.isArray(coords) || coords.length !== 3) { throw new Error('gl-surface: invalid coordinates for x/y') } for(var i=0; i<2; ++i) { var coord = coords[i] for(var j=0; j<2; ++j) { if(coord.shape[j] !== shape[j]) { throw new Error('gl-surface: coords have incorrect shape') } } padField(this._field[i], coord) } } else if(params.ticks) { var ticks = params.ticks if(!Array.isArray(ticks) || ticks.length !== 2) { throw new Error('gl-surface: invalid ticks') } for(var i=0; i<2; ++i) { var tick = ticks[i] if(Array.isArray(tick) || tick.length) { tick = ndarray(tick) } if(tick.shape[0] !== shape[i]) { throw new Error('gl-surface: invalid tick length') } //Make a copy view of the tick array var tick2 = ndarray(tick.data, shape) tick2.stride[i] = tick.stride[0] tick2.stride[i^1] = 0 //Fill in field array padField(this._field[i], tick2) } } else { for(var i=0; i<2; ++i) { var offset = [0,0] offset[i] = 1 this._field[i] = ndarray(this._field[i].data, [shape[0]+2, shape[1]+2], offset, 0) } this._field[0].set(0,0,0) for(var j=0; j 0) { //If we already added first edge, pop off verts for(var l=0; l<4; ++l) { contourVerts.pop() } vertexCount -= 1 } continue edge_loop } } } levelCounts.push(vertexCount) } //Store results this._contourOffsets[dim] = levelOffsets this._contourCounts[dim] = levelCounts } var floatBuffer = pool.mallocFloat(contourVerts.length) for(var i=0; i maxSize || h < 0 || h > maxSize) { throw new Error('gl-texture2d: Invalid texture size') } tex._shape = [w, h] tex.bind() gl.texImage2D(gl.TEXTURE_2D, 0, tex.format, w, h, 0, tex.format, tex.type, null) tex._mipLevels = [0] return tex } function Texture2D(gl, handle, width, height, format, type) { this.gl = gl this.handle = handle this.format = format this.type = type this._shape = [width, height] this._mipLevels = [0] this._magFilter = gl.NEAREST this._minFilter = gl.NEAREST this._wrapS = gl.CLAMP_TO_EDGE this._wrapT = gl.CLAMP_TO_EDGE this._anisoSamples = 1 var parent = this var wrapVector = [this._wrapS, this._wrapT] Object.defineProperties(wrapVector, [ { get: function() { return parent._wrapS }, set: function(v) { return parent.wrapS = v } }, { get: function() { return parent._wrapT }, set: function(v) { return parent.wrapT = v } } ]) this._wrapVector = wrapVector var shapeVector = [this._shape[0], this._shape[1]] Object.defineProperties(shapeVector, [ { get: function() { return parent._shape[0] }, set: function(v) { return parent.width = v } }, { get: function() { return parent._shape[1] }, set: function(v) { return parent.height = v } } ]) this._shapeVector = shapeVector } var proto = Texture2D.prototype Object.defineProperties(proto, { minFilter: { get: function() { return this._minFilter }, set: function(v) { this.bind() var gl = this.gl if(this.type === gl.FLOAT && linearTypes.indexOf(v) >= 0) { if(!gl.getExtension('OES_texture_float_linear')) { v = gl.NEAREST } } if(filterTypes.indexOf(v) < 0) { throw new Error('gl-texture2d: Unknown filter mode ' + v) } gl.texParameteri(gl.TEXTURE_2D, gl.TEXTURE_MIN_FILTER, v) return this._minFilter = v } }, magFilter: { get: function() { return this._magFilter }, set: function(v) { this.bind() var gl = this.gl if(this.type === gl.FLOAT && linearTypes.indexOf(v) >= 0) { if(!gl.getExtension('OES_texture_float_linear')) { v = gl.NEAREST } } if(filterTypes.indexOf(v) < 0) { throw new Error('gl-texture2d: Unknown filter mode ' + v) } gl.texParameteri(gl.TEXTURE_2D, gl.TEXTURE_MAG_FILTER, v) return this._magFilter = v } }, mipSamples: { get: function() { return this._anisoSamples }, set: function(i) { var psamples = this._anisoSamples this._anisoSamples = Math.max(i, 1)|0 if(psamples !== this._anisoSamples) { var ext = gl.getExtension('EXT_texture_filter_anisotropic') if(ext) { this.gl.texParameterf(this.gl.TEXTURE_2D, ext.TEXTURE_MAX_ANISOTROPY_EXT, this._anisoSamples) } } return this._anisoSamples } }, wrapS: { get: function() { return this._wrapS }, set: function(v) { this.bind() if(wrapTypes.indexOf(v) < 0) { throw new Error('gl-texture2d: Unknown wrap mode ' + v) } this.gl.texParameteri(this.gl.TEXTURE_2D, this.gl.TEXTURE_WRAP_S, v) return this._wrapS = v } }, wrapT: { get: function() { return this._wrapT }, set: function(v) { this.bind() if(wrapTypes.indexOf(v) < 0) { throw new Error('gl-texture2d: Unknown wrap mode ' + v) } this.gl.texParameteri(this.gl.TEXTURE_2D, this.gl.TEXTURE_WRAP_T, v) return this._wrapT = v } }, wrap: { get: function() { return this._wrapVector }, set: function(v) { if(!Array.isArray(v)) { v = [v,v] } if(v.length !== 2) { throw new Error('gl-texture2d: Must specify wrap mode for rows and columns') } for(var i=0; i<2; ++i) { if(wrapTypes.indexOf(v[i]) < 0) { throw new Error('gl-texture2d: Unknown wrap mode ' + v) } } this._wrapS = v[0] this._wrapT = v[1] var gl = this.gl this.bind() gl.texParameteri(gl.TEXTURE_2D, gl.TEXTURE_WRAP_S, this._wrapS) gl.texParameteri(gl.TEXTURE_2D, gl.TEXTURE_WRAP_T, this._wrapT) return v } }, shape: { get: function() { return this._shapeVector }, set: function(x) { if(!Array.isArray(x)) { x = [x|0,x|0] } else { if(x.length !== 2) { throw new Error('gl-texture2d: Invalid texture shape') } } reshapeTexture(this, x[0]|0, x[1]|0) return [x[0]|0, x[1]|0] } }, width: { get: function() { return this._shape[0] }, set: function(w) { w = w|0 reshapeTexture(this, w, this._shape[1]) return w } }, height: { get: function() { return this._shape[1] }, set: function(h) { h = h|0 reshapeTexture(this, this._shape[0], h) return h } } }) proto.bind = function(unit) { var gl = this.gl if(unit !== undefined) { gl.activeTexture(gl.TEXTURE0 + (unit|0)) } gl.bindTexture(gl.TEXTURE_2D, this.handle) if(unit !== undefined) { return (unit|0) } return gl.getParameter(gl.ACTIVE_TEXTURE) - gl.TEXTURE0 } proto.dispose = function() { this.gl.deleteTexture(this.handle) } proto.generateMipmap = function() { this.bind() this.gl.generateMipmap(this.gl.TEXTURE_2D) //Update mip levels var l = Math.min(this._shape[0], this._shape[1]) for(var i=0; l>0; ++i, l>>>=1) { if(this._mipLevels.indexOf(i) < 0) { this._mipLevels.push(i) } } } proto.setPixels = function(data, x_off, y_off, mip_level) { var gl = this.gl this.bind() if(Array.isArray(x_off)) { mip_level = y_off y_off = x_off[1]|0 x_off = x_off[0]|0 } else { x_off = x_off || 0 y_off = y_off || 0 } mip_level = mip_level || 0 if(data instanceof HTMLCanvasElement || data instanceof ImageData || data instanceof HTMLImageElement || data instanceof HTMLVideoElement) { var needsMip = this._mipLevels.indexOf(mip_level) < 0 if(needsMip) { gl.texImage2D(gl.TEXTURE_2D, 0, this.format, this.format, this.type, data) this._mipLevels.push(mip_level) } else { gl.texSubImage2D(gl.TEXTURE_2D, mip_level, x_off, y_off, this.format, this.type, data) } } else if(data.shape && data.stride && data.data) { if(data.shape.length < 2 || x_off + data.shape[1] > this._shape[1]>>>mip_level || y_off + data.shape[0] > this._shape[0]>>>mip_level || x_off < 0 || y_off < 0) { throw new Error('gl-texture2d: Texture dimensions are out of bounds') } texSubImageArray(gl, x_off, y_off, mip_level, this.format, this.type, this._mipLevels, data) } else { throw new Error('gl-texture2d: Unsupported data type') } } function isPacked(shape, stride) { if(shape.length === 3) { return (stride[2] === 1) && (stride[1] === shape[0]*shape[2]) && (stride[0] === shape[2]) } return (stride[0] === 1) && (stride[1] === shape[0]) } function texSubImageArray(gl, x_off, y_off, mip_level, cformat, ctype, mipLevels, array) { var dtype = array.dtype var shape = array.shape.slice() if(shape.length < 2 || shape.length > 3) { throw new Error('gl-texture2d: Invalid ndarray, must be 2d or 3d') } var type = 0, format = 0 var packed = isPacked(shape, array.stride.slice()) if(dtype === 'float32') { type = gl.FLOAT } else if(dtype === 'float64') { type = gl.FLOAT packed = false dtype = 'float32' } else if(dtype === 'uint8') { type = gl.UNSIGNED_BYTE } else { type = gl.UNSIGNED_BYTE packed = false dtype = 'uint8' } var channels = 1 if(shape.length === 2) { format = gl.LUMINANCE shape = [shape[0], shape[1], 1] array = ndarray(array.data, shape, [array.stride[0], array.stride[1], 1], array.offset) } else if(shape.length === 3) { if(shape[2] === 1) { format = gl.ALPHA } else if(shape[2] === 2) { format = gl.LUMINANCE_ALPHA } else if(shape[2] === 3) { format = gl.RGB } else if(shape[2] === 4) { format = gl.RGBA } else { throw new Error('gl-texture2d: Invalid shape for pixel coords') } channels = shape[2] } else { throw new Error('gl-texture2d: Invalid shape for texture') } //For 1-channel textures allow conversion between formats if((format === gl.LUMINANCE || format === gl.ALPHA) && (cformat === gl.LUMINANCE || cformat === gl.ALPHA)) { format = cformat } if(format !== cformat) { throw new Error('gl-texture2d: Incompatible texture format for setPixels') } var size = array.size var needsMip = mipLevels.indexOf(mip_level) < 0 if(needsMip) { mipLevels.push(mip_level) } if(type === ctype && packed) { //Array data types are compatible, can directly copy into texture if(array.offset === 0 && array.data.length === size) { if(needsMip) { gl.texImage2D(gl.TEXTURE_2D, mip_level, cformat, shape[0], shape[1], 0, cformat, ctype, array.data) } else { gl.texSubImage2D(gl.TEXTURE_2D, mip_level, x_off, y_off, shape[0], shape[1], cformat, ctype, array.data) } } else { if(needsMip) { gl.texImage2D(gl.TEXTURE_2D, mip_level, cformat, shape[0], shape[1], 0, cformat, ctype, array.data.subarray(array.offset, array.offset+size)) } else { gl.texSubImage2D(gl.TEXTURE_2D, mip_level, x_off, y_off, shape[0], shape[1], cformat, ctype, array.data.subarray(array.offset, array.offset+size)) } } } else { //Need to do type conversion to pack data into buffer var pack_buffer if(ctype === gl.FLOAT) { pack_buffer = pool.mallocFloat32(size) } else { pack_buffer = pool.mallocUint8(size) } var pack_view = ndarray(pack_buffer, shape, [shape[2], shape[2]*shape[0], 1]) if(type === gl.FLOAT && ctype === gl.UNSIGNED_BYTE) { convertFloatToUint8(pack_view, array) } else { ops.assign(pack_view, array) } if(needsMip) { gl.texImage2D(gl.TEXTURE_2D, mip_level, cformat, shape[0], shape[1], 0, cformat, ctype, pack_buffer.subarray(0, size)) } else { gl.texSubImage2D(gl.TEXTURE_2D, mip_level, x_off, y_off, shape[0], shape[1], cformat, ctype, pack_buffer.subarray(0, size)) } if(ctype === gl.FLOAT) { pool.freeFloat32(pack_buffer) } else { pool.freeUint8(pack_buffer) } } } function initTexture(gl) { var tex = gl.createTexture() gl.bindTexture(gl.TEXTURE_2D, tex) gl.texParameteri(gl.TEXTURE_2D, gl.TEXTURE_MIN_FILTER, gl.NEAREST) gl.texParameteri(gl.TEXTURE_2D, gl.TEXTURE_MAG_FILTER, gl.NEAREST) gl.texParameteri(gl.TEXTURE_2D, gl.TEXTURE_WRAP_S, gl.CLAMP_TO_EDGE) gl.texParameteri(gl.TEXTURE_2D, gl.TEXTURE_WRAP_T, gl.CLAMP_TO_EDGE) return tex } function createTextureShape(gl, width, height, format, type) { var maxTextureSize = gl.getParameter(gl.MAX_TEXTURE_SIZE) if(width < 0 || width > maxTextureSize || height < 0 || height > maxTextureSize) { throw new Error('gl-texture2d: Invalid texture shape') } if(type === gl.FLOAT && !gl.getExtension('OES_texture_float')) { throw new Error('gl-texture2d: Floating point textures not supported on this platform') } var tex = initTexture(gl) gl.texImage2D(gl.TEXTURE_2D, 0, format, width, height, 0, format, type, null) return new Texture2D(gl, tex, width, height, format, type) } function createTextureDOM(gl, element, format, type) { var tex = initTexture(gl) gl.texImage2D(gl.TEXTURE_2D, 0, format, format, type, element) return new Texture2D(gl, tex, element.width|0, element.height|0, format, type) } //Creates a texture from an ndarray function createTextureArray(gl, array) { var dtype = array.dtype var shape = array.shape.slice() var maxSize = gl.getParameter(gl.MAX_TEXTURE_SIZE) if(shape[0] < 0 || shape[0] > maxSize || shape[1] < 0 || shape[1] > maxSize) { throw new Error('gl-texture2d: Invalid texture size') } var packed = isPacked(shape, array.stride.slice()) var type = 0 if(dtype === 'float32') { type = gl.FLOAT } else if(dtype === 'float64') { type = gl.FLOAT packed = false dtype = 'float32' } else if(dtype === 'uint8') { type = gl.UNSIGNED_BYTE } else { type = gl.UNSIGNED_BYTE packed = false dtype = 'uint8' } var format = 0 if(shape.length === 2) { format = gl.LUMINANCE shape = [shape[0], shape[1], 1] array = ndarray(array.data, shape, [array.stride[0], array.stride[1], 1], array.offset) } else if(shape.length === 3) { if(shape[2] === 1) { format = gl.ALPHA } else if(shape[2] === 2) { format = gl.LUMINANCE_ALPHA } else if(shape[2] === 3) { format = gl.RGB } else if(shape[2] === 4) { format = gl.RGBA } else { throw new Error('gl-texture2d: Invalid shape for pixel coords') } } else { throw new Error('gl-texture2d: Invalid shape for texture') } if(type === gl.FLOAT && !gl.getExtension('OES_texture_float')) { type = gl.UNSIGNED_BYTE packed = false } var buffer, buf_store var size = array.size if(!packed) { var stride = [shape[2], shape[2]*shape[0], 1] buf_store = pool.malloc(size, dtype) var buf_array = ndarray(buf_store, shape, stride, 0) if((dtype === 'float32' || dtype === 'float64') && type === gl.UNSIGNED_BYTE) { convertFloatToUint8(buf_array, array) } else { ops.assign(buf_array, array) } buffer = buf_store.subarray(0, size) } else if (array.offset === 0 && array.data.length === size) { buffer = array.data } else { buffer = array.data.subarray(array.offset, array.offset + size) } var tex = initTexture(gl) gl.texImage2D(gl.TEXTURE_2D, 0, format, shape[0], shape[1], 0, format, type, buffer) if(!packed) { pool.free(buf_store) } return new Texture2D(gl, tex, shape[0], shape[1], format, type) } function createTexture2D(gl) { if(arguments.length <= 1) { throw new Error('gl-texture2d: Missing arguments for texture2d constructor') } if(!linearTypes) { lazyInitLinearTypes(gl) } if(typeof arguments[1] === 'number') { return createTextureShape(gl, arguments[1], arguments[2], arguments[3]||gl.RGBA, arguments[4]||gl.UNSIGNED_BYTE) } if(Array.isArray(arguments[1])) { return createTextureShape(gl, arguments[1][0]|0, arguments[1][1]|0, arguments[2]||gl.RGBA, arguments[3]||gl.UNSIGNED_BYTE) } if(typeof arguments[1] === 'object') { var obj = arguments[1] if(obj instanceof HTMLCanvasElement || obj instanceof HTMLImageElement || obj instanceof HTMLVideoElement || obj instanceof ImageData) { return createTextureDOM(gl, obj, arguments[2]||gl.RGBA, arguments[3]||gl.UNSIGNED_BYTE) } else if(obj.shape && obj.data && obj.stride) { return createTextureArray(gl, obj) } } throw new Error('gl-texture2d: Invalid arguments for texture2d constructor') } },{"ndarray":208,"ndarray-ops":207,"typedarray-pool":233}],186:[function(require,module,exports){ "use strict" function doBind(gl, elements, attributes) { if(elements) { elements.bind() } else { gl.bindBuffer(gl.ELEMENT_ARRAY_BUFFER, null) } var nattribs = gl.getParameter(gl.MAX_VERTEX_ATTRIBS)|0 if(attributes) { if(attributes.length > nattribs) { throw new Error("gl-vao: Too many vertex attributes") } for(var i=0; i 0) { code.push(",") } code.push("tuple[", i, "]") } code.push(")}return orient") var proc = new Function("test", code.join("")) var test = orient[d+1] if(!test) { test = orient } return proc(test) } var BAKED = [] function Triangulation(dimension, vertices, simplices) { this.dimension = dimension this.vertices = vertices this.simplices = simplices this.interior = simplices.filter(function(c) { return !c.boundary }) this.tuple = new Array(dimension+1) for(var i=0; i<=dimension; ++i) { this.tuple[i] = this.vertices[i] } var o = BAKED[dimension] if(!o) { o = BAKED[dimension] = bakeOrient(dimension) } this.orient = o } var proto = Triangulation.prototype //Degenerate situation where we are on boundary, but coplanar to face proto.handleBoundaryDegeneracy = function(cell, point) { var d = this.dimension var n = this.vertices.length - 1 var tuple = this.tuple var verts = this.vertices //Dumb solution: Just do dfs from boundary cell until we find any peak, or terminate var toVisit = [ cell ] cell.lastVisited = -n while(toVisit.length > 0) { cell = toVisit.pop() var cellVerts = cell.vertices var cellAdj = cell.adjacent for(var i=0; i<=d; ++i) { var neighbor = cellAdj[i] if(!neighbor.boundary || neighbor.lastVisited <= -n) { continue } var nv = neighbor.vertices for(var j=0; j<=d; ++j) { var vv = nv[j] if(vv < 0) { tuple[j] = point } else { tuple[j] = verts[vv] } } var o = this.orient() if(o > 0) { return neighbor } neighbor.lastVisited = -n if(o === 0) { toVisit.push(neighbor) } } } return null } proto.walk = function(point, random) { //Alias local properties var n = this.vertices.length - 1 var d = this.dimension var verts = this.vertices var tuple = this.tuple //Compute initial jump cell var initIndex = random ? (this.interior.length * Math.random())|0 : (this.interior.length-1) var cell = this.interior[ initIndex ] //Start walking outerLoop: while(!cell.boundary) { var cellVerts = cell.vertices var cellAdj = cell.adjacent for(var i=0; i<=d; ++i) { tuple[i] = verts[cellVerts[i]] } cell.lastVisited = n //Find farthest adjacent cell for(var i=0; i<=d; ++i) { var neighbor = cellAdj[i] if(neighbor.lastVisited >= n) { continue } var prev = tuple[i] tuple[i] = point var o = this.orient() tuple[i] = prev if(o < 0) { cell = neighbor continue outerLoop } else { if(!neighbor.boundary) { neighbor.lastVisited = n } else { neighbor.lastVisited = -n } } } return } return cell } proto.addPeaks = function(point, cell) { var n = this.vertices.length - 1 var d = this.dimension var verts = this.vertices var tuple = this.tuple var interior = this.interior var simplices = this.simplices //Walking finished at boundary, time to add peaks var tovisit = [ cell ] //Stretch initial boundary cell into a peak cell.lastVisited = n cell.vertices[cell.vertices.indexOf(-1)] = n cell.boundary = false interior.push(cell) //Record a list of all new boundaries created by added peaks so we can glue them together when we are all done var glueFacets = [] //Do a traversal of the boundary walking outward from starting peak while(tovisit.length > 0) { //Pop off peak and walk over adjacent cells var cell = tovisit.pop() var cellVerts = cell.vertices var cellAdj = cell.adjacent var indexOfN = cellVerts.indexOf(n) if(indexOfN < 0) { continue } for(var i=0; i<=d; ++i) { if(i === indexOfN) { continue } //For each boundary neighbor of the cell var neighbor = cellAdj[i] if(!neighbor.boundary || neighbor.lastVisited >= n) { continue } var nv = neighbor.vertices //Test if neighbor is a peak if(neighbor.lastVisited !== -n) { //Compute orientation of p relative to each boundary peak var indexOfNeg1 = 0 for(var j=0; j<=d; ++j) { if(nv[j] < 0) { indexOfNeg1 = j tuple[j] = point } else { tuple[j] = verts[nv[j]] } } var o = this.orient() //Test if neighbor cell is also a peak if(o > 0) { nv[indexOfNeg1] = n neighbor.boundary = false interior.push(neighbor) tovisit.push(neighbor) neighbor.lastVisited = n continue } else { neighbor.lastVisited = -n } } var na = neighbor.adjacent //Otherwise, replace neighbor with new face var vverts = cellVerts.slice() var vadj = cellAdj.slice() var ncell = new Simplex(vverts, vadj, true) simplices.push(ncell) //Connect to neighbor var opposite = na.indexOf(cell) if(opposite < 0) { continue } na[opposite] = ncell vadj[indexOfN] = neighbor //Connect to cell vverts[i] = -1 vadj[i] = cell cellAdj[i] = ncell //Flip facet ncell.flip() //Add to glue list for(var j=0; j<=d; ++j) { var uu = vverts[j] if(uu < 0 || uu === n) { continue } var nface = new Array(d-1) var nptr = 0 for(var k=0; k<=d; ++k) { var vv = vverts[k] if(vv < 0 || k === j) { continue } nface[nptr++] = vv } glueFacets.push(new GlueFacet(nface, ncell, j)) } } } //Glue boundary facets together glueFacets.sort(compareGlue) for(var i=0; i+1= 0) { bcell[ptr++] = cv[j] } else { parity = j&1 } } if(parity === (d&1)) { var t = bcell[0] bcell[0] = bcell[1] bcell[1] = t } boundary.push(bcell) } } return boundary } function incrementalConvexHull(points, randomSearch) { var n = points.length if(n === 0) { throw new Error("Must have at least d+1 points") } var d = points[0].length if(n <= d) { throw new Error("Must input at least d+1 points") } //FIXME: This could be degenerate, but need to select d+1 non-coplanar points to bootstrap process var initialSimplex = points.slice(0, d+1) //Make sure initial simplex is positively oriented var o = orient.apply(void 0, initialSimplex) if(o === 0) { throw new Error("Input not in general position") } var initialCoords = new Array(d+1) for(var i=0; i<=d; ++i) { initialCoords[i] = i } if(o < 0) { initialCoords[0] = 1 initialCoords[1] = 0 } //Create initial topological index, glue pointers together (kind of messy) var initialCell = new Simplex(initialCoords, new Array(d+1), false) var boundary = initialCell.adjacent var list = new Array(d+2) for(var i=0; i<=d; ++i) { var verts = initialCoords.slice() for(var j=0; j<=d; ++j) { if(j === i) { verts[j] = -1 } } var t = verts[0] verts[0] = verts[1] verts[1] = t var cell = new Simplex(verts, new Array(d+1), true) boundary[i] = cell list[i] = cell } list[d+1] = initialCell for(var i=0; i<=d; ++i) { var verts = boundary[i].vertices var adj = boundary[i].adjacent for(var j=0; j<=d; ++j) { var v = verts[j] if(v < 0) { adj[j] = initialCell continue } for(var k=0; k<=d; ++k) { if(boundary[k].vertices.indexOf(v) < 0) { adj[j] = boundary[k] } } } } //Initialize triangles var triangles = new Triangulation(d, initialSimplex, list) //Insert remaining points var useRandom = !!randomSearch for(var i=d+1; i> 1 , s = compareCells(cells[mid], c) if(s <= 0) { if(s === 0) { r = mid } lo = mid + 1 } else if(s > 0) { hi = mid - 1 } } return r } exports.findCell = findCell; //Builds an index for an n-cell. This is more general than dual, but less efficient function incidence(from_cells, to_cells) { var index = new Array(from_cells.length) for(var i=0, il=index.length; i= from_cells.length || compareCells(from_cells[idx], b) !== 0) { break } } } } return index } exports.incidence = incidence //Computes the dual of the mesh. This is basically an optimized version of buildIndex for the situation where from_cells is just the list of vertices function dual(cells, vertex_count) { if(!vertex_count) { return incidence(unique(skeleton(cells, 0)), cells, 0) } var res = new Array(vertex_count) for(var i=0; i>> k) & 1) { b.push(c[k]) } } result.push(b) } } return normalize(result) } exports.explode = explode //Enumerates all of the n-cells of a cell complex function skeleton(cells, n) { if(n < 0) { return [] } var result = [] , k0 = (1<<(n+1))-1 for(var i=0; i 0) { return 1<<(b-1) } } else if('button' in ev) { var b = ev.button if(b === 1) { return 4 } else if(b === 2) { return 2 } else if(b >= 0) { return 1<>", rrshift: ">>>" } ;(function(){ for(var id in assign_ops) { var op = assign_ops[id] exports[id] = makeOp({ args: ["array","array","array"], body: {args:["a","b","c"], body: "a=b"+op+"c"}, funcName: id }) exports[id+"eq"] = makeOp({ args: ["array","array"], body: {args:["a","b"], body:"a"+op+"=b"}, rvalue: true, funcName: id+"eq" }) exports[id+"s"] = makeOp({ args: ["array", "array", "scalar"], body: {args:["a","b","s"], body:"a=b"+op+"s"}, funcName: id+"s" }) exports[id+"seq"] = makeOp({ args: ["array","scalar"], body: {args:["a","s"], body:"a"+op+"=s"}, rvalue: true, funcName: id+"seq" }) } })(); var unary_ops = { not: "!", bnot: "~", neg: "-", recip: "1.0/" } ;(function(){ for(var id in unary_ops) { var op = unary_ops[id] exports[id] = makeOp({ args: ["array", "array"], body: {args:["a","b"], body:"a="+op+"b"}, funcName: id }) exports[id+"eq"] = makeOp({ args: ["array"], body: {args:["a"], body:"a="+op+"a"}, rvalue: true, count: 2, funcName: id+"eq" }) } })(); var binary_ops = { and: "&&", or: "||", eq: "===", neq: "!==", lt: "<", gt: ">", leq: "<=", geq: ">=" } ;(function() { for(var id in binary_ops) { var op = binary_ops[id] exports[id] = makeOp({ args: ["array","array","array"], body: {args:["a", "b", "c"], body:"a=b"+op+"c"}, funcName: id }) exports[id+"s"] = makeOp({ args: ["array","array","scalar"], body: {args:["a", "b", "s"], body:"a=b"+op+"s"}, funcName: id+"s" }) exports[id+"eq"] = makeOp({ args: ["array", "array"], body: {args:["a", "b"], body:"a=a"+op+"b"}, rvalue:true, count:2, funcName: id+"eq" }) exports[id+"seq"] = makeOp({ args: ["array", "scalar"], body: {args:["a","s"], body:"a=a"+op+"s"}, rvalue:true, count:2, funcName: id+"seq" }) } })(); var math_unary = [ "abs", "acos", "asin", "atan", "ceil", "cos", "exp", "floor", "log", "round", "sin", "sqrt", "tan" ] ;(function() { for(var i=0; ithis_s){this_s=-a}else if(a>this_s){this_s=a}", localVars: [], thisVars: ["this_s"]}, post: {args:[], localVars:[], thisVars:["this_s"], body:"return this_s"}, funcName: "norminf" }) exports.norm1 = compile({ args:["array"], pre: {args:[], localVars:[], thisVars:["this_s"], body:"this_s=0"}, body: {args:[{name:"a", lvalue:false, rvalue:true, count:3}], body: "this_s+=a<0?-a:a", localVars: [], thisVars: ["this_s"]}, post: {args:[], localVars:[], thisVars:["this_s"], body:"return this_s"}, funcName: "norm1" }) exports.sup = compile({ args: [ "array" ], pre: { body: "this_h=-Infinity", args: [], thisVars: [ "this_h" ], localVars: [] }, body: { body: "if(_inline_1_arg0_>this_h)this_h=_inline_1_arg0_", args: [{"name":"_inline_1_arg0_","lvalue":false,"rvalue":true,"count":2} ], thisVars: [ "this_h" ], localVars: [] }, post: { body: "return this_h", args: [], thisVars: [ "this_h" ], localVars: [] } }) exports.inf = compile({ args: [ "array" ], pre: { body: "this_h=Infinity", args: [], thisVars: [ "this_h" ], localVars: [] }, body: { body: "if(_inline_1_arg0_this_v){this_v=_inline_1_arg1_;for(var _inline_1_k=0;_inline_1_k<_inline_1_arg0_.length;++_inline_1_k){this_i[_inline_1_k]=_inline_1_arg0_[_inline_1_k]}}}", args:[ {name:"_inline_1_arg0_",lvalue:false,rvalue:true,count:2}, {name:"_inline_1_arg1_",lvalue:false,rvalue:true,count:2}], thisVars:["this_i","this_v"], localVars:["_inline_1_k"]}, post:{ body:"{return this_i}", args:[], thisVars:["this_i"], localVars:[]} }) exports.random = makeOp({ args: ["array"], pre: {args:[], body:"this_f=Math.random", thisVars:["this_f"]}, body: {args: ["a"], body:"a=this_f()", thisVars:["this_f"]}, funcName: "random" }) exports.assign = makeOp({ args:["array", "array"], body: {args:["a", "b"], body:"a=b"}, funcName: "assign" }) exports.assigns = makeOp({ args:["array", "scalar"], body: {args:["a", "b"], body:"a=b"}, funcName: "assigns" }) exports.equals = compile({ args:["array", "array"], pre: EmptyProc, body: {args:[{name:"x", lvalue:false, rvalue:true, count:1}, {name:"y", lvalue:false, rvalue:true, count:1}], body: "if(x!==y){return false}", localVars: [], thisVars: []}, post: {args:[], localVars:[], thisVars:[], body:"return true"}, funcName: "equals" }) },{"cwise-compiler":66}],208:[function(require,module,exports){ var iota = require("iota-array") var isBuffer = require("is-buffer") var hasTypedArrays = ((typeof Float64Array) !== "undefined") function compare1st(a, b) { return a[0] - b[0] } function order() { var stride = this.stride var terms = new Array(stride.length) var i for(i=0; iMath.abs(this.stride[1]))?[1,0]:[0,1]}})") } else if(dimension === 3) { code.push( "var s0=Math.abs(this.stride[0]),s1=Math.abs(this.stride[1]),s2=Math.abs(this.stride[2]);\ if(s0>s1){\ if(s1>s2){\ return [2,1,0];\ }else if(s0>s2){\ return [1,2,0];\ }else{\ return [1,0,2];\ }\ }else if(s0>s2){\ return [2,0,1];\ }else if(s2>s1){\ return [0,1,2];\ }else{\ return [0,2,1];\ }}})") } } else { code.push("ORDER})") } } //view.set(i0, ..., v): code.push( "proto.set=function "+className+"_set("+args.join(",")+",v){") if(useGetters) { code.push("return this.data.set("+index_str+",v)}") } else { code.push("return this.data["+index_str+"]=v}") } //view.get(i0, ...): code.push("proto.get=function "+className+"_get("+args.join(",")+"){") if(useGetters) { code.push("return this.data.get("+index_str+")}") } else { code.push("return this.data["+index_str+"]}") } //view.index: code.push( "proto.index=function "+className+"_index(", args.join(), "){return "+index_str+"}") //view.hi(): code.push("proto.hi=function "+className+"_hi("+args.join(",")+"){return new "+className+"(this.data,"+ indices.map(function(i) { return ["(typeof i",i,"!=='number'||i",i,"<0)?this.shape[", i, "]:i", i,"|0"].join("") }).join(",")+","+ indices.map(function(i) { return "this.stride["+i + "]" }).join(",")+",this.offset)}") //view.lo(): var a_vars = indices.map(function(i) { return "a"+i+"=this.shape["+i+"]" }) var c_vars = indices.map(function(i) { return "c"+i+"=this.stride["+i+"]" }) code.push("proto.lo=function "+className+"_lo("+args.join(",")+"){var b=this.offset,d=0,"+a_vars.join(",")+","+c_vars.join(",")) for(var i=0; i=0){\ d=i"+i+"|0;\ b+=c"+i+"*d;\ a"+i+"-=d}") } code.push("return new "+className+"(this.data,"+ indices.map(function(i) { return "a"+i }).join(",")+","+ indices.map(function(i) { return "c"+i }).join(",")+",b)}") //view.step(): code.push("proto.step=function "+className+"_step("+args.join(",")+"){var "+ indices.map(function(i) { return "a"+i+"=this.shape["+i+"]" }).join(",")+","+ indices.map(function(i) { return "b"+i+"=this.stride["+i+"]" }).join(",")+",c=this.offset,d=0,ceil=Math.ceil") for(var i=0; i=0){c=(c+this.stride["+i+"]*i"+i+")|0}else{a.push(this.shape["+i+"]);b.push(this.stride["+i+"])}") } code.push("var ctor=CTOR_LIST[a.length+1];return ctor(this.data,a,b,c)}") //Add return statement code.push("return function construct_"+className+"(data,shape,stride,offset){return new "+className+"(data,"+ indices.map(function(i) { return "shape["+i+"]" }).join(",")+","+ indices.map(function(i) { return "stride["+i+"]" }).join(",")+",offset)}") //Compile procedure var procedure = new Function("CTOR_LIST", "ORDER", code.join("\n")) return procedure(CACHED_CONSTRUCTORS[dtype], order) } function arrayDType(data) { if(isBuffer(data)) { return "buffer" } if(hasTypedArrays) { switch(Object.prototype.toString.call(data)) { case "[object Float64Array]": return "float64" case "[object Float32Array]": return "float32" case "[object Int8Array]": return "int8" case "[object Int16Array]": return "int16" case "[object Int32Array]": return "int32" case "[object Uint8Array]": return "uint8" case "[object Uint16Array]": return "uint16" case "[object Uint32Array]": return "uint32" case "[object Uint8ClampedArray]": return "uint8_clamped" } } if(Array.isArray(data)) { return "array" } return "generic" } var CACHED_CONSTRUCTORS = { "float32":[], "float64":[], "int8":[], "int16":[], "int32":[], "uint8":[], "uint16":[], "uint32":[], "array":[], "uint8_clamped":[], "buffer":[], "generic":[] } ;(function() { for(var id in CACHED_CONSTRUCTORS) { CACHED_CONSTRUCTORS[id].push(compileConstructor(id, -1)) } }); function wrappedNDArrayCtor(data, shape, stride, offset) { if(data === undefined) { var ctor = CACHED_CONSTRUCTORS.array[0] return ctor([]) } else if(typeof data === "number") { data = [data] } if(shape === undefined) { shape = [ data.length ] } var d = shape.length if(stride === undefined) { stride = new Array(d) for(var i=d-1, sz=1; i>=0; --i) { stride[i] = sz sz *= shape[i] } } if(offset === undefined) { offset = 0 for(var i=0; i * License: MIT * * `npm install is-buffer` */ module.exports = function (obj) { return !!(obj != null && (obj._isBuffer || // For Safari 5-7 (missing Object.prototype.constructor) (obj.constructor && typeof obj.constructor.isBuffer === 'function' && obj.constructor.isBuffer(obj)) )) } },{}],210:[function(require,module,exports){ (function (global){ module.exports = global.performance && global.performance.now ? function now() { return performance.now() } : Date.now || function now() { return +new Date } }).call(this,typeof global !== "undefined" ? global : typeof self !== "undefined" ? self : typeof window !== "undefined" ? window : {}) },{}],211:[function(require,module,exports){ "use strict" var determinant = require("robust-determinant") var NUM_EXPAND = 6 function generateSolver(n) { var funcName = "robustLinearSolve" + n + "d" var code = ["function ", funcName, "(A,b){return ["] for(var i=0; i 0) { code.push(",") } code.push("[") for(var k=0; k 0) { code.push(",") } if(k === i) { code.push("+b[", j, "]") } else { code.push("+A[", j, "][", k, "]") } } code.push("]") } code.push("]),") } code.push("det(A)]}return ", funcName) var proc = new Function("det", code.join("")) if(n < 6) { return proc(determinant[n]) } return proc(determinant) } function robustLinearSolve0d() { return [ 0 ] } function robustLinearSolve1d(A, b) { return [ [ b[0] ], [ A[0][0] ] ] } var CACHE = [ robustLinearSolve0d, robustLinearSolve1d ] function generateDispatch() { while(CACHE.length < NUM_EXPAND) { CACHE.push(generateSolver(CACHE.length)) } var procArgs = [] var code = ["function dispatchLinearSolve(A,b){switch(A.length){"] for(var i=0; i=0; --i) { var a = Q var b = e[i] Q = a + b var bv = Q - a var q = b - bv if(q) { e[--bottom] = Q Q = q } } var top = 0 for(var i=bottom; i>1 return ["sum(", generateSum(expr.slice(0, m)), ",", generateSum(expr.slice(m)), ")"].join("") } } function determinant(m) { if(m.length === 2) { return ["sum(prod(", m[0][0], ",", m[1][1], "),prod(-", m[0][1], ",", m[1][0], "))"].join("") } else { var expr = [] for(var i=0; i>1 return ["sum(", generateSum(expr.slice(0, m)), ",", generateSum(expr.slice(m)), ")"].join("") } } function determinant(m) { if(m.length === 2) { return [["sum(prod(", m[0][0], ",", m[1][1], "),prod(-", m[0][1], ",", m[1][0], "))"].join("")] } else { var expr = [] for(var i=0; i 0) { if(r <= 0) { return det } else { s = l + r } } else if(l < 0) { if(r >= 0) { return det } else { s = -(l + r) } } else { return det } var tol = ERRBOUND3 * s if(det >= tol || det <= -tol) { return det } return orientation3Exact(a, b, c) }, function orientation4(a,b,c,d) { var adx = a[0] - d[0] var bdx = b[0] - d[0] var cdx = c[0] - d[0] var ady = a[1] - d[1] var bdy = b[1] - d[1] var cdy = c[1] - d[1] var adz = a[2] - d[2] var bdz = b[2] - d[2] var cdz = c[2] - d[2] var bdxcdy = bdx * cdy var cdxbdy = cdx * bdy var cdxady = cdx * ady var adxcdy = adx * cdy var adxbdy = adx * bdy var bdxady = bdx * ady var det = adz * (bdxcdy - cdxbdy) + bdz * (cdxady - adxcdy) + cdz * (adxbdy - bdxady) var permanent = (Math.abs(bdxcdy) + Math.abs(cdxbdy)) * Math.abs(adz) + (Math.abs(cdxady) + Math.abs(adxcdy)) * Math.abs(bdz) + (Math.abs(adxbdy) + Math.abs(bdxady)) * Math.abs(cdz) var tol = ERRBOUND4 * permanent if ((det > tol) || (-det > tol)) { return det } return orientation4Exact(a,b,c,d) } ] function slowOrient(args) { var proc = CACHED[args.length] if(!proc) { proc = CACHED[args.length] = orientation(args.length) } return proc.apply(undefined, args) } function generateOrientationProc() { while(CACHED.length <= NUM_EXPAND) { CACHED.push(orientation(CACHED.length)) } var args = [] var procArgs = ["slow"] for(var i=0; i<=NUM_EXPAND; ++i) { args.push("a" + i) procArgs.push("o" + i) } var code = [ "function getOrientation(", args.join(), "){switch(arguments.length){case 0:case 1:return 0;" ] for(var i=2; i<=NUM_EXPAND; ++i) { code.push("case ", i, ":return o", i, "(", args.slice(0, i).join(), ");") } code.push("}var s=new Array(arguments.length);for(var i=0;i= nf)) { a = ei eptr += 1 if(eptr < ne) { ei = e[eptr] ea = abs(ei) } } else { a = fi fptr += 1 if(fptr < nf) { fi = -f[fptr] fa = abs(fi) } } var x = a + b var bv = x - a var y = b - bv var q0 = y var q1 = x var _x, _bv, _av, _br, _ar while(eptr < ne && fptr < nf) { if(ea < fa) { a = ei eptr += 1 if(eptr < ne) { ei = e[eptr] ea = abs(ei) } } else { a = fi fptr += 1 if(fptr < nf) { fi = -f[fptr] fa = abs(fi) } } b = q0 x = a + b bv = x - a y = b - bv if(y) { g[count++] = y } _x = q1 + x _bv = _x - q1 _av = _x - _bv _br = x - _bv _ar = q1 - _av q0 = _ar + _br q1 = _x } while(eptr < ne) { a = ei b = q0 x = a + b bv = x - a y = b - bv if(y) { g[count++] = y } _x = q1 + x _bv = _x - q1 _av = _x - _bv _br = x - _bv _ar = q1 - _av q0 = _ar + _br q1 = _x eptr += 1 if(eptr < ne) { ei = e[eptr] } } while(fptr < nf) { a = fi b = q0 x = a + b bv = x - a y = b - bv if(y) { g[count++] = y } _x = q1 + x _bv = _x - q1 _av = _x - _bv _br = x - _bv _ar = q1 - _av q0 = _ar + _br q1 = _x fptr += 1 if(fptr < nf) { fi = -f[fptr] } } if(q0) { g[count++] = q0 } if(q1) { g[count++] = q1 } if(!count) { g[count++] = 0.0 } g.length = count return g } },{}],217:[function(require,module,exports){ "use strict" module.exports = linearExpansionSum //Easy case: Add two scalars function scalarScalar(a, b) { var x = a + b var bv = x - a var av = x - bv var br = b - bv var ar = a - av var y = ar + br if(y) { return [y, x] } return [x] } function linearExpansionSum(e, f) { var ne = e.length|0 var nf = f.length|0 if(ne === 1 && nf === 1) { return scalarScalar(e[0], f[0]) } var n = ne + nf var g = new Array(n) var count = 0 var eptr = 0 var fptr = 0 var abs = Math.abs var ei = e[eptr] var ea = abs(ei) var fi = f[fptr] var fa = abs(fi) var a, b if(ea < fa) { b = ei eptr += 1 if(eptr < ne) { ei = e[eptr] ea = abs(ei) } } else { b = fi fptr += 1 if(fptr < nf) { fi = f[fptr] fa = abs(fi) } } if((eptr < ne && ea < fa) || (fptr >= nf)) { a = ei eptr += 1 if(eptr < ne) { ei = e[eptr] ea = abs(ei) } } else { a = fi fptr += 1 if(fptr < nf) { fi = f[fptr] fa = abs(fi) } } var x = a + b var bv = x - a var y = b - bv var q0 = y var q1 = x var _x, _bv, _av, _br, _ar while(eptr < ne && fptr < nf) { if(ea < fa) { a = ei eptr += 1 if(eptr < ne) { ei = e[eptr] ea = abs(ei) } } else { a = fi fptr += 1 if(fptr < nf) { fi = f[fptr] fa = abs(fi) } } b = q0 x = a + b bv = x - a y = b - bv if(y) { g[count++] = y } _x = q1 + x _bv = _x - q1 _av = _x - _bv _br = x - _bv _ar = q1 - _av q0 = _ar + _br q1 = _x } while(eptr < ne) { a = ei b = q0 x = a + b bv = x - a y = b - bv if(y) { g[count++] = y } _x = q1 + x _bv = _x - q1 _av = _x - _bv _br = x - _bv _ar = q1 - _av q0 = _ar + _br q1 = _x eptr += 1 if(eptr < ne) { ei = e[eptr] } } while(fptr < nf) { a = fi b = q0 x = a + b bv = x - a y = b - bv if(y) { g[count++] = y } _x = q1 + x _bv = _x - q1 _av = _x - _bv _br = x - _bv _ar = q1 - _av q0 = _ar + _br q1 = _x fptr += 1 if(fptr < nf) { fi = f[fptr] } } if(q0) { g[count++] = q0 } if(q1) { g[count++] = q1 } if(!count) { g[count++] = 0.0 } g.length = count return g } },{}],218:[function(require,module,exports){ 'use strict' module.exports = toSuperScript var SUPERSCRIPTS = { ' ': ' ', '0': '⁰', '1': '¹', '2': '²', '3': '³', '4': '⁴', '5': '⁵', '6': '⁶', '7': '⁷', '8': '⁸', '9': '⁹', '+': '⁺', '-': '⁻', 'a': 'ᵃ', 'b': 'ᵇ', 'c': 'ᶜ', 'd': 'ᵈ', 'e': 'ᵉ', 'f': 'ᶠ', 'g': 'ᵍ', 'h': 'ʰ', 'i': 'ⁱ', 'j': 'ʲ', 'k': 'ᵏ', 'l': 'ˡ', 'm': 'ᵐ', 'n': 'ⁿ', 'o': 'ᵒ', 'p': 'ᵖ', 'r': 'ʳ', 's': 'ˢ', 't': 'ᵗ', 'u': 'ᵘ', 'v': 'ᵛ', 'w': 'ʷ', 'x': 'ˣ', 'y': 'ʸ', 'z': 'ᶻ' } function toSuperScript(x) { return x.split('').map(function(c) { if(c in SUPERSCRIPTS) { return SUPERSCRIPTS[c] } return '' }).join('') } },{}],219:[function(require,module,exports){ "use strict" var pool = require("typedarray-pool") module.exports = createSurfaceExtractor //Helper macros function array(i) { return "a" + i } function data(i) { return "d" + i } function cube(i,bitmask) { return "c" + i + "_" + bitmask } function shape(i) { return "s" + i } function stride(i,j) { return "t" + i + "_" + j } function offset(i) { return "o" + i } function scalar(i) { return "x" + i } function pointer(i) { return "p" + i } function delta(i,bitmask) { return "d" + i + "_" + bitmask } function index(i) { return "i" + i } function step(i,j) { return "u" + i + "_" + j } function pcube(bitmask) { return "b" + bitmask } function qcube(bitmask) { return "y" + bitmask } function pdelta(bitmask) { return "e" + bitmask } function vert(i) { return "v" + i } var VERTEX_IDS = "V" var PHASES = "P" var VERTEX_COUNT = "N" var POOL_SIZE = "Q" var POINTER = "X" var TEMPORARY = "T" function permBitmask(dimension, mask, order) { var r = 0 for(var i=0; i 0) { stepVal.push(stride(i, order[j-1]) + "*" + shape(order[j-1]) ) } vars.push(step(i,order[j]) + "=(" + stepVal.join("-") + ")|0") } } //Create index variables for(var i=0; i=0; --i) { sizeVariable.push(shape(order[i])) } //Previous phases and vertex_ids vars.push(POOL_SIZE + "=(" + sizeVariable.join("*") + ")|0", PHASES + "=mallocUint32(" + POOL_SIZE + ")", VERTEX_IDS + "=mallocUint32(" + POOL_SIZE + ")", POINTER + "=0") //Create cube variables for phases vars.push(pcube(0) + "=0") for(var j=1; j<(1<=0; --i) { forLoopBegin(i, 0) } var phaseFuncArgs = [] for(var i=0; i0; k=(k-1)&subset) { faceArgs.push(VERTEX_IDS + "[" + POINTER + "+" + pdelta(k) + "]") } faceArgs.push(vert(0)) for(var k=0; k0){", index(order[i]), "=1;") createLoop(i-1, mask|(1< 0") } if(typeof args.vertex !== "function") { error("Must specify vertex creation function") } if(typeof args.cell !== "function") { error("Must specify cell creation function") } if(typeof args.phase !== "function") { error("Must specify phase function") } var getters = args.getters || [] var typesig = new Array(arrays) for(var i=0; i= 0) { typesig[i] = true } else { typesig[i] = false } } return compileSurfaceProcedure( args.vertex, args.cell, args.phase, scalars, order, typesig) } },{"typedarray-pool":233}],220:[function(require,module,exports){ // transliterated from the python snippet here: // http://en.wikipedia.org/wiki/Lanczos_approximation var g = 7; var p = [ 0.99999999999980993, 676.5203681218851, -1259.1392167224028, 771.32342877765313, -176.61502916214059, 12.507343278686905, -0.13857109526572012, 9.9843695780195716e-6, 1.5056327351493116e-7 ]; var g_ln = 607/128; var p_ln = [ 0.99999999999999709182, 57.156235665862923517, -59.597960355475491248, 14.136097974741747174, -0.49191381609762019978, 0.33994649984811888699e-4, 0.46523628927048575665e-4, -0.98374475304879564677e-4, 0.15808870322491248884e-3, -0.21026444172410488319e-3, 0.21743961811521264320e-3, -0.16431810653676389022e-3, 0.84418223983852743293e-4, -0.26190838401581408670e-4, 0.36899182659531622704e-5 ]; // Spouge approximation (suitable for large arguments) function lngamma(z) { if(z < 0) return Number('0/0'); var x = p_ln[0]; for(var i = p_ln.length - 1; i > 0; --i) x += p_ln[i] / (z + i); var t = z + g_ln + 0.5; return .5*Math.log(2*Math.PI)+(z+.5)*Math.log(t)-t+Math.log(x)-Math.log(z); } module.exports = function gamma (z) { if (z < 0.5) { return Math.PI / (Math.sin(Math.PI * z) * gamma(1 - z)); } else if(z > 100) return Math.exp(lngamma(z)); else { z -= 1; var x = p[0]; for (var i = 1; i < g + 2; i++) { x += p[i] / (z + i); } var t = z + g + 0.5; return Math.sqrt(2 * Math.PI) * Math.pow(t, z + 0.5) * Math.exp(-t) * x ; } }; module.exports.log = lngamma; },{}],221:[function(require,module,exports){ "use strict" module.exports = permutationSign var BRUTE_FORCE_CUTOFF = 32 var pool = require("typedarray-pool") function permutationSign(p) { var n = p.length if(n < BRUTE_FORCE_CUTOFF) { //Use quadratic algorithm for small n var sgn = 1 for(var i=0; i0; --i) { t = pinv[i] s = p[i] p[i] = p[t] p[t] = s pinv[i] = pinv[s] pinv[s] = t r = (r + s) * i } pool.freeUint32(pinv) pool.freeUint32(p) return r } function unrank(n, r, p) { switch(n) { case 0: if(p) { return p } return [] case 1: if(p) { p[0] = 0 return p } else { return [0] } case 2: if(p) { if(r) { p[0] = 0 p[1] = 1 } else { p[0] = 1 p[1] = 0 } return p } else { return r ? [0,1] : [1,0] } default: break } p = p || new Array(n) var s, t, i, nf=1 p[0] = 0 for(i=1; i0; --i) { s = (r / nf)|0 r = (r - s * nf)|0 nf = (nf / i)|0 t = p[i]|0 p[i] = p[s]|0 p[s] = t|0 } return p } exports.rank = rank exports.unrank = unrank },{"invert-permutation":223,"typedarray-pool":233}],223:[function(require,module,exports){ "use strict" function invertPermutation(pi, result) { result = result || new Array(pi.length) for(var i=0; i= 0) !== (_inline_1_db >= 0)) {\n _inline_1_arg2_.push(_inline_1_arg4_[0] + 0.5 + 0.5 * (_inline_1_da + _inline_1_db) / (_inline_1_da - _inline_1_db))\n }\n }", "args": [{ "name": "_inline_1_arg0_", "lvalue": false, "rvalue": true, "count": 1 }, { "name": "_inline_1_arg1_", "lvalue": false, "rvalue": true, "count": 1 }, { "name": "_inline_1_arg2_", "lvalue": false, "rvalue": true, "count": 1 }, { "name": "_inline_1_arg3_", "lvalue": false, "rvalue": true, "count": 2 }, { "name": "_inline_1_arg4_", "lvalue": false, "rvalue": true, "count": 1 }], "thisVars": [], "localVars": ["_inline_1_da", "_inline_1_db"] }, funcName: 'zeroCrossings' }) },{"cwise-compiler":66}],226:[function(require,module,exports){ "use strict" module.exports = findZeroCrossings var core = require("./lib/zc-core") function findZeroCrossings(array, level) { var cross = [] level = +level || 0.0 core(array.hi(array.shape[0]-1), cross, level) return cross } },{"./lib/zc-core":225}],227:[function(require,module,exports){ "use strict" module.exports = surfaceNets var generateContourExtractor = require("ndarray-extract-contour") var triangulateCube = require("triangulate-hypercube") var zeroCrossings = require("zero-crossings") function buildSurfaceNets(order, dtype) { var dimension = order.length var code = ["'use strict';"] var funcName = "surfaceNets" + order.join("_") + "d" + dtype //Contour extraction function code.push( "var contour=genContour({", "order:[", order.join(), "],", "scalarArguments: 3,", "phase:function phaseFunc(p,a,b,c) { return (p > c)|0 },") if(dtype === "generic") { code.push("getters:[0],") } //Generate vertex function var cubeArgs = [] var extraArgs = [] for(var i=0; i>>7){") } for(var i=0; i<1<<(1< 128) { if((i%128)===0) { if(extraFuncs.length > 0) { currentFunc.push("}}") } var efName = "vExtra" + extraFuncs.length code.push("case ", (i>>>7), ":", efName, "(m&0x7f,", extraArgs.join(), ");break;") currentFunc = [ "function ", efName, "(m,", extraArgs.join(), "){switch(m){" ] extraFuncs.push(currentFunc) } } currentFunc.push("case ", (i&0x7f), ":") var crossings = new Array(dimension) var denoms = new Array(dimension) var crossingCount = new Array(dimension) var bias = new Array(dimension) var totalCrossings = 0 for(var j=0; j j) { continue } if(!(i&(1< 0) { cStr = "+" + crossingCount[k] + "*c" } var weight = 0.5 * (crossings[k].length / totalCrossings) var shift = 0.5 + 0.5 * (bias[k] / totalCrossings) vertexStr.push("d" + k + "-" + shift + "-" + weight + "*(" + crossings[k].join("+") + cStr + ")/(" + denoms[k].join("+") + ")") } } currentFunc.push("a.push([", vertexStr.join(), "]);", "break;") } code.push("}},") if(extraFuncs.length > 0) { currentFunc.push("}}") } //Create face function var faceArgs = [] for(var i=0; i<(1<<(dimension-1)); ++i) { faceArgs.push("v" + i) } faceArgs.push("c0", "c1", "p0", "p1", "a", "b", "c") code.push("cell:function cellFunc(", faceArgs.join(), "){") var facets = triangulateCube(dimension-1) code.push("if(p0){b.push(", facets.map(function(f) { return "[" + f.map(function(v) { return "v" + v }) + "]" }).join(), ")}else{b.push(", facets.map(function(f) { var e = f.slice() e.reverse() return "[" + e.map(function(v) { return "v" + v }) + "]" }).join(), ")}}});function ", funcName, "(array,level){var verts=[],cells=[];contour(array,verts,cells,level);return {positions:verts,cells:cells};} return ", funcName, ";") for(var i=0; i0) { shapeX += 0.02 } } var data = new Float32Array(bufferSize) var ptr = 0 var xOffset = -0.5 * shapeX for(var i=0; i= 0; var needsAlphaFormat = !formatSet && hasAlpha && (format === "hex" || format === "hex6" || format === "hex3" || format === "name"); if (needsAlphaFormat) { // Special case for "transparent", all other non-alpha formats // will return rgba when there is transparency. if (format === "name" && this._a === 0) { return this.toName(); } return this.toRgbString(); } if (format === "rgb") { formattedString = this.toRgbString(); } if (format === "prgb") { formattedString = this.toPercentageRgbString(); } if (format === "hex" || format === "hex6") { formattedString = this.toHexString(); } if (format === "hex3") { formattedString = this.toHexString(true); } if (format === "hex8") { formattedString = this.toHex8String(); } if (format === "name") { formattedString = this.toName(); } if (format === "hsl") { formattedString = this.toHslString(); } if (format === "hsv") { formattedString = this.toHsvString(); } return formattedString || this.toHexString(); }, clone: function() { return tinycolor(this.toString()); }, _applyModification: function(fn, args) { var color = fn.apply(null, [this].concat([].slice.call(args))); this._r = color._r; this._g = color._g; this._b = color._b; this.setAlpha(color._a); return this; }, lighten: function() { return this._applyModification(lighten, arguments); }, brighten: function() { return this._applyModification(brighten, arguments); }, darken: function() { return this._applyModification(darken, arguments); }, desaturate: function() { return this._applyModification(desaturate, arguments); }, saturate: function() { return this._applyModification(saturate, arguments); }, greyscale: function() { return this._applyModification(greyscale, arguments); }, spin: function() { return this._applyModification(spin, arguments); }, _applyCombination: function(fn, args) { return fn.apply(null, [this].concat([].slice.call(args))); }, analogous: function() { return this._applyCombination(analogous, arguments); }, complement: function() { return this._applyCombination(complement, arguments); }, monochromatic: function() { return this._applyCombination(monochromatic, arguments); }, splitcomplement: function() { return this._applyCombination(splitcomplement, arguments); }, triad: function() { return this._applyCombination(triad, arguments); }, tetrad: function() { return this._applyCombination(tetrad, arguments); } }; // If input is an object, force 1 into "1.0" to handle ratios properly // String input requires "1.0" as input, so 1 will be treated as 1 tinycolor.fromRatio = function(color, opts) { if (typeof color == "object") { var newColor = {}; for (var i in color) { if (color.hasOwnProperty(i)) { if (i === "a") { newColor[i] = color[i]; } else { newColor[i] = convertToPercentage(color[i]); } } } color = newColor; } return tinycolor(color, opts); }; // Given a string or object, convert that input to RGB // Possible string inputs: // // "red" // "#f00" or "f00" // "#ff0000" or "ff0000" // "#ff000000" or "ff000000" // "rgb 255 0 0" or "rgb (255, 0, 0)" // "rgb 1.0 0 0" or "rgb (1, 0, 0)" // "rgba (255, 0, 0, 1)" or "rgba 255, 0, 0, 1" // "rgba (1.0, 0, 0, 1)" or "rgba 1.0, 0, 0, 1" // "hsl(0, 100%, 50%)" or "hsl 0 100% 50%" // "hsla(0, 100%, 50%, 1)" or "hsla 0 100% 50%, 1" // "hsv(0, 100%, 100%)" or "hsv 0 100% 100%" // function inputToRGB(color) { var rgb = { r: 0, g: 0, b: 0 }; var a = 1; var ok = false; var format = false; if (typeof color == "string") { color = stringInputToObject(color); } if (typeof color == "object") { if (color.hasOwnProperty("r") && color.hasOwnProperty("g") && color.hasOwnProperty("b")) { rgb = rgbToRgb(color.r, color.g, color.b); ok = true; format = String(color.r).substr(-1) === "%" ? "prgb" : "rgb"; } else if (color.hasOwnProperty("h") && color.hasOwnProperty("s") && color.hasOwnProperty("v")) { color.s = convertToPercentage(color.s); color.v = convertToPercentage(color.v); rgb = hsvToRgb(color.h, color.s, color.v); ok = true; format = "hsv"; } else if (color.hasOwnProperty("h") && color.hasOwnProperty("s") && color.hasOwnProperty("l")) { color.s = convertToPercentage(color.s); color.l = convertToPercentage(color.l); rgb = hslToRgb(color.h, color.s, color.l); ok = true; format = "hsl"; } if (color.hasOwnProperty("a")) { a = color.a; } } a = boundAlpha(a); return { ok: ok, format: color.format || format, r: mathMin(255, mathMax(rgb.r, 0)), g: mathMin(255, mathMax(rgb.g, 0)), b: mathMin(255, mathMax(rgb.b, 0)), a: a }; } // Conversion Functions // -------------------- // `rgbToHsl`, `rgbToHsv`, `hslToRgb`, `hsvToRgb` modified from: // // `rgbToRgb` // Handle bounds / percentage checking to conform to CSS color spec // // *Assumes:* r, g, b in [0, 255] or [0, 1] // *Returns:* { r, g, b } in [0, 255] function rgbToRgb(r, g, b){ return { r: bound01(r, 255) * 255, g: bound01(g, 255) * 255, b: bound01(b, 255) * 255 }; } // `rgbToHsl` // Converts an RGB color value to HSL. // *Assumes:* r, g, and b are contained in [0, 255] or [0, 1] // *Returns:* { h, s, l } in [0,1] function rgbToHsl(r, g, b) { r = bound01(r, 255); g = bound01(g, 255); b = bound01(b, 255); var max = mathMax(r, g, b), min = mathMin(r, g, b); var h, s, l = (max + min) / 2; if(max == min) { h = s = 0; // achromatic } else { var d = max - min; s = l > 0.5 ? d / (2 - max - min) : d / (max + min); switch(max) { case r: h = (g - b) / d + (g < b ? 6 : 0); break; case g: h = (b - r) / d + 2; break; case b: h = (r - g) / d + 4; break; } h /= 6; } return { h: h, s: s, l: l }; } // `hslToRgb` // Converts an HSL color value to RGB. // *Assumes:* h is contained in [0, 1] or [0, 360] and s and l are contained [0, 1] or [0, 100] // *Returns:* { r, g, b } in the set [0, 255] function hslToRgb(h, s, l) { var r, g, b; h = bound01(h, 360); s = bound01(s, 100); l = bound01(l, 100); function hue2rgb(p, q, t) { if(t < 0) t += 1; if(t > 1) t -= 1; if(t < 1/6) return p + (q - p) * 6 * t; if(t < 1/2) return q; if(t < 2/3) return p + (q - p) * (2/3 - t) * 6; return p; } if(s === 0) { r = g = b = l; // achromatic } else { var q = l < 0.5 ? l * (1 + s) : l + s - l * s; var p = 2 * l - q; r = hue2rgb(p, q, h + 1/3); g = hue2rgb(p, q, h); b = hue2rgb(p, q, h - 1/3); } return { r: r * 255, g: g * 255, b: b * 255 }; } // `rgbToHsv` // Converts an RGB color value to HSV // *Assumes:* r, g, and b are contained in the set [0, 255] or [0, 1] // *Returns:* { h, s, v } in [0,1] function rgbToHsv(r, g, b) { r = bound01(r, 255); g = bound01(g, 255); b = bound01(b, 255); var max = mathMax(r, g, b), min = mathMin(r, g, b); var h, s, v = max; var d = max - min; s = max === 0 ? 0 : d / max; if(max == min) { h = 0; // achromatic } else { switch(max) { case r: h = (g - b) / d + (g < b ? 6 : 0); break; case g: h = (b - r) / d + 2; break; case b: h = (r - g) / d + 4; break; } h /= 6; } return { h: h, s: s, v: v }; } // `hsvToRgb` // Converts an HSV color value to RGB. // *Assumes:* h is contained in [0, 1] or [0, 360] and s and v are contained in [0, 1] or [0, 100] // *Returns:* { r, g, b } in the set [0, 255] function hsvToRgb(h, s, v) { h = bound01(h, 360) * 6; s = bound01(s, 100); v = bound01(v, 100); var i = math.floor(h), f = h - i, p = v * (1 - s), q = v * (1 - f * s), t = v * (1 - (1 - f) * s), mod = i % 6, r = [v, q, p, p, t, v][mod], g = [t, v, v, q, p, p][mod], b = [p, p, t, v, v, q][mod]; return { r: r * 255, g: g * 255, b: b * 255 }; } // `rgbToHex` // Converts an RGB color to hex // Assumes r, g, and b are contained in the set [0, 255] // Returns a 3 or 6 character hex function rgbToHex(r, g, b, allow3Char) { var hex = [ pad2(mathRound(r).toString(16)), pad2(mathRound(g).toString(16)), pad2(mathRound(b).toString(16)) ]; // Return a 3 character hex if possible if (allow3Char && hex[0].charAt(0) == hex[0].charAt(1) && hex[1].charAt(0) == hex[1].charAt(1) && hex[2].charAt(0) == hex[2].charAt(1)) { return hex[0].charAt(0) + hex[1].charAt(0) + hex[2].charAt(0); } return hex.join(""); } // `rgbaToHex` // Converts an RGBA color plus alpha transparency to hex // Assumes r, g, b and a are contained in the set [0, 255] // Returns an 8 character hex function rgbaToHex(r, g, b, a) { var hex = [ pad2(convertDecimalToHex(a)), pad2(mathRound(r).toString(16)), pad2(mathRound(g).toString(16)), pad2(mathRound(b).toString(16)) ]; return hex.join(""); } // `equals` // Can be called with any tinycolor input tinycolor.equals = function (color1, color2) { if (!color1 || !color2) { return false; } return tinycolor(color1).toRgbString() == tinycolor(color2).toRgbString(); }; tinycolor.random = function() { return tinycolor.fromRatio({ r: mathRandom(), g: mathRandom(), b: mathRandom() }); }; // Modification Functions // ---------------------- // Thanks to less.js for some of the basics here // function desaturate(color, amount) { amount = (amount === 0) ? 0 : (amount || 10); var hsl = tinycolor(color).toHsl(); hsl.s -= amount / 100; hsl.s = clamp01(hsl.s); return tinycolor(hsl); } function saturate(color, amount) { amount = (amount === 0) ? 0 : (amount || 10); var hsl = tinycolor(color).toHsl(); hsl.s += amount / 100; hsl.s = clamp01(hsl.s); return tinycolor(hsl); } function greyscale(color) { return tinycolor(color).desaturate(100); } function lighten (color, amount) { amount = (amount === 0) ? 0 : (amount || 10); var hsl = tinycolor(color).toHsl(); hsl.l += amount / 100; hsl.l = clamp01(hsl.l); return tinycolor(hsl); } function brighten(color, amount) { amount = (amount === 0) ? 0 : (amount || 10); var rgb = tinycolor(color).toRgb(); rgb.r = mathMax(0, mathMin(255, rgb.r - mathRound(255 * - (amount / 100)))); rgb.g = mathMax(0, mathMin(255, rgb.g - mathRound(255 * - (amount / 100)))); rgb.b = mathMax(0, mathMin(255, rgb.b - mathRound(255 * - (amount / 100)))); return tinycolor(rgb); } function darken (color, amount) { amount = (amount === 0) ? 0 : (amount || 10); var hsl = tinycolor(color).toHsl(); hsl.l -= amount / 100; hsl.l = clamp01(hsl.l); return tinycolor(hsl); } // Spin takes a positive or negative amount within [-360, 360] indicating the change of hue. // Values outside of this range will be wrapped into this range. function spin(color, amount) { var hsl = tinycolor(color).toHsl(); var hue = (mathRound(hsl.h) + amount) % 360; hsl.h = hue < 0 ? 360 + hue : hue; return tinycolor(hsl); } // Combination Functions // --------------------- // Thanks to jQuery xColor for some of the ideas behind these // function complement(color) { var hsl = tinycolor(color).toHsl(); hsl.h = (hsl.h + 180) % 360; return tinycolor(hsl); } function triad(color) { var hsl = tinycolor(color).toHsl(); var h = hsl.h; return [ tinycolor(color), tinycolor({ h: (h + 120) % 360, s: hsl.s, l: hsl.l }), tinycolor({ h: (h + 240) % 360, s: hsl.s, l: hsl.l }) ]; } function tetrad(color) { var hsl = tinycolor(color).toHsl(); var h = hsl.h; return [ tinycolor(color), tinycolor({ h: (h + 90) % 360, s: hsl.s, l: hsl.l }), tinycolor({ h: (h + 180) % 360, s: hsl.s, l: hsl.l }), tinycolor({ h: (h + 270) % 360, s: hsl.s, l: hsl.l }) ]; } function splitcomplement(color) { var hsl = tinycolor(color).toHsl(); var h = hsl.h; return [ tinycolor(color), tinycolor({ h: (h + 72) % 360, s: hsl.s, l: hsl.l}), tinycolor({ h: (h + 216) % 360, s: hsl.s, l: hsl.l}) ]; } function analogous(color, results, slices) { results = results || 6; slices = slices || 30; var hsl = tinycolor(color).toHsl(); var part = 360 / slices; var ret = [tinycolor(color)]; for (hsl.h = ((hsl.h - (part * results >> 1)) + 720) % 360; --results; ) { hsl.h = (hsl.h + part) % 360; ret.push(tinycolor(hsl)); } return ret; } function monochromatic(color, results) { results = results || 6; var hsv = tinycolor(color).toHsv(); var h = hsv.h, s = hsv.s, v = hsv.v; var ret = []; var modification = 1 / results; while (results--) { ret.push(tinycolor({ h: h, s: s, v: v})); v = (v + modification) % 1; } return ret; } // Utility Functions // --------------------- tinycolor.mix = function(color1, color2, amount) { amount = (amount === 0) ? 0 : (amount || 50); var rgb1 = tinycolor(color1).toRgb(); var rgb2 = tinycolor(color2).toRgb(); var p = amount / 100; var w = p * 2 - 1; var a = rgb2.a - rgb1.a; var w1; if (w * a == -1) { w1 = w; } else { w1 = (w + a) / (1 + w * a); } w1 = (w1 + 1) / 2; var w2 = 1 - w1; var rgba = { r: rgb2.r * w1 + rgb1.r * w2, g: rgb2.g * w1 + rgb1.g * w2, b: rgb2.b * w1 + rgb1.b * w2, a: rgb2.a * p + rgb1.a * (1 - p) }; return tinycolor(rgba); }; // Readability Functions // --------------------- // false // tinycolor.isReadable("#000", "#111",{level:"AA",size:"large"}) => false tinycolor.isReadable = function(color1, color2, wcag2) { var readability = tinycolor.readability(color1, color2); var wcag2Parms, out; out = false; wcag2Parms = validateWCAG2Parms(wcag2); switch (wcag2Parms.level + wcag2Parms.size) { case "AAsmall": case "AAAlarge": out = readability >= 4.5; break; case "AAlarge": out = readability >= 3; break; case "AAAsmall": out = readability >= 7; break; } return out; }; // `mostReadable` // Given a base color and a list of possible foreground or background // colors for that base, returns the most readable color. // Optionally returns Black or White if the most readable color is unreadable. // *Example* // tinycolor.mostReadable(tinycolor.mostReadable("#123", ["#124", "#125"],{includeFallbackColors:false}).toHexString(); // "#112255" // tinycolor.mostReadable(tinycolor.mostReadable("#123", ["#124", "#125"],{includeFallbackColors:true}).toHexString(); // "#ffffff" // tinycolor.mostReadable("#a8015a", ["#faf3f3"],{includeFallbackColors:true,level:"AAA",size:"large"}).toHexString(); // "#faf3f3" // tinycolor.mostReadable("#a8015a", ["#faf3f3"],{includeFallbackColors:true,level:"AAA",size:"small"}).toHexString(); // "#ffffff" tinycolor.mostReadable = function(baseColor, colorList, args) { var bestColor = null; var bestScore = 0; var readability; var includeFallbackColors, level, size ; args = args || {}; includeFallbackColors = args.includeFallbackColors ; level = args.level; size = args.size; for (var i= 0; i < colorList.length ; i++) { readability = tinycolor.readability(baseColor, colorList[i]); if (readability > bestScore) { bestScore = readability; bestColor = tinycolor(colorList[i]); } } if (tinycolor.isReadable(baseColor, bestColor, {"level":level,"size":size}) || !includeFallbackColors) { return bestColor; } else { args.includeFallbackColors=false; return tinycolor.mostReadable(baseColor,["#fff", "#000"],args); } }; // Big List of Colors // ------------------ // var names = tinycolor.names = { aliceblue: "f0f8ff", antiquewhite: "faebd7", aqua: "0ff", aquamarine: "7fffd4", azure: "f0ffff", beige: "f5f5dc", bisque: "ffe4c4", black: "000", blanchedalmond: "ffebcd", blue: "00f", blueviolet: "8a2be2", brown: "a52a2a", burlywood: "deb887", burntsienna: "ea7e5d", cadetblue: "5f9ea0", chartreuse: "7fff00", chocolate: "d2691e", coral: "ff7f50", cornflowerblue: "6495ed", cornsilk: "fff8dc", crimson: "dc143c", cyan: "0ff", darkblue: "00008b", darkcyan: "008b8b", darkgoldenrod: "b8860b", darkgray: "a9a9a9", darkgreen: "006400", darkgrey: "a9a9a9", darkkhaki: "bdb76b", darkmagenta: "8b008b", darkolivegreen: "556b2f", darkorange: "ff8c00", darkorchid: "9932cc", darkred: "8b0000", darksalmon: "e9967a", darkseagreen: "8fbc8f", darkslateblue: "483d8b", darkslategray: "2f4f4f", darkslategrey: "2f4f4f", darkturquoise: "00ced1", darkviolet: "9400d3", deeppink: "ff1493", deepskyblue: "00bfff", dimgray: "696969", dimgrey: "696969", dodgerblue: "1e90ff", firebrick: "b22222", floralwhite: "fffaf0", forestgreen: "228b22", fuchsia: "f0f", gainsboro: "dcdcdc", ghostwhite: "f8f8ff", gold: "ffd700", goldenrod: "daa520", gray: "808080", green: "008000", greenyellow: "adff2f", grey: "808080", honeydew: "f0fff0", hotpink: "ff69b4", indianred: "cd5c5c", indigo: "4b0082", ivory: "fffff0", khaki: "f0e68c", lavender: "e6e6fa", lavenderblush: "fff0f5", lawngreen: "7cfc00", lemonchiffon: "fffacd", lightblue: "add8e6", lightcoral: "f08080", lightcyan: "e0ffff", lightgoldenrodyellow: "fafad2", lightgray: "d3d3d3", lightgreen: "90ee90", lightgrey: "d3d3d3", lightpink: "ffb6c1", lightsalmon: "ffa07a", lightseagreen: "20b2aa", lightskyblue: "87cefa", lightslategray: "789", lightslategrey: "789", lightsteelblue: "b0c4de", lightyellow: "ffffe0", lime: "0f0", limegreen: "32cd32", linen: "faf0e6", magenta: "f0f", maroon: "800000", mediumaquamarine: "66cdaa", mediumblue: "0000cd", mediumorchid: "ba55d3", mediumpurple: "9370db", mediumseagreen: "3cb371", mediumslateblue: "7b68ee", mediumspringgreen: "00fa9a", mediumturquoise: "48d1cc", mediumvioletred: "c71585", midnightblue: "191970", mintcream: "f5fffa", mistyrose: "ffe4e1", moccasin: "ffe4b5", navajowhite: "ffdead", navy: "000080", oldlace: "fdf5e6", olive: "808000", olivedrab: "6b8e23", orange: "ffa500", orangered: "ff4500", orchid: "da70d6", palegoldenrod: "eee8aa", palegreen: "98fb98", paleturquoise: "afeeee", palevioletred: "db7093", papayawhip: "ffefd5", peachpuff: "ffdab9", peru: "cd853f", pink: "ffc0cb", plum: "dda0dd", powderblue: "b0e0e6", purple: "800080", rebeccapurple: "663399", red: "f00", rosybrown: "bc8f8f", royalblue: "4169e1", saddlebrown: "8b4513", salmon: "fa8072", sandybrown: "f4a460", seagreen: "2e8b57", seashell: "fff5ee", sienna: "a0522d", silver: "c0c0c0", skyblue: "87ceeb", slateblue: "6a5acd", slategray: "708090", slategrey: "708090", snow: "fffafa", springgreen: "00ff7f", steelblue: "4682b4", tan: "d2b48c", teal: "008080", thistle: "d8bfd8", tomato: "ff6347", turquoise: "40e0d0", violet: "ee82ee", wheat: "f5deb3", white: "fff", whitesmoke: "f5f5f5", yellow: "ff0", yellowgreen: "9acd32" }; // Make it easy to access colors via `hexNames[hex]` var hexNames = tinycolor.hexNames = flip(names); // Utilities // --------- // `{ 'name1': 'val1' }` becomes `{ 'val1': 'name1' }` function flip(o) { var flipped = { }; for (var i in o) { if (o.hasOwnProperty(i)) { flipped[o[i]] = i; } } return flipped; } // Return a valid alpha value [0,1] with all invalid values being set to 1 function boundAlpha(a) { a = parseFloat(a); if (isNaN(a) || a < 0 || a > 1) { a = 1; } return a; } // Take input from [0, n] and return it as [0, 1] function bound01(n, max) { if (isOnePointZero(n)) { n = "100%"; } var processPercent = isPercentage(n); n = mathMin(max, mathMax(0, parseFloat(n))); // Automatically convert percentage into number if (processPercent) { n = parseInt(n * max, 10) / 100; } // Handle floating point rounding errors if ((math.abs(n - max) < 0.000001)) { return 1; } // Convert into [0, 1] range if it isn't already return (n % max) / parseFloat(max); } // Force a number between 0 and 1 function clamp01(val) { return mathMin(1, mathMax(0, val)); } // Parse a base-16 hex value into a base-10 integer function parseIntFromHex(val) { return parseInt(val, 16); } // Need to handle 1.0 as 100%, since once it is a number, there is no difference between it and 1 // function isOnePointZero(n) { return typeof n == "string" && n.indexOf('.') != -1 && parseFloat(n) === 1; } // Check to see if string passed in is a percentage function isPercentage(n) { return typeof n === "string" && n.indexOf('%') != -1; } // Force a hex value to have 2 characters function pad2(c) { return c.length == 1 ? '0' + c : '' + c; } // Replace a decimal with it's percentage value function convertToPercentage(n) { if (n <= 1) { n = (n * 100) + "%"; } return n; } // Converts a decimal to a hex value function convertDecimalToHex(d) { return Math.round(parseFloat(d) * 255).toString(16); } // Converts a hex value to a decimal function convertHexToDecimal(h) { return (parseIntFromHex(h) / 255); } var matchers = (function() { // var CSS_INTEGER = "[-\\+]?\\d+%?"; // var CSS_NUMBER = "[-\\+]?\\d*\\.\\d+%?"; // Allow positive/negative integer/number. Don't capture the either/or, just the entire outcome. var CSS_UNIT = "(?:" + CSS_NUMBER + ")|(?:" + CSS_INTEGER + ")"; // Actual matching. // Parentheses and commas are optional, but not required. // Whitespace can take the place of commas or opening paren var PERMISSIVE_MATCH3 = "[\\s|\\(]+(" + CSS_UNIT + ")[,|\\s]+(" + CSS_UNIT + ")[,|\\s]+(" + CSS_UNIT + ")\\s*\\)?"; var PERMISSIVE_MATCH4 = "[\\s|\\(]+(" + CSS_UNIT + ")[,|\\s]+(" + CSS_UNIT + ")[,|\\s]+(" + CSS_UNIT + ")[,|\\s]+(" + CSS_UNIT + ")\\s*\\)?"; return { rgb: new RegExp("rgb" + PERMISSIVE_MATCH3), rgba: new RegExp("rgba" + PERMISSIVE_MATCH4), hsl: new RegExp("hsl" + PERMISSIVE_MATCH3), hsla: new RegExp("hsla" + PERMISSIVE_MATCH4), hsv: new RegExp("hsv" + PERMISSIVE_MATCH3), hsva: new RegExp("hsva" + PERMISSIVE_MATCH4), hex3: /^#?([0-9a-fA-F]{1})([0-9a-fA-F]{1})([0-9a-fA-F]{1})$/, hex6: /^#?([0-9a-fA-F]{2})([0-9a-fA-F]{2})([0-9a-fA-F]{2})$/, hex8: /^#?([0-9a-fA-F]{2})([0-9a-fA-F]{2})([0-9a-fA-F]{2})([0-9a-fA-F]{2})$/ }; })(); // `stringInputToObject` // Permissive string parsing. Take in a number of formats, and output an object // based on detected format. Returns `{ r, g, b }` or `{ h, s, l }` or `{ h, s, v}` function stringInputToObject(color) { color = color.replace(trimLeft,'').replace(trimRight, '').toLowerCase(); var named = false; if (names[color]) { color = names[color]; named = true; } else if (color == 'transparent') { return { r: 0, g: 0, b: 0, a: 0, format: "name" }; } // Try to match string input using regular expressions. // Keep most of the number bounding out of this function - don't worry about [0,1] or [0,100] or [0,360] // Just return an object and let the conversion functions handle that. // This way the result will be the same whether the tinycolor is initialized with string or object. var match; if ((match = matchers.rgb.exec(color))) { return { r: match[1], g: match[2], b: match[3] }; } if ((match = matchers.rgba.exec(color))) { return { r: match[1], g: match[2], b: match[3], a: match[4] }; } if ((match = matchers.hsl.exec(color))) { return { h: match[1], s: match[2], l: match[3] }; } if ((match = matchers.hsla.exec(color))) { return { h: match[1], s: match[2], l: match[3], a: match[4] }; } if ((match = matchers.hsv.exec(color))) { return { h: match[1], s: match[2], v: match[3] }; } if ((match = matchers.hsva.exec(color))) { return { h: match[1], s: match[2], v: match[3], a: match[4] }; } if ((match = matchers.hex8.exec(color))) { return { a: convertHexToDecimal(match[1]), r: parseIntFromHex(match[2]), g: parseIntFromHex(match[3]), b: parseIntFromHex(match[4]), format: named ? "name" : "hex8" }; } if ((match = matchers.hex6.exec(color))) { return { r: parseIntFromHex(match[1]), g: parseIntFromHex(match[2]), b: parseIntFromHex(match[3]), format: named ? "name" : "hex" }; } if ((match = matchers.hex3.exec(color))) { return { r: parseIntFromHex(match[1] + '' + match[1]), g: parseIntFromHex(match[2] + '' + match[2]), b: parseIntFromHex(match[3] + '' + match[3]), format: named ? "name" : "hex" }; } return false; } function validateWCAG2Parms(parms) { // return valid WCAG2 parms for isReadable. // If input parms are invalid, return {"level":"AA", "size":"small"} var level, size; parms = parms || {"level":"AA", "size":"small"}; level = (parms.level || "AA").toUpperCase(); size = (parms.size || "small").toLowerCase(); if (level !== "AA" && level !== "AAA") { level = "AA"; } if (size !== "small" && size !== "large") { size = "small"; } return {"level":level, "size":size}; } // Node: Export function if (typeof module !== "undefined" && module.exports) { module.exports = tinycolor; } // AMD/requirejs: Define the module else if (typeof define === 'function' && define.amd) { define(function () {return tinycolor;}); } // Browser: Expose to window else { window.tinycolor = tinycolor; } })(); },{}],230:[function(require,module,exports){ !function() { var topojson = { version: "1.6.20", mesh: function(topology) { return object(topology, meshArcs.apply(this, arguments)); }, meshArcs: meshArcs, merge: function(topology) { return object(topology, mergeArcs.apply(this, arguments)); }, mergeArcs: mergeArcs, feature: featureOrCollection, neighbors: neighbors, presimplify: presimplify }; function stitchArcs(topology, arcs) { var stitchedArcs = {}, fragmentByStart = {}, fragmentByEnd = {}, fragments = [], emptyIndex = -1; // Stitch empty arcs first, since they may be subsumed by other arcs. arcs.forEach(function(i, j) { var arc = topology.arcs[i < 0 ? ~i : i], t; if (arc.length < 3 && !arc[1][0] && !arc[1][1]) { t = arcs[++emptyIndex], arcs[emptyIndex] = i, arcs[j] = t; } }); arcs.forEach(function(i) { var e = ends(i), start = e[0], end = e[1], f, g; if (f = fragmentByEnd[start]) { delete fragmentByEnd[f.end]; f.push(i); f.end = end; if (g = fragmentByStart[end]) { delete fragmentByStart[g.start]; var fg = g === f ? f : f.concat(g); fragmentByStart[fg.start = f.start] = fragmentByEnd[fg.end = g.end] = fg; } else { fragmentByStart[f.start] = fragmentByEnd[f.end] = f; } } else if (f = fragmentByStart[end]) { delete fragmentByStart[f.start]; f.unshift(i); f.start = start; if (g = fragmentByEnd[start]) { delete fragmentByEnd[g.end]; var gf = g === f ? f : g.concat(f); fragmentByStart[gf.start = g.start] = fragmentByEnd[gf.end = f.end] = gf; } else { fragmentByStart[f.start] = fragmentByEnd[f.end] = f; } } else { f = [i]; fragmentByStart[f.start = start] = fragmentByEnd[f.end = end] = f; } }); function ends(i) { var arc = topology.arcs[i < 0 ? ~i : i], p0 = arc[0], p1; if (topology.transform) p1 = [0, 0], arc.forEach(function(dp) { p1[0] += dp[0], p1[1] += dp[1]; }); else p1 = arc[arc.length - 1]; return i < 0 ? [p1, p0] : [p0, p1]; } function flush(fragmentByEnd, fragmentByStart) { for (var k in fragmentByEnd) { var f = fragmentByEnd[k]; delete fragmentByStart[f.start]; delete f.start; delete f.end; f.forEach(function(i) { stitchedArcs[i < 0 ? ~i : i] = 1; }); fragments.push(f); } } flush(fragmentByEnd, fragmentByStart); flush(fragmentByStart, fragmentByEnd); arcs.forEach(function(i) { if (!stitchedArcs[i < 0 ? ~i : i]) fragments.push([i]); }); return fragments; } function meshArcs(topology, o, filter) { var arcs = []; if (arguments.length > 1) { var geomsByArc = [], geom; function arc(i) { var j = i < 0 ? ~i : i; (geomsByArc[j] || (geomsByArc[j] = [])).push({i: i, g: geom}); } function line(arcs) { arcs.forEach(arc); } function polygon(arcs) { arcs.forEach(line); } function geometry(o) { if (o.type === "GeometryCollection") o.geometries.forEach(geometry); else if (o.type in geometryType) geom = o, geometryType[o.type](o.arcs); } var geometryType = { LineString: line, MultiLineString: polygon, Polygon: polygon, MultiPolygon: function(arcs) { arcs.forEach(polygon); } }; geometry(o); geomsByArc.forEach(arguments.length < 3 ? function(geoms) { arcs.push(geoms[0].i); } : function(geoms) { if (filter(geoms[0].g, geoms[geoms.length - 1].g)) arcs.push(geoms[0].i); }); } else { for (var i = 0, n = topology.arcs.length; i < n; ++i) arcs.push(i); } return {type: "MultiLineString", arcs: stitchArcs(topology, arcs)}; } function mergeArcs(topology, objects) { var polygonsByArc = {}, polygons = [], components = []; objects.forEach(function(o) { if (o.type === "Polygon") register(o.arcs); else if (o.type === "MultiPolygon") o.arcs.forEach(register); }); function register(polygon) { polygon.forEach(function(ring) { ring.forEach(function(arc) { (polygonsByArc[arc = arc < 0 ? ~arc : arc] || (polygonsByArc[arc] = [])).push(polygon); }); }); polygons.push(polygon); } function exterior(ring) { return cartesianRingArea(object(topology, {type: "Polygon", arcs: [ring]}).coordinates[0]) > 0; // TODO allow spherical? } polygons.forEach(function(polygon) { if (!polygon._) { var component = [], neighbors = [polygon]; polygon._ = 1; components.push(component); while (polygon = neighbors.pop()) { component.push(polygon); polygon.forEach(function(ring) { ring.forEach(function(arc) { polygonsByArc[arc < 0 ? ~arc : arc].forEach(function(polygon) { if (!polygon._) { polygon._ = 1; neighbors.push(polygon); } }); }); }); } } }); polygons.forEach(function(polygon) { delete polygon._; }); return { type: "MultiPolygon", arcs: components.map(function(polygons) { var arcs = [], n; // Extract the exterior (unique) arcs. polygons.forEach(function(polygon) { polygon.forEach(function(ring) { ring.forEach(function(arc) { if (polygonsByArc[arc < 0 ? ~arc : arc].length < 2) { arcs.push(arc); } }); }); }); // Stitch the arcs into one or more rings. arcs = stitchArcs(topology, arcs); // If more than one ring is returned, // at most one of these rings can be the exterior; // this exterior ring has the same winding order // as any exterior ring in the original polygons. if ((n = arcs.length) > 1) { var sgn = exterior(polygons[0][0]); for (var i = 0, t; i < n; ++i) { if (sgn === exterior(arcs[i])) { t = arcs[0], arcs[0] = arcs[i], arcs[i] = t; break; } } } return arcs; }) }; } function featureOrCollection(topology, o) { return o.type === "GeometryCollection" ? { type: "FeatureCollection", features: o.geometries.map(function(o) { return feature(topology, o); }) } : feature(topology, o); } function feature(topology, o) { var f = { type: "Feature", id: o.id, properties: o.properties || {}, geometry: object(topology, o) }; if (o.id == null) delete f.id; return f; } function object(topology, o) { var absolute = transformAbsolute(topology.transform), arcs = topology.arcs; function arc(i, points) { if (points.length) points.pop(); for (var a = arcs[i < 0 ? ~i : i], k = 0, n = a.length, p; k < n; ++k) { points.push(p = a[k].slice()); absolute(p, k); } if (i < 0) reverse(points, n); } function point(p) { p = p.slice(); absolute(p, 0); return p; } function line(arcs) { var points = []; for (var i = 0, n = arcs.length; i < n; ++i) arc(arcs[i], points); if (points.length < 2) points.push(points[0].slice()); return points; } function ring(arcs) { var points = line(arcs); while (points.length < 4) points.push(points[0].slice()); return points; } function polygon(arcs) { return arcs.map(ring); } function geometry(o) { var t = o.type; return t === "GeometryCollection" ? {type: t, geometries: o.geometries.map(geometry)} : t in geometryType ? {type: t, coordinates: geometryType[t](o)} : null; } var geometryType = { Point: function(o) { return point(o.coordinates); }, MultiPoint: function(o) { return o.coordinates.map(point); }, LineString: function(o) { return line(o.arcs); }, MultiLineString: function(o) { return o.arcs.map(line); }, Polygon: function(o) { return polygon(o.arcs); }, MultiPolygon: function(o) { return o.arcs.map(polygon); } }; return geometry(o); } function reverse(array, n) { var t, j = array.length, i = j - n; while (i < --j) t = array[i], array[i++] = array[j], array[j] = t; } function bisect(a, x) { var lo = 0, hi = a.length; while (lo < hi) { var mid = lo + hi >>> 1; if (a[mid] < x) lo = mid + 1; else hi = mid; } return lo; } function neighbors(objects) { var indexesByArc = {}, // arc index -> array of object indexes neighbors = objects.map(function() { return []; }); function line(arcs, i) { arcs.forEach(function(a) { if (a < 0) a = ~a; var o = indexesByArc[a]; if (o) o.push(i); else indexesByArc[a] = [i]; }); } function polygon(arcs, i) { arcs.forEach(function(arc) { line(arc, i); }); } function geometry(o, i) { if (o.type === "GeometryCollection") o.geometries.forEach(function(o) { geometry(o, i); }); else if (o.type in geometryType) geometryType[o.type](o.arcs, i); } var geometryType = { LineString: line, MultiLineString: polygon, Polygon: polygon, MultiPolygon: function(arcs, i) { arcs.forEach(function(arc) { polygon(arc, i); }); } }; objects.forEach(geometry); for (var i in indexesByArc) { for (var indexes = indexesByArc[i], m = indexes.length, j = 0; j < m; ++j) { for (var k = j + 1; k < m; ++k) { var ij = indexes[j], ik = indexes[k], n; if ((n = neighbors[ij])[i = bisect(n, ik)] !== ik) n.splice(i, 0, ik); if ((n = neighbors[ik])[i = bisect(n, ij)] !== ij) n.splice(i, 0, ij); } } } return neighbors; } function presimplify(topology, triangleArea) { var absolute = transformAbsolute(topology.transform), relative = transformRelative(topology.transform), heap = minAreaHeap(); if (!triangleArea) triangleArea = cartesianTriangleArea; topology.arcs.forEach(function(arc) { var triangles = [], maxArea = 0, triangle; // To store each point’s effective area, we create a new array rather than // extending the passed-in point to workaround a Chrome/V8 bug (getting // stuck in smi mode). For midpoints, the initial effective area of // Infinity will be computed in the next step. for (var i = 0, n = arc.length, p; i < n; ++i) { p = arc[i]; absolute(arc[i] = [p[0], p[1], Infinity], i); } for (var i = 1, n = arc.length - 1; i < n; ++i) { triangle = arc.slice(i - 1, i + 2); triangle[1][2] = triangleArea(triangle); triangles.push(triangle); heap.push(triangle); } for (var i = 0, n = triangles.length; i < n; ++i) { triangle = triangles[i]; triangle.previous = triangles[i - 1]; triangle.next = triangles[i + 1]; } while (triangle = heap.pop()) { var previous = triangle.previous, next = triangle.next; // If the area of the current point is less than that of the previous point // to be eliminated, use the latter's area instead. This ensures that the // current point cannot be eliminated without eliminating previously- // eliminated points. if (triangle[1][2] < maxArea) triangle[1][2] = maxArea; else maxArea = triangle[1][2]; if (previous) { previous.next = next; previous[2] = triangle[2]; update(previous); } if (next) { next.previous = previous; next[0] = triangle[0]; update(next); } } arc.forEach(relative); }); function update(triangle) { heap.remove(triangle); triangle[1][2] = triangleArea(triangle); heap.push(triangle); } return topology; } function cartesianRingArea(ring) { var i = -1, n = ring.length, a, b = ring[n - 1], area = 0; while (++i < n) { a = b; b = ring[i]; area += a[0] * b[1] - a[1] * b[0]; } return area / 2; } function cartesianTriangleArea(triangle) { var a = triangle[0], b = triangle[1], c = triangle[2]; return Math.abs((a[0] - c[0]) * (b[1] - a[1]) - (a[0] - b[0]) * (c[1] - a[1])); } function compareArea(a, b) { return a[1][2] - b[1][2]; } function minAreaHeap() { var heap = {}, array = [], size = 0; heap.push = function(object) { up(array[object._ = size] = object, size++); return size; }; heap.pop = function() { if (size <= 0) return; var removed = array[0], object; if (--size > 0) object = array[size], down(array[object._ = 0] = object, 0); return removed; }; heap.remove = function(removed) { var i = removed._, object; if (array[i] !== removed) return; // invalid request if (i !== --size) object = array[size], (compareArea(object, removed) < 0 ? up : down)(array[object._ = i] = object, i); return i; }; function up(object, i) { while (i > 0) { var j = ((i + 1) >> 1) - 1, parent = array[j]; if (compareArea(object, parent) >= 0) break; array[parent._ = i] = parent; array[object._ = i = j] = object; } } function down(object, i) { while (true) { var r = (i + 1) << 1, l = r - 1, j = i, child = array[j]; if (l < size && compareArea(array[l], child) < 0) child = array[j = l]; if (r < size && compareArea(array[r], child) < 0) child = array[j = r]; if (j === i) break; array[child._ = i] = child; array[object._ = i = j] = object; } } return heap; } function transformAbsolute(transform) { if (!transform) return noop; var x0, y0, kx = transform.scale[0], ky = transform.scale[1], dx = transform.translate[0], dy = transform.translate[1]; return function(point, i) { if (!i) x0 = y0 = 0; point[0] = (x0 += point[0]) * kx + dx; point[1] = (y0 += point[1]) * ky + dy; }; } function transformRelative(transform) { if (!transform) return noop; var x0, y0, kx = transform.scale[0], ky = transform.scale[1], dx = transform.translate[0], dy = transform.translate[1]; return function(point, i) { if (!i) x0 = y0 = 0; var x1 = (point[0] - dx) / kx | 0, y1 = (point[1] - dy) / ky | 0; point[0] = x1 - x0; point[1] = y1 - y0; x0 = x1; y0 = y1; }; } function noop() {} if (typeof define === "function" && define.amd) define(topojson); else if (typeof module === "object" && module.exports) module.exports = topojson; else this.topojson = topojson; }(); },{}],231:[function(require,module,exports){ "use strict" module.exports = twoProduct var SPLITTER = +(Math.pow(2, 27) + 1.0) function twoProduct(a, b, result) { var x = a * b var c = SPLITTER * a var abig = c - a var ahi = c - abig var alo = a - ahi var d = SPLITTER * b var bbig = d - b var bhi = d - bbig var blo = b - bhi var err1 = x - (ahi * bhi) var err2 = err1 - (alo * bhi) var err3 = err2 - (ahi * blo) var y = alo * blo - err3 if(result) { result[0] = y result[1] = x return result } return [ y, x ] } },{}],232:[function(require,module,exports){ "use strict" module.exports = fastTwoSum function fastTwoSum(a, b, result) { var x = a + b var bv = x - a var av = x - bv var br = b - bv var ar = a - av if(result) { result[0] = ar + br result[1] = x return result } return [ar+br, x] } },{}],233:[function(require,module,exports){ (function (global,Buffer){ 'use strict' var bits = require('bit-twiddle') var dup = require('dup') //Legacy pool support if(!global.__TYPEDARRAY_POOL) { global.__TYPEDARRAY_POOL = { UINT8 : dup([32, 0]) , UINT16 : dup([32, 0]) , UINT32 : dup([32, 0]) , INT8 : dup([32, 0]) , INT16 : dup([32, 0]) , INT32 : dup([32, 0]) , FLOAT : dup([32, 0]) , DOUBLE : dup([32, 0]) , DATA : dup([32, 0]) , UINT8C : dup([32, 0]) , BUFFER : dup([32, 0]) } } var hasUint8C = (typeof Uint8ClampedArray) !== 'undefined' var POOL = global.__TYPEDARRAY_POOL //Upgrade pool if(!POOL.UINT8C) { POOL.UINT8C = dup([32, 0]) } if(!POOL.BUFFER) { POOL.BUFFER = dup([32, 0]) } //New technique: Only allocate from ArrayBufferView and Buffer var DATA = POOL.DATA , BUFFER = POOL.BUFFER exports.free = function free(array) { if(Buffer.isBuffer(array)) { BUFFER[bits.log2(array.length)].push(array) } else { if(Object.prototype.toString.call(array) !== '[object ArrayBuffer]') { array = array.buffer } if(!array) { return } var n = array.length || array.byteLength var log_n = bits.log2(n)|0 DATA[log_n].push(array) } } function freeArrayBuffer(buffer) { if(!buffer) { return } var n = buffer.length || buffer.byteLength var log_n = bits.log2(n) DATA[log_n].push(buffer) } function freeTypedArray(array) { freeArrayBuffer(array.buffer) } exports.freeUint8 = exports.freeUint16 = exports.freeUint32 = exports.freeInt8 = exports.freeInt16 = exports.freeInt32 = exports.freeFloat32 = exports.freeFloat = exports.freeFloat64 = exports.freeDouble = exports.freeUint8Clamped = exports.freeDataView = freeTypedArray exports.freeArrayBuffer = freeArrayBuffer exports.freeBuffer = function freeBuffer(array) { BUFFER[bits.log2(array.length)].push(array) } exports.malloc = function malloc(n, dtype) { if(dtype === undefined || dtype === 'arraybuffer') { return mallocArrayBuffer(n) } else { switch(dtype) { case 'uint8': return mallocUint8(n) case 'uint16': return mallocUint16(n) case 'uint32': return mallocUint32(n) case 'int8': return mallocInt8(n) case 'int16': return mallocInt16(n) case 'int32': return mallocInt32(n) case 'float': case 'float32': return mallocFloat(n) case 'double': case 'float64': return mallocDouble(n) case 'uint8_clamped': return mallocUint8Clamped(n) case 'buffer': return mallocBuffer(n) case 'data': case 'dataview': return mallocDataView(n) default: return null } } return null } function mallocArrayBuffer(n) { var n = bits.nextPow2(n) var log_n = bits.log2(n) var d = DATA[log_n] if(d.length > 0) { return d.pop() } return new ArrayBuffer(n) } exports.mallocArrayBuffer = mallocArrayBuffer function mallocUint8(n) { return new Uint8Array(mallocArrayBuffer(n), 0, n) } exports.mallocUint8 = mallocUint8 function mallocUint16(n) { return new Uint16Array(mallocArrayBuffer(2*n), 0, n) } exports.mallocUint16 = mallocUint16 function mallocUint32(n) { return new Uint32Array(mallocArrayBuffer(4*n), 0, n) } exports.mallocUint32 = mallocUint32 function mallocInt8(n) { return new Int8Array(mallocArrayBuffer(n), 0, n) } exports.mallocInt8 = mallocInt8 function mallocInt16(n) { return new Int16Array(mallocArrayBuffer(2*n), 0, n) } exports.mallocInt16 = mallocInt16 function mallocInt32(n) { return new Int32Array(mallocArrayBuffer(4*n), 0, n) } exports.mallocInt32 = mallocInt32 function mallocFloat(n) { return new Float32Array(mallocArrayBuffer(4*n), 0, n) } exports.mallocFloat32 = exports.mallocFloat = mallocFloat function mallocDouble(n) { return new Float64Array(mallocArrayBuffer(8*n), 0, n) } exports.mallocFloat64 = exports.mallocDouble = mallocDouble function mallocUint8Clamped(n) { if(hasUint8C) { return new Uint8ClampedArray(mallocArrayBuffer(n), 0, n) } else { return mallocUint8(n) } } exports.mallocUint8Clamped = mallocUint8Clamped function mallocDataView(n) { return new DataView(mallocArrayBuffer(n), 0, n) } exports.mallocDataView = mallocDataView function mallocBuffer(n) { n = bits.nextPow2(n) var log_n = bits.log2(n) var cache = BUFFER[log_n] if(cache.length > 0) { return cache.pop() } return new Buffer(n) } exports.mallocBuffer = mallocBuffer exports.clearCache = function clearCache() { for(var i=0; i<32; ++i) { POOL.UINT8[i].length = 0 POOL.UINT16[i].length = 0 POOL.UINT32[i].length = 0 POOL.INT8[i].length = 0 POOL.INT16[i].length = 0 POOL.INT32[i].length = 0 POOL.FLOAT[i].length = 0 POOL.DOUBLE[i].length = 0 POOL.UINT8C[i].length = 0 DATA[i].length = 0 BUFFER[i].length = 0 } } }).call(this,typeof global !== "undefined" ? global : typeof self !== "undefined" ? self : typeof window !== "undefined" ? window : {},require("buffer").Buffer) },{"bit-twiddle":49,"buffer":50,"dup":72}],234:[function(require,module,exports){ "use strict" function unique_pred(list, compare) { var ptr = 1 , len = list.length , a=list[0], b=list[0] for(var i=1; i 8192) { throw new Error("vectorize-text: String too long (sorry, this will get fixed later)") } var height = 3 * size if(canvas.height < height) { canvas.height = height } context.fillStyle = "#000" context.fillRect(0, 0, canvas.width, canvas.height) context.fillStyle = "#fff" context.fillText(str, size, 2*size) //Cut pixels from image var pixelData = context.getImageData(0, 0, width, height) var pixels = ndarray(pixelData.data, [height, width, 4]) return pixels.pick(-1,-1,0).transpose(1,0) } function getContour(pixels, doSimplify) { var contour = surfaceNets(pixels, 128) if(doSimplify) { return simplify(contour.cells, contour.positions, 0.25) } return { edges: contour.cells, positions: contour.positions } } function processPixelsImpl(pixels, options, size, simplify) { //Extract contour var contour = getContour(pixels, simplify) //Apply warp to positions var positions = transformPositions(contour.positions, options, size) var edges = contour.edges var flip = "ccw" === options.orientation //Clean up the PSLG, resolve self intersections, etc. cleanPSLG(positions, edges) //If triangulate flag passed, triangulate the result if(options.polygons || options.polygon || options.polyline) { var result = toPolygonCrappy(edges, positions) var nresult = new Array(result.length) for(var i=0; i 0) { var b = stack.pop() var a = stack.pop() //Find opposite pairs var x = -1, y = -1 var star = stars[a] for(var i=1; i= 0) { continue } //Flip the edge triangulation.flip(a, b) //Test flipping neighboring edges testFlip(points, triangulation, stack, x, a, y) testFlip(points, triangulation, stack, a, y, x) testFlip(points, triangulation, stack, y, b, x) testFlip(points, triangulation, stack, b, x, y) } } },{"binary-search-bounds":242,"robust-in-sphere":243}],239:[function(require,module,exports){ 'use strict' var bsearch = require('binary-search-bounds') module.exports = classifyFaces function FaceIndex(cells, neighbor, constraint, flags, active, next, boundary) { this.cells = cells this.neighbor = neighbor this.flags = flags this.constraint = constraint this.active = active this.next = next this.boundary = boundary } var proto = FaceIndex.prototype function compareCell(a, b) { return a[0] - b[0] || a[1] - b[1] || a[2] - b[2] } proto.locate = (function() { var key = [0,0,0] return function(a, b, c) { var x = a, y = b, z = c if(b < c) { if(b < a) { x = b y = c z = a } } else if(c < a) { x = c y = a z = b } if(x < 0) { return -1 } key[0] = x key[1] = y key[2] = z return bsearch.eq(this.cells, key, compareCell) } })() function indexCells(triangulation, infinity) { //First get cells and canonicalize var cells = triangulation.cells() var nc = cells.length for(var i=0; i 0 || next.length > 0) { while(active.length > 0) { var t = active.pop() if(flags[t] === -side) { continue } flags[t] = side var c = cells[t] for(var j=0; j<3; ++j) { var f = neighbor[3*t+j] if(f >= 0 && flags[f] === 0) { if(constraint[3*t+j]) { next.push(f) } else { active.push(f) flags[f] = side } } } } //Swap arrays and loop var tmp = next next = active active = tmp next.length = 0 side = -side } var result = filterCells(cells, flags, target) if(infinity) { return result.concat(index.boundary) } return result } },{"binary-search-bounds":242}],240:[function(require,module,exports){ 'use strict' var bsearch = require('binary-search-bounds') var orient = require('robust-orientation')[3] var EVENT_POINT = 0 var EVENT_END = 1 var EVENT_START = 2 module.exports = monotoneTriangulate //A partial convex hull fragment, made of two unimonotone polygons function PartialHull(a, b, idx, lowerIds, upperIds) { this.a = a this.b = b this.idx = idx this.lowerIds = lowerIds this.upperIds = upperIds } //An event in the sweep line procedure function Event(a, b, type, idx) { this.a = a this.b = b this.type = type this.idx = idx } //This is used to compare events for the sweep line procedure // Points are: // 1. sorted lexicographically // 2. sorted by type (point < end < start) // 3. segments sorted by winding order // 4. sorted by index function compareEvent(a, b) { var d = (a.a[0] - b.a[0]) || (a.a[1] - b.a[1]) || (a.type - b.type) if(d) { return d } if(a.type !== EVENT_POINT) { d = orient(a.a, a.b, b.b) if(d) { return d } } return a.idx - b.idx } function testPoint(hull, p) { return orient(hull.a, hull.b, p) } function addPoint(cells, hulls, points, p, idx) { var lo = bsearch.lt(hulls, p, testPoint) var hi = bsearch.gt(hulls, p, testPoint) for(var i=lo; i 1 && orient( points[lowerIds[m-2]], points[lowerIds[m-1]], p) > 0) { cells.push( [lowerIds[m-1], lowerIds[m-2], idx]) m -= 1 } lowerIds.length = m lowerIds.push(idx) //Insert p into upper hull var upperIds = hull.upperIds var m = upperIds.length while(m > 1 && orient( points[upperIds[m-2]], points[upperIds[m-1]], p) < 0) { cells.push( [upperIds[m-2], upperIds[m-1], idx]) m -= 1 } upperIds.length = m upperIds.push(idx) } } function findSplit(hull, edge) { var d if(hull.a[0] < edge.a[0]) { d = orient(hull.a, hull.b, edge.a) } else { d = orient(edge.b, edge.a, hull.a) } if(d) { return d } if(edge.b[0] < hull.b[0]) { d = orient(hull.a, hull.b, edge.b) } else { d = orient(edge.b, edge.a, hull.b) } return d || hull.idx - edge.idx } function splitHulls(hulls, points, event) { var splitIdx = bsearch.le(hulls, event, findSplit) var hull = hulls[splitIdx] var upperIds = hull.upperIds var x = upperIds[upperIds.length-1] hull.upperIds = [x] hulls.splice(splitIdx+1, 0, new PartialHull(event.a, event.b, event.idx, [x], upperIds)) } function mergeHulls(hulls, points, event) { //Swap pointers for merge search var tmp = event.a event.a = event.b event.b = tmp var mergeIdx = bsearch.eq(hulls, event, findSplit) var upper = hulls[mergeIdx] var lower = hulls[mergeIdx-1] lower.upperIds = upper.upperIds hulls.splice(mergeIdx, 1) } function monotoneTriangulate(points, edges) { var numPoints = points.length var numEdges = edges.length var events = [] //Create point events for(var i=0; i b[0]) { events.push( new Event(b, a, EVENT_START, i), new Event(a, b, EVENT_END, i)) } } //Sort events events.sort(compareEvent) //Initialize hull var minX = events[0].a[0] - (1 + Math.abs(events[0].a[0])) * Math.pow(2, -52) var hull = [ new PartialHull([minX, 1], [minX, 0], -1, [], [], [], []) ] //Process events in order var cells = [] for(var i=0, numEvents=events.length; i= 0 } })() proto.removeTriangle = function(i, j, k) { var stars = this.stars removePair(stars[i], j, k) removePair(stars[j], k, i) removePair(stars[k], i, j) } proto.addTriangle = function(i, j, k) { var stars = this.stars stars[i].push(j, k) stars[j].push(k, i) stars[k].push(i, j) } proto.opposite = function(j, i) { var list = this.stars[i] for(var k=1, n=list.length; k>1 return ["sum(", generateSum(expr.slice(0, m)), ",", generateSum(expr.slice(m)), ")"].join("") } } function makeProduct(a, b) { if(a.charAt(0) === "m") { if(b.charAt(0) === "w") { var toks = a.split("[") return ["w", b.substr(1), "m", toks[0].substr(1)].join("") } else { return ["prod(", a, ",", b, ")"].join("") } } else { return makeProduct(b, a) } } function sign(s) { if(s & 1 !== 0) { return "-" } return "" } function determinant(m) { if(m.length === 2) { return [["diff(", makeProduct(m[0][0], m[1][1]), ",", makeProduct(m[1][0], m[0][1]), ")"].join("")] } else { var expr = [] for(var i=0; i 0) { return [nextafter(f, -Infinity), f] } else { return [f, f] } } //Convert a list of edges in a pslg to bounding boxes function boundEdges(points, edges) { var bounds = new Array(edges.length) for(var i=0; i= floatPoints.length) { return ratPoints[idx-floatPoints.length] } var p = floatPoints[idx] return [ rat(p[0]), rat(p[1]) ] } junctions.sort(function(a, b) { if(a[0] !== b[0]) { return a[0] - b[0] } var u = getPoint(a[1]) var v = getPoint(b[1]) return ratCmp(u[0], v[0]) || ratCmp(u[1], v[1]) }) //Split edges along junctions for(var i=junctions.length-1; i>=0; --i) { var junction = junctions[i] var e = junction[0] var edge = edges[e] var s = edge[0] var t = edge[1] //Check if edge is not lexicographically sorted var a = floatPoints[s] var b = floatPoints[t] if(((a[0] - b[0]) || (a[1] - b[1])) < 0) { var tmp = s s = t t = tmp } //Split leading edge edge[0] = s var last = edge[1] = junction[1] //If we are grouping edges by color, remember to track data var color if(useColor) { color = edge[2] } //Split other edges while(i > 0 && junctions[i-1][0] === e) { var junction = junctions[--i] var next = junction[1] if(useColor) { edges.push([last, next, color]) } else { edges.push([last, next]) } last = next } //Add final edge if(useColor) { edges.push([last, t, color]) } else { edges.push([last, t]) } } //Return constructed rational points return ratPoints } //Merge overlapping points function dedupPoints(floatPoints, ratPoints, floatBounds) { var numPoints = floatPoints.length + ratPoints.length var uf = new UnionFind(numPoints) //Compute rational bounds var bounds = floatBounds for(var i=0; i b[2]) { return 1 } return 0 } //Remove duplicate edge labels function dedupEdges(edges, labels, useColor) { if(edges.length === 0) { return } if(labels) { for(var i=0; i 0 || tjunctions.length > 0) } // More iterations necessary return true } //Main loop, runs PSLG clean up until completion function cleanPSLG(points, edges, colors) { var modified = false //If using colors, augment edges with color data var prevEdges if(colors) { prevEdges = edges var augEdges = new Array(edges.length) for(var i=0; i 0) { a = a.shln(shift) } else if(shift < 0) { b = b.shln(-shift) } return rationalize(a, b) } },{"./div":248,"./is-rat":250,"./lib/is-bn":254,"./lib/num-to-bn":255,"./lib/rationalize":256,"./lib/str-to-bn":257}],250:[function(require,module,exports){ 'use strict' var isBN = require('./lib/is-bn') module.exports = isRat function isRat(x) { return Array.isArray(x) && x.length === 2 && isBN(x[0]) && isBN(x[1]) } },{"./lib/is-bn":254}],251:[function(require,module,exports){ 'use strict' var bn = require('bn.js') module.exports = sign function sign(x) { return x.cmp(new bn(0)) } },{"bn.js":259}],252:[function(require,module,exports){ 'use strict' module.exports = bn2num //TODO: Make this better function bn2num(b) { var l = b.length var words = b.words var out = 0 if (l === 1) { out = words[0] } else if (l === 2) { out = words[0] + (words[1] * 0x4000000) } else { var out = 0 for (var i = 0; i < l; i++) { var w = words[i] out += w * Math.pow(0x4000000, i) } } return b.sign ? -out : out } },{}],253:[function(require,module,exports){ 'use strict' var db = require('double-bits') var ctz = require('bit-twiddle').countTrailingZeros module.exports = ctzNumber //Counts the number of trailing zeros function ctzNumber(x) { var l = ctz(db.lo(x)) if(l < 32) { return l } var h = ctz(db.hi(x)) if(h > 20) { return 52 } return h + 32 } },{"bit-twiddle":49,"double-bits":270}],254:[function(require,module,exports){ 'use strict' var BN = require('bn.js') module.exports = isBN //Test if x is a bignumber //FIXME: obviously this is the wrong way to do it function isBN(x) { return x && typeof x === 'object' && Boolean(x.words) } },{"bn.js":259}],255:[function(require,module,exports){ 'use strict' var BN = require('bn.js') var db = require('double-bits') module.exports = num2bn function num2bn(x) { var e = db.exponent(x) if(e < 52) { return new BN(x) } else { return (new BN(x * Math.pow(2, 52-e))).shln(e-52) } } },{"bn.js":259,"double-bits":270}],256:[function(require,module,exports){ 'use strict' var num2bn = require('./num-to-bn') var sign = require('./bn-sign') module.exports = rationalize function rationalize(numer, denom) { var snumer = sign(numer) var sdenom = sign(denom) if(snumer === 0) { return [num2bn(0), num2bn(1)] } if(sdenom === 0) { return [num2bn(0), num2bn(0)] } if(sdenom < 0) { numer = numer.neg() denom = denom.neg() } var d = numer.gcd(denom) if(d.cmpn(1)) { return [ numer.div(d), denom.div(d) ] } return [ numer, denom ] } },{"./bn-sign":251,"./num-to-bn":255}],257:[function(require,module,exports){ 'use strict' var BN = require('bn.js') module.exports = str2BN function str2BN(x) { return new BN(x) } },{"bn.js":259}],258:[function(require,module,exports){ 'use strict' var rationalize = require('./lib/rationalize') module.exports = mul function mul(a, b) { return rationalize(a[0].mul(b[0]), a[1].mul(b[1])) } },{"./lib/rationalize":256}],259:[function(require,module,exports){ (function (module, exports) { 'use strict'; // Utils function assert(val, msg) { if (!val) throw new Error(msg || 'Assertion failed'); } // Could use `inherits` module, but don't want to move from single file // architecture yet. function inherits(ctor, superCtor) { ctor.super_ = superCtor; var TempCtor = function () {}; TempCtor.prototype = superCtor.prototype; ctor.prototype = new TempCtor(); ctor.prototype.constructor = ctor; } // BN function BN(number, base, endian) { // May be `new BN(bn)` ? if (number !== null && typeof number === 'object' && Array.isArray(number.words)) { return number; } this.sign = false; this.words = null; this.length = 0; // Reduction context this.red = null; if (base === 'le' || base === 'be') { endian = base; base = 10; } if (number !== null) this._init(number || 0, base || 10, endian || 'be'); } if (typeof module === 'object') module.exports = BN; else exports.BN = BN; BN.BN = BN; BN.wordSize = 26; BN.prototype._init = function init(number, base, endian) { if (typeof number === 'number') { return this._initNumber(number, base, endian); } else if (typeof number === 'object') { return this._initArray(number, base, endian); } if (base === 'hex') base = 16; assert(base === (base | 0) && base >= 2 && base <= 36); number = number.toString().replace(/\s+/g, ''); var start = 0; if (number[0] === '-') start++; if (base === 16) this._parseHex(number, start); else this._parseBase(number, base, start); if (number[0] === '-') this.sign = true; this.strip(); if (endian !== 'le') return; this._initArray(this.toArray(), base, endian); }; BN.prototype._initNumber = function _initNumber(number, base, endian) { if (number < 0) { this.sign = true; number = -number; } if (number < 0x4000000) { this.words = [ number & 0x3ffffff ]; this.length = 1; } else if (number < 0x10000000000000) { this.words = [ number & 0x3ffffff, (number / 0x4000000) & 0x3ffffff ]; this.length = 2; } else { assert(number < 0x20000000000000); // 2 ^ 53 (unsafe) this.words = [ number & 0x3ffffff, (number / 0x4000000) & 0x3ffffff, 1 ]; this.length = 3; } if (endian !== 'le') return; // Reverse the bytes this._initArray(this.toArray(), base, endian); }; BN.prototype._initArray = function _initArray(number, base, endian) { // Perhaps a Uint8Array assert(typeof number.length === 'number'); if (number.length <= 0) { this.words = [ 0 ]; this.length = 1; return this; } this.length = Math.ceil(number.length / 3); this.words = new Array(this.length); for (var i = 0; i < this.length; i++) this.words[i] = 0; var off = 0; if (endian === 'be') { for (var i = number.length - 1, j = 0; i >= 0; i -= 3) { var w = number[i] | (number[i - 1] << 8) | (number[i - 2] << 16); this.words[j] |= (w << off) & 0x3ffffff; this.words[j + 1] = (w >>> (26 - off)) & 0x3ffffff; off += 24; if (off >= 26) { off -= 26; j++; } } } else if (endian === 'le') { for (var i = 0, j = 0; i < number.length; i += 3) { var w = number[i] | (number[i + 1] << 8) | (number[i + 2] << 16); this.words[j] |= (w << off) & 0x3ffffff; this.words[j + 1] = (w >>> (26 - off)) & 0x3ffffff; off += 24; if (off >= 26) { off -= 26; j++; } } } return this.strip(); }; function parseHex(str, start, end) { var r = 0; var len = Math.min(str.length, end); for (var i = start; i < len; i++) { var c = str.charCodeAt(i) - 48; r <<= 4; // 'a' - 'f' if (c >= 49 && c <= 54) r |= c - 49 + 0xa; // 'A' - 'F' else if (c >= 17 && c <= 22) r |= c - 17 + 0xa; // '0' - '9' else r |= c & 0xf; } return r; } BN.prototype._parseHex = function _parseHex(number, start) { // Create possibly bigger array to ensure that it fits the number this.length = Math.ceil((number.length - start) / 6); this.words = new Array(this.length); for (var i = 0; i < this.length; i++) this.words[i] = 0; // Scan 24-bit chunks and add them to the number var off = 0; for (var i = number.length - 6, j = 0; i >= start; i -= 6) { var w = parseHex(number, i, i + 6); this.words[j] |= (w << off) & 0x3ffffff; this.words[j + 1] |= w >>> (26 - off) & 0x3fffff; off += 24; if (off >= 26) { off -= 26; j++; } } if (i + 6 !== start) { var w = parseHex(number, start, i + 6); this.words[j] |= (w << off) & 0x3ffffff; this.words[j + 1] |= w >>> (26 - off) & 0x3fffff; } this.strip(); }; function parseBase(str, start, end, mul) { var r = 0; var len = Math.min(str.length, end); for (var i = start; i < len; i++) { var c = str.charCodeAt(i) - 48; r *= mul; // 'a' if (c >= 49) r += c - 49 + 0xa; // 'A' else if (c >= 17) r += c - 17 + 0xa; // '0' - '9' else r += c; } return r; } BN.prototype._parseBase = function _parseBase(number, base, start) { // Initialize as zero this.words = [ 0 ]; this.length = 1; // Find length of limb in base for (var limbLen = 0, limbPow = 1; limbPow <= 0x3ffffff; limbPow *= base) limbLen++; limbLen--; limbPow = (limbPow / base) | 0; var total = number.length - start; var mod = total % limbLen; var end = Math.min(total, total - mod) + start; var word = 0; for (var i = start; i < end; i += limbLen) { word = parseBase(number, i, i + limbLen, base); this.imuln(limbPow); if (this.words[0] + word < 0x4000000) this.words[0] += word; else this._iaddn(word); } if (mod !== 0) { var pow = 1; var word = parseBase(number, i, number.length, base); for (var i = 0; i < mod; i++) pow *= base; this.imuln(pow); if (this.words[0] + word < 0x4000000) this.words[0] += word; else this._iaddn(word); } }; BN.prototype.copy = function copy(dest) { dest.words = new Array(this.length); for (var i = 0; i < this.length; i++) dest.words[i] = this.words[i]; dest.length = this.length; dest.sign = this.sign; dest.red = this.red; }; BN.prototype.clone = function clone() { var r = new BN(null); this.copy(r); return r; }; // Remove leading `0` from `this` BN.prototype.strip = function strip() { while (this.length > 1 && this.words[this.length - 1] === 0) this.length--; return this._normSign(); }; BN.prototype._normSign = function _normSign() { // -0 = 0 if (this.length === 1 && this.words[0] === 0) this.sign = false; return this; }; BN.prototype.inspect = function inspect() { return (this.red ? ''; }; /* var zeros = []; var groupSizes = []; var groupBases = []; var s = ''; var i = -1; while (++i < BN.wordSize) { zeros[i] = s; s += '0'; } groupSizes[0] = 0; groupSizes[1] = 0; groupBases[0] = 0; groupBases[1] = 0; var base = 2 - 1; while (++base < 36 + 1) { var groupSize = 0; var groupBase = 1; while (groupBase < (1 << BN.wordSize) / base) { groupBase *= base; groupSize += 1; } groupSizes[base] = groupSize; groupBases[base] = groupBase; } */ var zeros = [ '', '0', '00', '000', '0000', '00000', '000000', '0000000', '00000000', '000000000', '0000000000', '00000000000', '000000000000', '0000000000000', '00000000000000', '000000000000000', '0000000000000000', '00000000000000000', '000000000000000000', '0000000000000000000', '00000000000000000000', '000000000000000000000', '0000000000000000000000', '00000000000000000000000', '000000000000000000000000', '0000000000000000000000000' ]; var groupSizes = [ 0, 0, 25, 16, 12, 11, 10, 9, 8, 8, 7, 7, 7, 7, 6, 6, 6, 6, 6, 6, 6, 5, 5, 5, 5, 5, 5, 5, 5, 5, 5, 5, 5, 5, 5, 5, 5 ]; var groupBases = [ 0, 0, 33554432, 43046721, 16777216, 48828125, 60466176, 40353607, 16777216, 43046721, 10000000, 19487171, 35831808, 62748517, 7529536, 11390625, 16777216, 24137569, 34012224, 47045881, 64000000, 4084101, 5153632, 6436343, 7962624, 9765625, 11881376, 14348907, 17210368, 20511149, 24300000, 28629151, 33554432, 39135393, 45435424, 52521875, 60466176 ]; BN.prototype.toString = function toString(base, padding) { base = base || 10; if (base === 16 || base === 'hex') { var out = ''; var off = 0; var padding = padding | 0 || 1; var carry = 0; for (var i = 0; i < this.length; i++) { var w = this.words[i]; var word = (((w << off) | carry) & 0xffffff).toString(16); carry = (w >>> (24 - off)) & 0xffffff; if (carry !== 0 || i !== this.length - 1) out = zeros[6 - word.length] + word + out; else out = word + out; off += 2; if (off >= 26) { off -= 26; i--; } } if (carry !== 0) out = carry.toString(16) + out; while (out.length % padding !== 0) out = '0' + out; if (this.sign) out = '-' + out; return out; } else if (base === (base | 0) && base >= 2 && base <= 36) { // var groupSize = Math.floor(BN.wordSize * Math.LN2 / Math.log(base)); var groupSize = groupSizes[base]; // var groupBase = Math.pow(base, groupSize); var groupBase = groupBases[base]; var out = ''; var c = this.clone(); c.sign = false; while (c.cmpn(0) !== 0) { var r = c.modn(groupBase).toString(base); c = c.idivn(groupBase); if (c.cmpn(0) !== 0) out = zeros[groupSize - r.length] + r + out; else out = r + out; } if (this.cmpn(0) === 0) out = '0' + out; if (this.sign) out = '-' + out; return out; } else { assert(false, 'Base should be between 2 and 36'); } }; BN.prototype.toJSON = function toJSON() { return this.toString(16); }; BN.prototype.toArray = function toArray(endian) { this.strip(); var res = new Array(this.byteLength()); res[0] = 0; var q = this.clone(); if (endian !== 'le') { // Assume big-endian for (var i = 0; q.cmpn(0) !== 0; i++) { var b = q.andln(0xff); q.ishrn(8); res[res.length - i - 1] = b; } } else { // Assume little-endian for (var i = 0; q.cmpn(0) !== 0; i++) { var b = q.andln(0xff); q.ishrn(8); res[i] = b; } } return res; }; if (Math.clz32) { BN.prototype._countBits = function _countBits(w) { return 32 - Math.clz32(w); }; } else { BN.prototype._countBits = function _countBits(w) { var t = w; var r = 0; if (t >= 0x1000) { r += 13; t >>>= 13; } if (t >= 0x40) { r += 7; t >>>= 7; } if (t >= 0x8) { r += 4; t >>>= 4; } if (t >= 0x02) { r += 2; t >>>= 2; } return r + t; }; } BN.prototype._zeroBits = function _zeroBits(w) { // Short-cut if (w === 0) return 26; var t = w; var r = 0; if ((t & 0x1fff) === 0) { r += 13; t >>>= 13; } if ((t & 0x7f) === 0) { r += 7; t >>>= 7; } if ((t & 0xf) === 0) { r += 4; t >>>= 4; } if ((t & 0x3) === 0) { r += 2; t >>>= 2; } if ((t & 0x1) === 0) r++; return r; }; // Return number of used bits in a BN BN.prototype.bitLength = function bitLength() { var hi = 0; var w = this.words[this.length - 1]; var hi = this._countBits(w); return (this.length - 1) * 26 + hi; }; // Number of trailing zero bits BN.prototype.zeroBits = function zeroBits() { if (this.cmpn(0) === 0) return 0; var r = 0; for (var i = 0; i < this.length; i++) { var b = this._zeroBits(this.words[i]); r += b; if (b !== 26) break; } return r; }; BN.prototype.byteLength = function byteLength() { return Math.ceil(this.bitLength() / 8); }; // Return negative clone of `this` BN.prototype.neg = function neg() { if (this.cmpn(0) === 0) return this.clone(); var r = this.clone(); r.sign = !this.sign; return r; }; // Or `num` with `this` in-place BN.prototype.ior = function ior(num) { this.sign = this.sign || num.sign; while (this.length < num.length) this.words[this.length++] = 0; for (var i = 0; i < num.length; i++) this.words[i] = this.words[i] | num.words[i]; return this.strip(); }; // Or `num` with `this` BN.prototype.or = function or(num) { if (this.length > num.length) return this.clone().ior(num); else return num.clone().ior(this); }; // And `num` with `this` in-place BN.prototype.iand = function iand(num) { this.sign = this.sign && num.sign; // b = min-length(num, this) var b; if (this.length > num.length) b = num; else b = this; for (var i = 0; i < b.length; i++) this.words[i] = this.words[i] & num.words[i]; this.length = b.length; return this.strip(); }; // And `num` with `this` BN.prototype.and = function and(num) { if (this.length > num.length) return this.clone().iand(num); else return num.clone().iand(this); }; // Xor `num` with `this` in-place BN.prototype.ixor = function ixor(num) { this.sign = this.sign || num.sign; // a.length > b.length var a; var b; if (this.length > num.length) { a = this; b = num; } else { a = num; b = this; } for (var i = 0; i < b.length; i++) this.words[i] = a.words[i] ^ b.words[i]; if (this !== a) for (; i < a.length; i++) this.words[i] = a.words[i]; this.length = a.length; return this.strip(); }; // Xor `num` with `this` BN.prototype.xor = function xor(num) { if (this.length > num.length) return this.clone().ixor(num); else return num.clone().ixor(this); }; // Set `bit` of `this` BN.prototype.setn = function setn(bit, val) { assert(typeof bit === 'number' && bit >= 0); var off = (bit / 26) | 0; var wbit = bit % 26; while (this.length <= off) this.words[this.length++] = 0; if (val) this.words[off] = this.words[off] | (1 << wbit); else this.words[off] = this.words[off] & ~(1 << wbit); return this.strip(); }; // Add `num` to `this` in-place BN.prototype.iadd = function iadd(num) { // negative + positive if (this.sign && !num.sign) { this.sign = false; var r = this.isub(num); this.sign = !this.sign; return this._normSign(); // positive + negative } else if (!this.sign && num.sign) { num.sign = false; var r = this.isub(num); num.sign = true; return r._normSign(); } // a.length > b.length var a; var b; if (this.length > num.length) { a = this; b = num; } else { a = num; b = this; } var carry = 0; for (var i = 0; i < b.length; i++) { var r = a.words[i] + b.words[i] + carry; this.words[i] = r & 0x3ffffff; carry = r >>> 26; } for (; carry !== 0 && i < a.length; i++) { var r = a.words[i] + carry; this.words[i] = r & 0x3ffffff; carry = r >>> 26; } this.length = a.length; if (carry !== 0) { this.words[this.length] = carry; this.length++; // Copy the rest of the words } else if (a !== this) { for (; i < a.length; i++) this.words[i] = a.words[i]; } return this; }; // Add `num` to `this` BN.prototype.add = function add(num) { if (num.sign && !this.sign) { num.sign = false; var res = this.sub(num); num.sign = true; return res; } else if (!num.sign && this.sign) { this.sign = false; var res = num.sub(this); this.sign = true; return res; } if (this.length > num.length) return this.clone().iadd(num); else return num.clone().iadd(this); }; // Subtract `num` from `this` in-place BN.prototype.isub = function isub(num) { // this - (-num) = this + num if (num.sign) { num.sign = false; var r = this.iadd(num); num.sign = true; return r._normSign(); // -this - num = -(this + num) } else if (this.sign) { this.sign = false; this.iadd(num); this.sign = true; return this._normSign(); } // At this point both numbers are positive var cmp = this.cmp(num); // Optimization - zeroify if (cmp === 0) { this.sign = false; this.length = 1; this.words[0] = 0; return this; } // a > b var a; var b; if (cmp > 0) { a = this; b = num; } else { a = num; b = this; } var carry = 0; for (var i = 0; i < b.length; i++) { var r = a.words[i] - b.words[i] + carry; carry = r >> 26; this.words[i] = r & 0x3ffffff; } for (; carry !== 0 && i < a.length; i++) { var r = a.words[i] + carry; carry = r >> 26; this.words[i] = r & 0x3ffffff; } // Copy rest of the words if (carry === 0 && i < a.length && a !== this) for (; i < a.length; i++) this.words[i] = a.words[i]; this.length = Math.max(this.length, i); if (a !== this) this.sign = true; return this.strip(); }; // Subtract `num` from `this` BN.prototype.sub = function sub(num) { return this.clone().isub(num); }; /* // NOTE: This could be potentionally used to generate loop-less multiplications function _genCombMulTo(alen, blen) { var len = alen + blen - 1; var src = [ 'var a = this.words, b = num.words, o = out.words, c = 0, w, ' + 'mask = 0x3ffffff, shift = 0x4000000;', 'out.length = ' + len + ';' ]; for (var k = 0; k < len; k++) { var minJ = Math.max(0, k - alen + 1); var maxJ = Math.min(k, blen - 1); for (var j = minJ; j <= maxJ; j++) { var i = k - j; var mul = 'a[' + i + '] * b[' + j + ']'; if (j === minJ) { src.push('w = ' + mul + ' + c;'); src.push('c = (w / shift) | 0;'); } else { src.push('w += ' + mul + ';'); src.push('c += (w / shift) | 0;'); } src.push('w &= mask;'); } src.push('o[' + k + '] = w;'); } src.push('if (c !== 0) {', ' o[' + k + '] = c;', ' out.length++;', '}', 'return out;'); return src.join('\n'); } */ BN.prototype._smallMulTo = function _smallMulTo(num, out) { out.sign = num.sign !== this.sign; out.length = this.length + num.length; var carry = 0; for (var k = 0; k < out.length - 1; k++) { // Sum all words with the same `i + j = k` and accumulate `ncarry`, // note that ncarry could be >= 0x3ffffff var ncarry = carry >>> 26; var rword = carry & 0x3ffffff; var maxJ = Math.min(k, num.length - 1); for (var j = Math.max(0, k - this.length + 1); j <= maxJ; j++) { var i = k - j; var a = this.words[i] | 0; var b = num.words[j] | 0; var r = a * b; var lo = r & 0x3ffffff; ncarry = (ncarry + ((r / 0x4000000) | 0)) | 0; lo = (lo + rword) | 0; rword = lo & 0x3ffffff; ncarry = (ncarry + (lo >>> 26)) | 0; } out.words[k] = rword; carry = ncarry; } if (carry !== 0) { out.words[k] = carry; } else { out.length--; } return out.strip(); }; BN.prototype._bigMulTo = function _bigMulTo(num, out) { out.sign = num.sign !== this.sign; out.length = this.length + num.length; var carry = 0; var hncarry = 0; for (var k = 0; k < out.length - 1; k++) { // Sum all words with the same `i + j = k` and accumulate `ncarry`, // note that ncarry could be >= 0x3ffffff var ncarry = hncarry; hncarry = 0; var rword = carry & 0x3ffffff; var maxJ = Math.min(k, num.length - 1); for (var j = Math.max(0, k - this.length + 1); j <= maxJ; j++) { var i = k - j; var a = this.words[i] | 0; var b = num.words[j] | 0; var r = a * b; var lo = r & 0x3ffffff; ncarry = (ncarry + ((r / 0x4000000) | 0)) | 0; lo = (lo + rword) | 0; rword = lo & 0x3ffffff; ncarry = (ncarry + (lo >>> 26)) | 0; hncarry += ncarry >>> 26; ncarry &= 0x3ffffff; } out.words[k] = rword; carry = ncarry; ncarry = hncarry; } if (carry !== 0) { out.words[k] = carry; } else { out.length--; } return out.strip(); }; BN.prototype.mulTo = function mulTo(num, out) { var res; if (this.length + num.length < 63) res = this._smallMulTo(num, out); else res = this._bigMulTo(num, out); return res; }; // Multiply `this` by `num` BN.prototype.mul = function mul(num) { var out = new BN(null); out.words = new Array(this.length + num.length); return this.mulTo(num, out); }; // In-place Multiplication BN.prototype.imul = function imul(num) { if (this.cmpn(0) === 0 || num.cmpn(0) === 0) { this.words[0] = 0; this.length = 1; return this; } var tlen = this.length; var nlen = num.length; this.sign = num.sign !== this.sign; this.length = this.length + num.length; this.words[this.length - 1] = 0; for (var k = this.length - 2; k >= 0; k--) { // Sum all words with the same `i + j = k` and accumulate `carry`, // note that carry could be >= 0x3ffffff var carry = 0; var rword = 0; var maxJ = Math.min(k, nlen - 1); for (var j = Math.max(0, k - tlen + 1); j <= maxJ; j++) { var i = k - j; var a = this.words[i]; var b = num.words[j]; var r = a * b; var lo = r & 0x3ffffff; carry += (r / 0x4000000) | 0; lo += rword; rword = lo & 0x3ffffff; carry += lo >>> 26; } this.words[k] = rword; this.words[k + 1] += carry; carry = 0; } // Propagate overflows var carry = 0; for (var i = 1; i < this.length; i++) { var w = this.words[i] + carry; this.words[i] = w & 0x3ffffff; carry = w >>> 26; } return this.strip(); }; BN.prototype.imuln = function imuln(num) { assert(typeof num === 'number'); // Carry var carry = 0; for (var i = 0; i < this.length; i++) { var w = this.words[i] * num; var lo = (w & 0x3ffffff) + (carry & 0x3ffffff); carry >>= 26; carry += (w / 0x4000000) | 0; // NOTE: lo is 27bit maximum carry += lo >>> 26; this.words[i] = lo & 0x3ffffff; } if (carry !== 0) { this.words[i] = carry; this.length++; } return this; }; BN.prototype.muln = function muln(num) { return this.clone().imuln(num); }; // `this` * `this` BN.prototype.sqr = function sqr() { return this.mul(this); }; // `this` * `this` in-place BN.prototype.isqr = function isqr() { return this.mul(this); }; // Shift-left in-place BN.prototype.ishln = function ishln(bits) { assert(typeof bits === 'number' && bits >= 0); var r = bits % 26; var s = (bits - r) / 26; var carryMask = (0x3ffffff >>> (26 - r)) << (26 - r); if (r !== 0) { var carry = 0; for (var i = 0; i < this.length; i++) { var newCarry = this.words[i] & carryMask; var c = (this.words[i] - newCarry) << r; this.words[i] = c | carry; carry = newCarry >>> (26 - r); } if (carry) { this.words[i] = carry; this.length++; } } if (s !== 0) { for (var i = this.length - 1; i >= 0; i--) this.words[i + s] = this.words[i]; for (var i = 0; i < s; i++) this.words[i] = 0; this.length += s; } return this.strip(); }; // Shift-right in-place // NOTE: `hint` is a lowest bit before trailing zeroes // NOTE: if `extended` is present - it will be filled with destroyed bits BN.prototype.ishrn = function ishrn(bits, hint, extended) { assert(typeof bits === 'number' && bits >= 0); var h; if (hint) h = (hint - (hint % 26)) / 26; else h = 0; var r = bits % 26; var s = Math.min((bits - r) / 26, this.length); var mask = 0x3ffffff ^ ((0x3ffffff >>> r) << r); var maskedWords = extended; h -= s; h = Math.max(0, h); // Extended mode, copy masked part if (maskedWords) { for (var i = 0; i < s; i++) maskedWords.words[i] = this.words[i]; maskedWords.length = s; } if (s === 0) { // No-op, we should not move anything at all } else if (this.length > s) { this.length -= s; for (var i = 0; i < this.length; i++) this.words[i] = this.words[i + s]; } else { this.words[0] = 0; this.length = 1; } var carry = 0; for (var i = this.length - 1; i >= 0 && (carry !== 0 || i >= h); i--) { var word = this.words[i]; this.words[i] = (carry << (26 - r)) | (word >>> r); carry = word & mask; } // Push carried bits as a mask if (maskedWords && carry !== 0) maskedWords.words[maskedWords.length++] = carry; if (this.length === 0) { this.words[0] = 0; this.length = 1; } this.strip(); return this; }; // Shift-left BN.prototype.shln = function shln(bits) { return this.clone().ishln(bits); }; // Shift-right BN.prototype.shrn = function shrn(bits) { return this.clone().ishrn(bits); }; // Test if n bit is set BN.prototype.testn = function testn(bit) { assert(typeof bit === 'number' && bit >= 0); var r = bit % 26; var s = (bit - r) / 26; var q = 1 << r; // Fast case: bit is much higher than all existing words if (this.length <= s) { return false; } // Check bit and return var w = this.words[s]; return !!(w & q); }; // Return only lowers bits of number (in-place) BN.prototype.imaskn = function imaskn(bits) { assert(typeof bits === 'number' && bits >= 0); var r = bits % 26; var s = (bits - r) / 26; assert(!this.sign, 'imaskn works only with positive numbers'); if (r !== 0) s++; this.length = Math.min(s, this.length); if (r !== 0) { var mask = 0x3ffffff ^ ((0x3ffffff >>> r) << r); this.words[this.length - 1] &= mask; } return this.strip(); }; // Return only lowers bits of number BN.prototype.maskn = function maskn(bits) { return this.clone().imaskn(bits); }; // Add plain number `num` to `this` BN.prototype.iaddn = function iaddn(num) { assert(typeof num === 'number'); if (num < 0) return this.isubn(-num); // Possible sign change if (this.sign) { if (this.length === 1 && this.words[0] < num) { this.words[0] = num - this.words[0]; this.sign = false; return this; } this.sign = false; this.isubn(num); this.sign = true; return this; } // Add without checks return this._iaddn(num); }; BN.prototype._iaddn = function _iaddn(num) { this.words[0] += num; // Carry for (var i = 0; i < this.length && this.words[i] >= 0x4000000; i++) { this.words[i] -= 0x4000000; if (i === this.length - 1) this.words[i + 1] = 1; else this.words[i + 1]++; } this.length = Math.max(this.length, i + 1); return this; }; // Subtract plain number `num` from `this` BN.prototype.isubn = function isubn(num) { assert(typeof num === 'number'); if (num < 0) return this.iaddn(-num); if (this.sign) { this.sign = false; this.iaddn(num); this.sign = true; return this; } this.words[0] -= num; // Carry for (var i = 0; i < this.length && this.words[i] < 0; i++) { this.words[i] += 0x4000000; this.words[i + 1] -= 1; } return this.strip(); }; BN.prototype.addn = function addn(num) { return this.clone().iaddn(num); }; BN.prototype.subn = function subn(num) { return this.clone().isubn(num); }; BN.prototype.iabs = function iabs() { this.sign = false; return this; }; BN.prototype.abs = function abs() { return this.clone().iabs(); }; BN.prototype._ishlnsubmul = function _ishlnsubmul(num, mul, shift) { // Bigger storage is needed var len = num.length + shift; var i; if (this.words.length < len) { var t = new Array(len); for (var i = 0; i < this.length; i++) t[i] = this.words[i]; this.words = t; } else { i = this.length; } // Zeroify rest this.length = Math.max(this.length, len); for (; i < this.length; i++) this.words[i] = 0; var carry = 0; for (var i = 0; i < num.length; i++) { var w = this.words[i + shift] + carry; var right = num.words[i] * mul; w -= right & 0x3ffffff; carry = (w >> 26) - ((right / 0x4000000) | 0); this.words[i + shift] = w & 0x3ffffff; } for (; i < this.length - shift; i++) { var w = this.words[i + shift] + carry; carry = w >> 26; this.words[i + shift] = w & 0x3ffffff; } if (carry === 0) return this.strip(); // Subtraction overflow assert(carry === -1); carry = 0; for (var i = 0; i < this.length; i++) { var w = -this.words[i] + carry; carry = w >> 26; this.words[i] = w & 0x3ffffff; } this.sign = true; return this.strip(); }; BN.prototype._wordDiv = function _wordDiv(num, mode) { var shift = this.length - num.length; var a = this.clone(); var b = num; // Normalize var bhi = b.words[b.length - 1]; var bhiBits = this._countBits(bhi); shift = 26 - bhiBits; if (shift !== 0) { b = b.shln(shift); a.ishln(shift); bhi = b.words[b.length - 1]; } // Initialize quotient var m = a.length - b.length; var q; if (mode !== 'mod') { q = new BN(null); q.length = m + 1; q.words = new Array(q.length); for (var i = 0; i < q.length; i++) q.words[i] = 0; } var diff = a.clone()._ishlnsubmul(b, 1, m); if (!diff.sign) { a = diff; if (q) q.words[m] = 1; } for (var j = m - 1; j >= 0; j--) { var qj = a.words[b.length + j] * 0x4000000 + a.words[b.length + j - 1]; // NOTE: (qj / bhi) is (0x3ffffff * 0x4000000 + 0x3ffffff) / 0x2000000 max // (0x7ffffff) qj = Math.min((qj / bhi) | 0, 0x3ffffff); a._ishlnsubmul(b, qj, j); while (a.sign) { qj--; a.sign = false; a._ishlnsubmul(b, 1, j); if (a.cmpn(0) !== 0) a.sign = !a.sign; } if (q) q.words[j] = qj; } if (q) q.strip(); a.strip(); // Denormalize if (mode !== 'div' && shift !== 0) a.ishrn(shift); return { div: q ? q : null, mod: a }; }; BN.prototype.divmod = function divmod(num, mode) { assert(num.cmpn(0) !== 0); if (this.sign && !num.sign) { var res = this.neg().divmod(num, mode); var div; var mod; if (mode !== 'mod') div = res.div.neg(); if (mode !== 'div') mod = res.mod.cmpn(0) === 0 ? res.mod : num.sub(res.mod); return { div: div, mod: mod }; } else if (!this.sign && num.sign) { var res = this.divmod(num.neg(), mode); var div; if (mode !== 'mod') div = res.div.neg(); return { div: div, mod: res.mod }; } else if (this.sign && num.sign) { return this.neg().divmod(num.neg(), mode); } // Both numbers are positive at this point // Strip both numbers to approximate shift value if (num.length > this.length || this.cmp(num) < 0) return { div: new BN(0), mod: this }; // Very short reduction if (num.length === 1) { if (mode === 'div') return { div: this.divn(num.words[0]), mod: null }; else if (mode === 'mod') return { div: null, mod: new BN(this.modn(num.words[0])) }; return { div: this.divn(num.words[0]), mod: new BN(this.modn(num.words[0])) }; } return this._wordDiv(num, mode); }; // Find `this` / `num` BN.prototype.div = function div(num) { return this.divmod(num, 'div').div; }; // Find `this` % `num` BN.prototype.mod = function mod(num) { return this.divmod(num, 'mod').mod; }; // Find Round(`this` / `num`) BN.prototype.divRound = function divRound(num) { var dm = this.divmod(num); // Fast case - exact division if (dm.mod.cmpn(0) === 0) return dm.div; var mod = dm.div.sign ? dm.mod.isub(num) : dm.mod; var half = num.shrn(1); var r2 = num.andln(1); var cmp = mod.cmp(half); // Round down if (cmp < 0 || r2 === 1 && cmp === 0) return dm.div; // Round up return dm.div.sign ? dm.div.isubn(1) : dm.div.iaddn(1); }; BN.prototype.modn = function modn(num) { assert(num <= 0x3ffffff); var p = (1 << 26) % num; var acc = 0; for (var i = this.length - 1; i >= 0; i--) acc = (p * acc + this.words[i]) % num; return acc; }; // In-place division by number BN.prototype.idivn = function idivn(num) { assert(num <= 0x3ffffff); var carry = 0; for (var i = this.length - 1; i >= 0; i--) { var w = this.words[i] + carry * 0x4000000; this.words[i] = (w / num) | 0; carry = w % num; } return this.strip(); }; BN.prototype.divn = function divn(num) { return this.clone().idivn(num); }; BN.prototype.egcd = function egcd(p) { assert(!p.sign); assert(p.cmpn(0) !== 0); var x = this; var y = p.clone(); if (x.sign) x = x.mod(p); else x = x.clone(); // A * x + B * y = x var A = new BN(1); var B = new BN(0); // C * x + D * y = y var C = new BN(0); var D = new BN(1); var g = 0; while (x.isEven() && y.isEven()) { x.ishrn(1); y.ishrn(1); ++g; } var yp = y.clone(); var xp = x.clone(); while (x.cmpn(0) !== 0) { while (x.isEven()) { x.ishrn(1); if (A.isEven() && B.isEven()) { A.ishrn(1); B.ishrn(1); } else { A.iadd(yp).ishrn(1); B.isub(xp).ishrn(1); } } while (y.isEven()) { y.ishrn(1); if (C.isEven() && D.isEven()) { C.ishrn(1); D.ishrn(1); } else { C.iadd(yp).ishrn(1); D.isub(xp).ishrn(1); } } if (x.cmp(y) >= 0) { x.isub(y); A.isub(C); B.isub(D); } else { y.isub(x); C.isub(A); D.isub(B); } } return { a: C, b: D, gcd: y.ishln(g) }; }; // This is reduced incarnation of the binary EEA // above, designated to invert members of the // _prime_ fields F(p) at a maximal speed BN.prototype._invmp = function _invmp(p) { assert(!p.sign); assert(p.cmpn(0) !== 0); var a = this; var b = p.clone(); if (a.sign) a = a.mod(p); else a = a.clone(); var x1 = new BN(1); var x2 = new BN(0); var delta = b.clone(); while (a.cmpn(1) > 0 && b.cmpn(1) > 0) { while (a.isEven()) { a.ishrn(1); if (x1.isEven()) x1.ishrn(1); else x1.iadd(delta).ishrn(1); } while (b.isEven()) { b.ishrn(1); if (x2.isEven()) x2.ishrn(1); else x2.iadd(delta).ishrn(1); } if (a.cmp(b) >= 0) { a.isub(b); x1.isub(x2); } else { b.isub(a); x2.isub(x1); } } if (a.cmpn(1) === 0) return x1; else return x2; }; BN.prototype.gcd = function gcd(num) { if (this.cmpn(0) === 0) return num.clone(); if (num.cmpn(0) === 0) return this.clone(); var a = this.clone(); var b = num.clone(); a.sign = false; b.sign = false; // Remove common factor of two for (var shift = 0; a.isEven() && b.isEven(); shift++) { a.ishrn(1); b.ishrn(1); } do { while (a.isEven()) a.ishrn(1); while (b.isEven()) b.ishrn(1); var r = a.cmp(b); if (r < 0) { // Swap `a` and `b` to make `a` always bigger than `b` var t = a; a = b; b = t; } else if (r === 0 || b.cmpn(1) === 0) { break; } a.isub(b); } while (true); return b.ishln(shift); }; // Invert number in the field F(num) BN.prototype.invm = function invm(num) { return this.egcd(num).a.mod(num); }; BN.prototype.isEven = function isEven() { return (this.words[0] & 1) === 0; }; BN.prototype.isOdd = function isOdd() { return (this.words[0] & 1) === 1; }; // And first word and num BN.prototype.andln = function andln(num) { return this.words[0] & num; }; // Increment at the bit position in-line BN.prototype.bincn = function bincn(bit) { assert(typeof bit === 'number'); var r = bit % 26; var s = (bit - r) / 26; var q = 1 << r; // Fast case: bit is much higher than all existing words if (this.length <= s) { for (var i = this.length; i < s + 1; i++) this.words[i] = 0; this.words[s] |= q; this.length = s + 1; return this; } // Add bit and propagate, if needed var carry = q; for (var i = s; carry !== 0 && i < this.length; i++) { var w = this.words[i]; w += carry; carry = w >>> 26; w &= 0x3ffffff; this.words[i] = w; } if (carry !== 0) { this.words[i] = carry; this.length++; } return this; }; BN.prototype.cmpn = function cmpn(num) { var sign = num < 0; if (sign) num = -num; if (this.sign && !sign) return -1; else if (!this.sign && sign) return 1; num &= 0x3ffffff; this.strip(); var res; if (this.length > 1) { res = 1; } else { var w = this.words[0]; res = w === num ? 0 : w < num ? -1 : 1; } if (this.sign) res = -res; return res; }; // Compare two numbers and return: // 1 - if `this` > `num` // 0 - if `this` == `num` // -1 - if `this` < `num` BN.prototype.cmp = function cmp(num) { if (this.sign && !num.sign) return -1; else if (!this.sign && num.sign) return 1; var res = this.ucmp(num); if (this.sign) return -res; else return res; }; // Unsigned comparison BN.prototype.ucmp = function ucmp(num) { // At this point both numbers have the same sign if (this.length > num.length) return 1; else if (this.length < num.length) return -1; var res = 0; for (var i = this.length - 1; i >= 0; i--) { var a = this.words[i]; var b = num.words[i]; if (a === b) continue; if (a < b) res = -1; else if (a > b) res = 1; break; } return res; }; // // A reduce context, could be using montgomery or something better, depending // on the `m` itself. // BN.red = function red(num) { return new Red(num); }; BN.prototype.toRed = function toRed(ctx) { assert(!this.red, 'Already a number in reduction context'); assert(!this.sign, 'red works only with positives'); return ctx.convertTo(this)._forceRed(ctx); }; BN.prototype.fromRed = function fromRed() { assert(this.red, 'fromRed works only with numbers in reduction context'); return this.red.convertFrom(this); }; BN.prototype._forceRed = function _forceRed(ctx) { this.red = ctx; return this; }; BN.prototype.forceRed = function forceRed(ctx) { assert(!this.red, 'Already a number in reduction context'); return this._forceRed(ctx); }; BN.prototype.redAdd = function redAdd(num) { assert(this.red, 'redAdd works only with red numbers'); return this.red.add(this, num); }; BN.prototype.redIAdd = function redIAdd(num) { assert(this.red, 'redIAdd works only with red numbers'); return this.red.iadd(this, num); }; BN.prototype.redSub = function redSub(num) { assert(this.red, 'redSub works only with red numbers'); return this.red.sub(this, num); }; BN.prototype.redISub = function redISub(num) { assert(this.red, 'redISub works only with red numbers'); return this.red.isub(this, num); }; BN.prototype.redShl = function redShl(num) { assert(this.red, 'redShl works only with red numbers'); return this.red.shl(this, num); }; BN.prototype.redMul = function redMul(num) { assert(this.red, 'redMul works only with red numbers'); this.red._verify2(this, num); return this.red.mul(this, num); }; BN.prototype.redIMul = function redIMul(num) { assert(this.red, 'redMul works only with red numbers'); this.red._verify2(this, num); return this.red.imul(this, num); }; BN.prototype.redSqr = function redSqr() { assert(this.red, 'redSqr works only with red numbers'); this.red._verify1(this); return this.red.sqr(this); }; BN.prototype.redISqr = function redISqr() { assert(this.red, 'redISqr works only with red numbers'); this.red._verify1(this); return this.red.isqr(this); }; // Square root over p BN.prototype.redSqrt = function redSqrt() { assert(this.red, 'redSqrt works only with red numbers'); this.red._verify1(this); return this.red.sqrt(this); }; BN.prototype.redInvm = function redInvm() { assert(this.red, 'redInvm works only with red numbers'); this.red._verify1(this); return this.red.invm(this); }; // Return negative clone of `this` % `red modulo` BN.prototype.redNeg = function redNeg() { assert(this.red, 'redNeg works only with red numbers'); this.red._verify1(this); return this.red.neg(this); }; BN.prototype.redPow = function redPow(num) { assert(this.red && !num.red, 'redPow(normalNum)'); this.red._verify1(this); return this.red.pow(this, num); }; // Prime numbers with efficient reduction var primes = { k256: null, p224: null, p192: null, p25519: null }; // Pseudo-Mersenne prime function MPrime(name, p) { // P = 2 ^ N - K this.name = name; this.p = new BN(p, 16); this.n = this.p.bitLength(); this.k = new BN(1).ishln(this.n).isub(this.p); this.tmp = this._tmp(); } MPrime.prototype._tmp = function _tmp() { var tmp = new BN(null); tmp.words = new Array(Math.ceil(this.n / 13)); return tmp; }; MPrime.prototype.ireduce = function ireduce(num) { // Assumes that `num` is less than `P^2` // num = HI * (2 ^ N - K) + HI * K + LO = HI * K + LO (mod P) var r = num; var rlen; do { this.split(r, this.tmp); r = this.imulK(r); r = r.iadd(this.tmp); rlen = r.bitLength(); } while (rlen > this.n); var cmp = rlen < this.n ? -1 : r.ucmp(this.p); if (cmp === 0) { r.words[0] = 0; r.length = 1; } else if (cmp > 0) { r.isub(this.p); } else { r.strip(); } return r; }; MPrime.prototype.split = function split(input, out) { input.ishrn(this.n, 0, out); }; MPrime.prototype.imulK = function imulK(num) { return num.imul(this.k); }; function K256() { MPrime.call( this, 'k256', 'ffffffff ffffffff ffffffff ffffffff ffffffff ffffffff fffffffe fffffc2f'); } inherits(K256, MPrime); K256.prototype.split = function split(input, output) { // 256 = 9 * 26 + 22 var mask = 0x3fffff; var outLen = Math.min(input.length, 9); for (var i = 0; i < outLen; i++) output.words[i] = input.words[i]; output.length = outLen; if (input.length <= 9) { input.words[0] = 0; input.length = 1; return; } // Shift by 9 limbs var prev = input.words[9]; output.words[output.length++] = prev & mask; for (var i = 10; i < input.length; i++) { var next = input.words[i]; input.words[i - 10] = ((next & mask) << 4) | (prev >>> 22); prev = next; } input.words[i - 10] = prev >>> 22; input.length -= 9; }; K256.prototype.imulK = function imulK(num) { // K = 0x1000003d1 = [ 0x40, 0x3d1 ] num.words[num.length] = 0; num.words[num.length + 1] = 0; num.length += 2; // bounded at: 0x40 * 0x3ffffff + 0x3d0 = 0x100000390 var hi; var lo = 0; for (var i = 0; i < num.length; i++) { var w = num.words[i]; hi = w * 0x40; lo += w * 0x3d1; hi += (lo / 0x4000000) | 0; lo &= 0x3ffffff; num.words[i] = lo; lo = hi; } // Fast length reduction if (num.words[num.length - 1] === 0) { num.length--; if (num.words[num.length - 1] === 0) num.length--; } return num; }; function P224() { MPrime.call( this, 'p224', 'ffffffff ffffffff ffffffff ffffffff 00000000 00000000 00000001'); } inherits(P224, MPrime); function P192() { MPrime.call( this, 'p192', 'ffffffff ffffffff ffffffff fffffffe ffffffff ffffffff'); } inherits(P192, MPrime); function P25519() { // 2 ^ 255 - 19 MPrime.call( this, '25519', '7fffffffffffffff ffffffffffffffff ffffffffffffffff ffffffffffffffed'); } inherits(P25519, MPrime); P25519.prototype.imulK = function imulK(num) { // K = 0x13 var carry = 0; for (var i = 0; i < num.length; i++) { var hi = num.words[i] * 0x13 + carry; var lo = hi & 0x3ffffff; hi >>>= 26; num.words[i] = lo; carry = hi; } if (carry !== 0) num.words[num.length++] = carry; return num; }; // Exported mostly for testing purposes, use plain name instead BN._prime = function prime(name) { // Cached version of prime if (primes[name]) return primes[name]; var prime; if (name === 'k256') prime = new K256(); else if (name === 'p224') prime = new P224(); else if (name === 'p192') prime = new P192(); else if (name === 'p25519') prime = new P25519(); else throw new Error('Unknown prime ' + name); primes[name] = prime; return prime; }; // // Base reduction engine // function Red(m) { if (typeof m === 'string') { var prime = BN._prime(m); this.m = prime.p; this.prime = prime; } else { this.m = m; this.prime = null; } } Red.prototype._verify1 = function _verify1(a) { assert(!a.sign, 'red works only with positives'); assert(a.red, 'red works only with red numbers'); }; Red.prototype._verify2 = function _verify2(a, b) { assert(!a.sign && !b.sign, 'red works only with positives'); assert(a.red && a.red === b.red, 'red works only with red numbers'); }; Red.prototype.imod = function imod(a) { if (this.prime) return this.prime.ireduce(a)._forceRed(this); return a.mod(this.m)._forceRed(this); }; Red.prototype.neg = function neg(a) { var r = a.clone(); r.sign = !r.sign; return r.iadd(this.m)._forceRed(this); }; Red.prototype.add = function add(a, b) { this._verify2(a, b); var res = a.add(b); if (res.cmp(this.m) >= 0) res.isub(this.m); return res._forceRed(this); }; Red.prototype.iadd = function iadd(a, b) { this._verify2(a, b); var res = a.iadd(b); if (res.cmp(this.m) >= 0) res.isub(this.m); return res; }; Red.prototype.sub = function sub(a, b) { this._verify2(a, b); var res = a.sub(b); if (res.cmpn(0) < 0) res.iadd(this.m); return res._forceRed(this); }; Red.prototype.isub = function isub(a, b) { this._verify2(a, b); var res = a.isub(b); if (res.cmpn(0) < 0) res.iadd(this.m); return res; }; Red.prototype.shl = function shl(a, num) { this._verify1(a); return this.imod(a.shln(num)); }; Red.prototype.imul = function imul(a, b) { this._verify2(a, b); return this.imod(a.imul(b)); }; Red.prototype.mul = function mul(a, b) { this._verify2(a, b); return this.imod(a.mul(b)); }; Red.prototype.isqr = function isqr(a) { return this.imul(a, a); }; Red.prototype.sqr = function sqr(a) { return this.mul(a, a); }; Red.prototype.sqrt = function sqrt(a) { if (a.cmpn(0) === 0) return a.clone(); var mod3 = this.m.andln(3); assert(mod3 % 2 === 1); // Fast case if (mod3 === 3) { var pow = this.m.add(new BN(1)).ishrn(2); var r = this.pow(a, pow); return r; } // Tonelli-Shanks algorithm (Totally unoptimized and slow) // // Find Q and S, that Q * 2 ^ S = (P - 1) var q = this.m.subn(1); var s = 0; while (q.cmpn(0) !== 0 && q.andln(1) === 0) { s++; q.ishrn(1); } assert(q.cmpn(0) !== 0); var one = new BN(1).toRed(this); var nOne = one.redNeg(); // Find quadratic non-residue // NOTE: Max is such because of generalized Riemann hypothesis. var lpow = this.m.subn(1).ishrn(1); var z = this.m.bitLength(); z = new BN(2 * z * z).toRed(this); while (this.pow(z, lpow).cmp(nOne) !== 0) z.redIAdd(nOne); var c = this.pow(z, q); var r = this.pow(a, q.addn(1).ishrn(1)); var t = this.pow(a, q); var m = s; while (t.cmp(one) !== 0) { var tmp = t; for (var i = 0; tmp.cmp(one) !== 0; i++) tmp = tmp.redSqr(); assert(i < m); var b = this.pow(c, new BN(1).ishln(m - i - 1)); r = r.redMul(b); c = b.redSqr(); t = t.redMul(c); m = i; } return r; }; Red.prototype.invm = function invm(a) { var inv = a._invmp(this.m); if (inv.sign) { inv.sign = false; return this.imod(inv).redNeg(); } else { return this.imod(inv); } }; Red.prototype.pow = function pow(a, num) { var w = []; if (num.cmpn(0) === 0) return new BN(1); var q = num.clone(); while (q.cmpn(0) !== 0) { w.push(q.andln(1)); q.ishrn(1); } // Skip leading zeroes var res = a; for (var i = 0; i < w.length; i++, res = this.sqr(res)) if (w[i] !== 0) break; if (++i < w.length) { for (var q = this.sqr(res); i < w.length; i++, q = this.sqr(q)) { if (w[i] === 0) continue; res = this.mul(res, q); } } return res; }; Red.prototype.convertTo = function convertTo(num) { var r = num.mod(this.m); if (r === num) return r.clone(); else return r; }; Red.prototype.convertFrom = function convertFrom(num) { var res = num.clone(); res.red = null; return res; }; // // Montgomery method engine // BN.mont = function mont(num) { return new Mont(num); }; function Mont(m) { Red.call(this, m); this.shift = this.m.bitLength(); if (this.shift % 26 !== 0) this.shift += 26 - (this.shift % 26); this.r = new BN(1).ishln(this.shift); this.r2 = this.imod(this.r.sqr()); this.rinv = this.r._invmp(this.m); this.minv = this.rinv.mul(this.r).isubn(1).div(this.m); this.minv.sign = true; this.minv = this.minv.mod(this.r); } inherits(Mont, Red); Mont.prototype.convertTo = function convertTo(num) { return this.imod(num.shln(this.shift)); }; Mont.prototype.convertFrom = function convertFrom(num) { var r = this.imod(num.mul(this.rinv)); r.red = null; return r; }; Mont.prototype.imul = function imul(a, b) { if (a.cmpn(0) === 0 || b.cmpn(0) === 0) { a.words[0] = 0; a.length = 1; return a; } var t = a.imul(b); var c = t.maskn(this.shift).mul(this.minv).imaskn(this.shift).mul(this.m); var u = t.isub(c).ishrn(this.shift); var res = u; if (u.cmp(this.m) >= 0) res = u.isub(this.m); else if (u.cmpn(0) < 0) res = u.iadd(this.m); return res._forceRed(this); }; Mont.prototype.mul = function mul(a, b) { if (a.cmpn(0) === 0 || b.cmpn(0) === 0) return new BN(0)._forceRed(this); var t = a.mul(b); var c = t.maskn(this.shift).mul(this.minv).imaskn(this.shift).mul(this.m); var u = t.isub(c).ishrn(this.shift); var res = u; if (u.cmp(this.m) >= 0) res = u.isub(this.m); else if (u.cmpn(0) < 0) res = u.iadd(this.m); return res._forceRed(this); }; Mont.prototype.invm = function invm(a) { // (AR)^-1 * R^2 = (A^-1 * R^-1) * R^2 = A^-1 * R var res = this.imod(a._invmp(this.m).mul(this.r2)); return res._forceRed(this); }; })(typeof module === 'undefined' || module, this); },{}],260:[function(require,module,exports){ 'use strict' var bnsign = require('./lib/bn-sign') module.exports = sign function sign(x) { return bnsign(x[0]) * bnsign(x[1]) } },{"./lib/bn-sign":251}],261:[function(require,module,exports){ 'use strict' var rationalize = require('./lib/rationalize') module.exports = sub function sub(a, b) { return rationalize(a[0].mul(b[1]).sub(a[1].mul(b[0])), a[1].mul(b[1])) } },{"./lib/rationalize":256}],262:[function(require,module,exports){ 'use strict' var bn2num = require('./lib/bn-to-num') var ctz = require('./lib/ctz') module.exports = roundRat //Round a rational to the closest float function roundRat(f) { var a = f[0] var b = f[1] if(a.cmpn(0) === 0) { return 0 } var h = a.divmod(b) var iv = h.div var x = bn2num(iv) var ir = h.mod if(ir.cmpn(0) === 0) { return x } if(x) { var s = ctz(x) + 4 var y = bn2num(ir.shln(s).divRound(b)) // flip the sign of y if x is negative if (x<0) { y = -y; } return x + y * Math.pow(2, -s) } else { var ybits = b.bitLength() - ir.bitLength() + 53 var y = bn2num(ir.shln(ybits).divRound(b)) if(ybits < 1023) { return y * Math.pow(2, -ybits) } y *= Math.pow(2, -1023) return y * Math.pow(2, 1023-ybits) } } },{"./lib/bn-to-num":252,"./lib/ctz":253}],263:[function(require,module,exports){ 'use strict' module.exports = boxIntersectWrapper var pool = require('typedarray-pool') var sweep = require('./lib/sweep') var boxIntersectIter = require('./lib/intersect') function boxEmpty(d, box) { for(var j=0; j>>1 if(d <= 0) { return } var retval //Convert red boxes var redList = pool.mallocDouble(2*d*n) var redIds = pool.mallocInt32(n) n = convertBoxes(red, d, redList, redIds) if(n > 0) { if(d === 1 && full) { //Special case: 1d complete sweep.init(n) retval = sweep.sweepComplete( d, visit, 0, n, redList, redIds, 0, n, redList, redIds) } else { //Convert blue boxes var blueList = pool.mallocDouble(2*d*m) var blueIds = pool.mallocInt32(m) m = convertBoxes(blue, d, blueList, blueIds) if(m > 0) { sweep.init(n+m) if(d === 1) { //Special case: 1d bipartite retval = sweep.sweepBipartite( d, visit, 0, n, redList, redIds, 0, m, blueList, blueIds) } else { //General case: d>1 retval = boxIntersectIter( d, visit, full, n, redList, redIds, m, blueList, blueIds) } pool.free(blueList) pool.free(blueIds) } } pool.free(redList) pool.free(redIds) } return retval } var RESULT function appendItem(i,j) { RESULT.push([i,j]) } function intersectFullArray(x) { RESULT = [] boxIntersect(x, x, appendItem, true) return RESULT } function intersectBipartiteArray(x, y) { RESULT = [] boxIntersect(x, y, appendItem, false) return RESULT } //User-friendly wrapper, handle full input and no-visitor cases function boxIntersectWrapper(arg0, arg1, arg2) { var result switch(arguments.length) { case 1: return intersectFullArray(arg0) case 2: if(typeof arg1 === 'function') { return boxIntersect(arg0, arg0, arg1, true) } else { return intersectBipartiteArray(arg0, arg1) } case 3: return boxIntersect(arg0, arg1, arg2, false) default: throw new Error('box-intersect: Invalid arguments') } } },{"./lib/intersect":265,"./lib/sweep":269,"typedarray-pool":233}],264:[function(require,module,exports){ 'use strict' var DIMENSION = 'd' var AXIS = 'ax' var VISIT = 'vv' var FLIP = 'fp' var ELEM_SIZE = 'es' var RED_START = 'rs' var RED_END = 're' var RED_BOXES = 'rb' var RED_INDEX = 'ri' var RED_PTR = 'rp' var BLUE_START = 'bs' var BLUE_END = 'be' var BLUE_BOXES = 'bb' var BLUE_INDEX = 'bi' var BLUE_PTR = 'bp' var RETVAL = 'rv' var INNER_LABEL = 'Q' var ARGS = [ DIMENSION, AXIS, VISIT, RED_START, RED_END, RED_BOXES, RED_INDEX, BLUE_START, BLUE_END, BLUE_BOXES, BLUE_INDEX ] function generateBruteForce(redMajor, flip, full) { var funcName = 'bruteForce' + (redMajor ? 'Red' : 'Blue') + (flip ? 'Flip' : '') + (full ? 'Full' : '') var code = ['function ', funcName, '(', ARGS.join(), '){', 'var ', ELEM_SIZE, '=2*', DIMENSION, ';'] var redLoop = 'for(var i=' + RED_START + ',' + RED_PTR + '=' + ELEM_SIZE + '*' + RED_START + ';' + 'i<' + RED_END +';' + '++i,' + RED_PTR + '+=' + ELEM_SIZE + '){' + 'var x0=' + RED_BOXES + '[' + AXIS + '+' + RED_PTR + '],' + 'x1=' + RED_BOXES + '[' + AXIS + '+' + RED_PTR + '+' + DIMENSION + '],' + 'xi=' + RED_INDEX + '[i];' var blueLoop = 'for(var j=' + BLUE_START + ',' + BLUE_PTR + '=' + ELEM_SIZE + '*' + BLUE_START + ';' + 'j<' + BLUE_END + ';' + '++j,' + BLUE_PTR + '+=' + ELEM_SIZE + '){' + 'var y0=' + BLUE_BOXES + '[' + AXIS + '+' + BLUE_PTR + '],' + (full ? 'y1=' + BLUE_BOXES + '[' + AXIS + '+' + BLUE_PTR + '+' + DIMENSION + '],' : '') + 'yi=' + BLUE_INDEX + '[j];' if(redMajor) { code.push(redLoop, INNER_LABEL, ':', blueLoop) } else { code.push(blueLoop, INNER_LABEL, ':', redLoop) } if(full) { code.push('if(y1' + BLUE_END + '-' + BLUE_START + '){') if(full) { invoke(true, false) code.push('}else{') invoke(false, false) } else { code.push('if(' + FLIP + '){') invoke(true, true) code.push('}else{') invoke(true, false) code.push('}}else{if(' + FLIP + '){') invoke(false, true) code.push('}else{') invoke(false, false) code.push('}') } code.push('}}return ' + funcName) var codeStr = prefix.join('') + code.join('') var proc = new Function(codeStr) return proc() } exports.partial = bruteForcePlanner(false) exports.full = bruteForcePlanner(true) },{}],265:[function(require,module,exports){ 'use strict' module.exports = boxIntersectIter var pool = require('typedarray-pool') var bits = require('bit-twiddle') var bruteForce = require('./brute') var bruteForcePartial = bruteForce.partial var bruteForceFull = bruteForce.full var sweep = require('./sweep') var findMedian = require('./median') var genPartition = require('./partition') //Twiddle parameters var BRUTE_FORCE_CUTOFF = 128 //Cut off for brute force search var SCAN_CUTOFF = (1<<22) //Cut off for two way scan var SCAN_COMPLETE_CUTOFF = (1<<22) //Partition functions var partitionInteriorContainsInterval = genPartition( '!(lo>=p0)&&!(p1>=hi)', ['p0', 'p1']) var partitionStartEqual = genPartition( 'lo===p0', ['p0']) var partitionStartLessThan = genPartition( 'lo 0) { top -= 1 var iptr = top * IFRAME_SIZE var axis = BOX_ISTACK[iptr] var redStart = BOX_ISTACK[iptr+1] var redEnd = BOX_ISTACK[iptr+2] var blueStart = BOX_ISTACK[iptr+3] var blueEnd = BOX_ISTACK[iptr+4] var state = BOX_ISTACK[iptr+5] var dptr = top * DFRAME_SIZE var lo = BOX_DSTACK[dptr] var hi = BOX_DSTACK[dptr+1] //Unpack state info var flip = (state & 1) var full = !!(state & 16) //Unpack indices var red = xBoxes var redIndex = xIndex var blue = yBoxes var blueIndex = yIndex if(flip) { red = yBoxes redIndex = yIndex blue = xBoxes blueIndex = xIndex } if(state & 2) { redEnd = partitionStartLessThan( d, axis, redStart, redEnd, red, redIndex, hi) if(redStart >= redEnd) { continue } } if(state & 4) { redStart = partitionEndLessThanEqual( d, axis, redStart, redEnd, red, redIndex, lo) if(redStart >= redEnd) { continue } } var redCount = redEnd - redStart var blueCount = blueEnd - blueStart if(full) { if(d * redCount * (redCount + blueCount) < SCAN_COMPLETE_CUTOFF) { retval = sweep.scanComplete( d, axis, visit, redStart, redEnd, red, redIndex, blueStart, blueEnd, blue, blueIndex) if(retval !== void 0) { return retval } continue } } else { if(d * Math.min(redCount, blueCount) < BRUTE_FORCE_CUTOFF) { //If input small, then use brute force retval = bruteForcePartial( d, axis, visit, flip, redStart, redEnd, red, redIndex, blueStart, blueEnd, blue, blueIndex) if(retval !== void 0) { return retval } continue } else if(d * redCount * blueCount < SCAN_CUTOFF) { //If input medium sized, then use sweep and prune retval = sweep.scanBipartite( d, axis, visit, flip, redStart, redEnd, red, redIndex, blueStart, blueEnd, blue, blueIndex) if(retval !== void 0) { return retval } continue } } //First, find all red intervals whose interior contains (lo,hi) var red0 = partitionInteriorContainsInterval( d, axis, redStart, redEnd, red, redIndex, lo, hi) //Lower dimensional case if(redStart < red0) { if(d * (red0 - redStart) < BRUTE_FORCE_CUTOFF) { //Special case for small inputs: use brute force retval = bruteForceFull( d, axis+1, visit, redStart, red0, red, redIndex, blueStart, blueEnd, blue, blueIndex) if(retval !== void 0) { return retval } } else if(axis === d-2) { if(flip) { retval = sweep.sweepBipartite( d, visit, blueStart, blueEnd, blue, blueIndex, redStart, red0, red, redIndex) } else { retval = sweep.sweepBipartite( d, visit, redStart, red0, red, redIndex, blueStart, blueEnd, blue, blueIndex) } if(retval !== void 0) { return retval } } else { iterPush(top++, axis+1, redStart, red0, blueStart, blueEnd, flip, -Infinity, Infinity) iterPush(top++, axis+1, blueStart, blueEnd, redStart, red0, flip^1, -Infinity, Infinity) } } //Divide and conquer phase if(red0 < redEnd) { //Cut blue into 3 parts: // // Points < mid point // Points = mid point // Points > mid point // var blue0 = findMedian( d, axis, blueStart, blueEnd, blue, blueIndex) var mid = blue[elemSize * blue0 + axis] var blue1 = partitionStartEqual( d, axis, blue0, blueEnd, blue, blueIndex, mid) //Right case if(blue1 < blueEnd) { iterPush(top++, axis, red0, redEnd, blue1, blueEnd, (flip|4) + (full ? 16 : 0), mid, hi) } //Left case if(blueStart < blue0) { iterPush(top++, axis, red0, redEnd, blueStart, blue0, (flip|2) + (full ? 16 : 0), lo, mid) } //Center case (the hard part) if(blue0 + 1 === blue1) { //Optimization: Range with exactly 1 point, use a brute force scan if(full) { retval = onePointFull( d, axis, visit, red0, redEnd, red, redIndex, blue0, blue, blueIndex[blue0]) } else { retval = onePointPartial( d, axis, visit, flip, red0, redEnd, red, redIndex, blue0, blue, blueIndex[blue0]) } if(retval !== void 0) { return retval } } else if(blue0 < blue1) { var red1 if(full) { //If full intersection, need to handle special case red1 = partitionContainsPoint( d, axis, red0, redEnd, red, redIndex, mid) if(red0 < red1) { var redX = partitionStartEqual( d, axis, red0, red1, red, redIndex, mid) if(axis === d-2) { //Degenerate sweep intersection: // [red0, redX] with [blue0, blue1] if(red0 < redX) { retval = sweep.sweepComplete( d, visit, red0, redX, red, redIndex, blue0, blue1, blue, blueIndex) if(retval !== void 0) { return retval } } //Normal sweep intersection: // [redX, red1] with [blue0, blue1] if(redX < red1) { retval = sweep.sweepBipartite( d, visit, redX, red1, red, redIndex, blue0, blue1, blue, blueIndex) if(retval !== void 0) { return retval } } } else { if(red0 < redX) { iterPush(top++, axis+1, red0, redX, blue0, blue1, 16, -Infinity, Infinity) } if(redX < red1) { iterPush(top++, axis+1, redX, red1, blue0, blue1, 0, -Infinity, Infinity) iterPush(top++, axis+1, blue0, blue1, redX, red1, 1, -Infinity, Infinity) } } } } else { if(flip) { red1 = partitionContainsPointProper( d, axis, red0, redEnd, red, redIndex, mid) } else { red1 = partitionContainsPoint( d, axis, red0, redEnd, red, redIndex, mid) } if(red0 < red1) { if(axis === d-2) { if(flip) { retval = sweep.sweepBipartite( d, visit, blue0, blue1, blue, blueIndex, red0, red1, red, redIndex) } else { retval = sweep.sweepBipartite( d, visit, red0, red1, red, redIndex, blue0, blue1, blue, blueIndex) } } else { iterPush(top++, axis+1, red0, red1, blue0, blue1, flip, -Infinity, Infinity) iterPush(top++, axis+1, blue0, blue1, red0, red1, flip^1, -Infinity, Infinity) } } } } } } } },{"./brute":264,"./median":266,"./partition":267,"./sweep":269,"bit-twiddle":49,"typedarray-pool":233}],266:[function(require,module,exports){ 'use strict' module.exports = findMedian var genPartition = require('./partition') var partitionStartLessThan = genPartition('lostart && boxes[ptr+axis] > x; --j, ptr-=elemSize) { //Swap var aPtr = ptr var bPtr = ptr+elemSize for(var k=0; k>> 1) var elemSize = 2*d var pivot = mid var value = boxes[elemSize*mid+axis] while(lo < hi) { if(hi - lo < PARTITION_THRESHOLD) { insertionSort(d, axis, lo, hi, boxes, ids) value = boxes[elemSize*mid+axis] break } //Select pivot using median-of-3 var count = hi - lo var pivot0 = (Math.random()*count+lo)|0 var value0 = boxes[elemSize*pivot0 + axis] var pivot1 = (Math.random()*count+lo)|0 var value1 = boxes[elemSize*pivot1 + axis] var pivot2 = (Math.random()*count+lo)|0 var value2 = boxes[elemSize*pivot2 + axis] if(value0 <= value1) { if(value2 >= value1) { pivot = pivot1 value = value1 } else if(value0 >= value2) { pivot = pivot0 value = value0 } else { pivot = pivot2 value = value2 } } else { if(value1 >= value2) { pivot = pivot1 value = value1 } else if(value2 >= value0) { pivot = pivot0 value = value0 } else { pivot = pivot2 value = value2 } } //Swap pivot to end of array var aPtr = elemSize * (hi-1) var bPtr = elemSize * pivot for(var i=0; i= 0) { reads.push('lo=e[k+n]') } if(predicate.indexOf('hi') >= 0) { reads.push('hi=e[k+o]') } fargs.push( code.replace('_', reads.join()) .replace('$', predicate)) return Function.apply(void 0, fargs) } },{}],268:[function(require,module,exports){ 'use strict'; //This code is extracted from ndarray-sort //It is inlined here as a temporary workaround module.exports = wrapper; var INSERT_SORT_CUTOFF = 32 function wrapper(data, n0) { if (n0 <= 4*INSERT_SORT_CUTOFF) { insertionSort(0, n0 - 1, data); } else { quickSort(0, n0 - 1, data); } } function insertionSort(left, right, data) { var ptr = 2*(left+1) for(var i=left+1; i<=right; ++i) { var a = data[ptr++] var b = data[ptr++] var j = i var jptr = ptr-2 while(j-- > left) { var x = data[jptr-2] var y = data[jptr-1] if(x < a) { break } else if(x === a && y < b) { break } data[jptr] = x data[jptr+1] = y jptr -= 2 } data[jptr] = a data[jptr+1] = b } } function swap(i, j, data) { i *= 2 j *= 2 var x = data[i] var y = data[i+1] data[i] = data[j] data[i+1] = data[j+1] data[j] = x data[j+1] = y } function move(i, j, data) { i *= 2 j *= 2 data[i] = data[j] data[i+1] = data[j+1] } function rotate(i, j, k, data) { i *= 2 j *= 2 k *= 2 var x = data[i] var y = data[i+1] data[i] = data[j] data[i+1] = data[j+1] data[j] = data[k] data[j+1] = data[k+1] data[k] = x data[k+1] = y } function shufflePivot(i, j, px, py, data) { i *= 2 j *= 2 data[i] = data[j] data[j] = px data[i+1] = data[j+1] data[j+1] = py } function compare(i, j, data) { i *= 2 j *= 2 var x = data[i], y = data[j] if(x < y) { return false } else if(x === y) { return data[i+1] > data[j+1] } return true } function comparePivot(i, y, b, data) { i *= 2 var x = data[i] if(x < y) { return true } else if(x === y) { return data[i+1] < b } return false } function quickSort(left, right, data) { var sixth = (right - left + 1) / 6 | 0, index1 = left + sixth, index5 = right - sixth, index3 = left + right >> 1, index2 = index3 - sixth, index4 = index3 + sixth, el1 = index1, el2 = index2, el3 = index3, el4 = index4, el5 = index5, less = left + 1, great = right - 1, tmp = 0 if(compare(el1, el2, data)) { tmp = el1 el1 = el2 el2 = tmp } if(compare(el4, el5, data)) { tmp = el4 el4 = el5 el5 = tmp } if(compare(el1, el3, data)) { tmp = el1 el1 = el3 el3 = tmp } if(compare(el2, el3, data)) { tmp = el2 el2 = el3 el3 = tmp } if(compare(el1, el4, data)) { tmp = el1 el1 = el4 el4 = tmp } if(compare(el3, el4, data)) { tmp = el3 el3 = el4 el4 = tmp } if(compare(el2, el5, data)) { tmp = el2 el2 = el5 el5 = tmp } if(compare(el2, el3, data)) { tmp = el2 el2 = el3 el3 = tmp } if(compare(el4, el5, data)) { tmp = el4 el4 = el5 el5 = tmp } var pivot1X = data[2*el2] var pivot1Y = data[2*el2+1] var pivot2X = data[2*el4] var pivot2Y = data[2*el4+1] var ptr0 = 2 * el1; var ptr2 = 2 * el3; var ptr4 = 2 * el5; var ptr5 = 2 * index1; var ptr6 = 2 * index3; var ptr7 = 2 * index5; for (var i1 = 0; i1 < 2; ++i1) { var x = data[ptr0+i1]; var y = data[ptr2+i1]; var z = data[ptr4+i1]; data[ptr5+i1] = x; data[ptr6+i1] = y; data[ptr7+i1] = z; } move(index2, left, data) move(index4, right, data) for (var k = less; k <= great; ++k) { if (comparePivot(k, pivot1X, pivot1Y, data)) { if (k !== less) { swap(k, less, data) } ++less; } else { if (!comparePivot(k, pivot2X, pivot2Y, data)) { while (true) { if (!comparePivot(great, pivot2X, pivot2Y, data)) { if (--great < k) { break; } continue; } else { if (comparePivot(great, pivot1X, pivot1Y, data)) { rotate(k, less, great, data) ++less; --great; } else { swap(k, great, data) --great; } break; } } } } } shufflePivot(left, less-1, pivot1X, pivot1Y, data) shufflePivot(right, great+1, pivot2X, pivot2Y, data) if (less - 2 - left <= INSERT_SORT_CUTOFF) { insertionSort(left, less - 2, data); } else { quickSort(left, less - 2, data); } if (right - (great + 2) <= INSERT_SORT_CUTOFF) { insertionSort(great + 2, right, data); } else { quickSort(great + 2, right, data); } if (great - less <= INSERT_SORT_CUTOFF) { insertionSort(less, great, data); } else { quickSort(less, great, data); } } },{}],269:[function(require,module,exports){ 'use strict' module.exports = { init: sqInit, sweepBipartite: sweepBipartite, sweepComplete: sweepComplete, scanBipartite: scanBipartite, scanComplete: scanComplete } var pool = require('typedarray-pool') var bits = require('bit-twiddle') var isort = require('./sort') //Flag for blue var BLUE_FLAG = (1<<28) //1D sweep event queue stuff (use pool to save space) var INIT_CAPACITY = 1024 var RED_SWEEP_QUEUE = pool.mallocInt32(INIT_CAPACITY) var RED_SWEEP_INDEX = pool.mallocInt32(INIT_CAPACITY) var BLUE_SWEEP_QUEUE = pool.mallocInt32(INIT_CAPACITY) var BLUE_SWEEP_INDEX = pool.mallocInt32(INIT_CAPACITY) var COMMON_SWEEP_QUEUE = pool.mallocInt32(INIT_CAPACITY) var COMMON_SWEEP_INDEX = pool.mallocInt32(INIT_CAPACITY) var SWEEP_EVENTS = pool.mallocDouble(INIT_CAPACITY * 8) //Reserves memory for the 1D sweep data structures function sqInit(count) { var rcount = bits.nextPow2(count) if(RED_SWEEP_QUEUE.length < rcount) { pool.free(RED_SWEEP_QUEUE) RED_SWEEP_QUEUE = pool.mallocInt32(rcount) } if(RED_SWEEP_INDEX.length < rcount) { pool.free(RED_SWEEP_INDEX) RED_SWEEP_INDEX = pool.mallocInt32(rcount) } if(BLUE_SWEEP_QUEUE.length < rcount) { pool.free(BLUE_SWEEP_QUEUE) BLUE_SWEEP_QUEUE = pool.mallocInt32(rcount) } if(BLUE_SWEEP_INDEX.length < rcount) { pool.free(BLUE_SWEEP_INDEX) BLUE_SWEEP_INDEX = pool.mallocInt32(rcount) } if(COMMON_SWEEP_QUEUE.length < rcount) { pool.free(COMMON_SWEEP_QUEUE) COMMON_SWEEP_QUEUE = pool.mallocInt32(rcount) } if(COMMON_SWEEP_INDEX.length < rcount) { pool.free(COMMON_SWEEP_INDEX) COMMON_SWEEP_INDEX = pool.mallocInt32(rcount) } var eventLength = 8 * rcount if(SWEEP_EVENTS.length < eventLength) { pool.free(SWEEP_EVENTS) SWEEP_EVENTS = pool.mallocDouble(eventLength) } } //Remove an item from the active queue in O(1) function sqPop(queue, index, count, item) { var idx = index[item] var top = queue[count-1] queue[idx] = top index[top] = idx } //Insert an item into the active queue in O(1) function sqPush(queue, index, count, item) { queue[count] = item index[item] = count } //Recursion base case: use 1D sweep algorithm function sweepBipartite( d, visit, redStart, redEnd, red, redIndex, blueStart, blueEnd, blue, blueIndex) { //store events as pairs [coordinate, idx] // // red create: -(idx+1) // red destroy: idx // blue create: -(idx+BLUE_FLAG) // blue destroy: idx+BLUE_FLAG // var ptr = 0 var elemSize = 2*d var istart = d-1 var iend = elemSize-1 for(var i=redStart; iright var n = ptr >>> 1 isort(SWEEP_EVENTS, n) var redActive = 0 var blueActive = 0 for(var i=0; i= BLUE_FLAG) { //blue destroy event e = (e-BLUE_FLAG)|0 sqPop(BLUE_SWEEP_QUEUE, BLUE_SWEEP_INDEX, blueActive--, e) } else if(e >= 0) { //red destroy event sqPop(RED_SWEEP_QUEUE, RED_SWEEP_INDEX, redActive--, e) } else if(e <= -BLUE_FLAG) { //blue create event e = (-e-BLUE_FLAG)|0 for(var j=0; jright var n = ptr >>> 1 isort(SWEEP_EVENTS, n) var redActive = 0 var blueActive = 0 var commonActive = 0 for(var i=0; i>1) === (SWEEP_EVENTS[2*i+3]>>1)) { color = 2 i += 1 } if(e < 0) { //Create event var id = -(e>>1) - 1 //Intersect with common for(var j=0; j>1) - 1 if(color === 0) { //Red sqPop(RED_SWEEP_QUEUE, RED_SWEEP_INDEX, redActive--, id) } else if(color === 1) { //Blue sqPop(BLUE_SWEEP_QUEUE, BLUE_SWEEP_INDEX, blueActive--, id) } else if(color === 2) { //Both sqPop(COMMON_SWEEP_QUEUE, COMMON_SWEEP_INDEX, commonActive--, id) } } } } //Sweep and prune/scanline algorithm: // Scan along axis, detect intersections // Brute force all boxes along axis function scanBipartite( d, axis, visit, flip, redStart, redEnd, red, redIndex, blueStart, blueEnd, blue, blueIndex) { var ptr = 0 var elemSize = 2*d var istart = axis var iend = axis+d var redShift = 1 var blueShift = 1 if(flip) { blueShift = BLUE_FLAG } else { redShift = BLUE_FLAG } for(var i=redStart; iright var n = ptr >>> 1 isort(SWEEP_EVENTS, n) var redActive = 0 for(var i=0; i= BLUE_FLAG) { isRed = !flip idx -= BLUE_FLAG } else { isRed = !!flip idx -= 1 } if(isRed) { sqPush(RED_SWEEP_QUEUE, RED_SWEEP_INDEX, redActive++, idx) } else { var blueId = blueIndex[idx] var bluePtr = elemSize * idx var b0 = blue[bluePtr+axis+1] var b1 = blue[bluePtr+axis+1+d] red_loop: for(var j=0; jright var n = ptr >>> 1 isort(SWEEP_EVENTS, n) var redActive = 0 for(var i=0; i= BLUE_FLAG) { RED_SWEEP_QUEUE[redActive++] = idx - BLUE_FLAG } else { idx -= 1 var blueId = blueIndex[idx] var bluePtr = elemSize * idx var b0 = blue[bluePtr+axis+1] var b1 = blue[bluePtr+axis+1+d] red_loop: for(var j=0; j=0; --j) { if(RED_SWEEP_QUEUE[j] === idx) { for(var k=j+1; k>> 31 } module.exports.exponent = function(n) { var b = module.exports.hi(n) return ((b<<1) >>> 21) - 1023 } module.exports.fraction = function(n) { var lo = module.exports.lo(n) var hi = module.exports.hi(n) var b = hi & ((1<<20) - 1) if(hi & 0x7ff00000) { b += (1<<20) } return [lo, b] } module.exports.denormalized = function(n) { var hi = module.exports.hi(n) return !(hi & 0x7ff00000) } }).call(this,require("buffer").Buffer) },{"buffer":50}],271:[function(require,module,exports){ "use strict" var doubleBits = require("double-bits") var SMALLEST_DENORM = Math.pow(2, -1074) var UINT_MAX = (-1)>>>0 module.exports = nextafter function nextafter(x, y) { if(isNaN(x) || isNaN(y)) { return NaN } if(x === y) { return x } if(x === 0) { if(y < 0) { return -SMALLEST_DENORM } else { return SMALLEST_DENORM } } var hi = doubleBits.hi(x) var lo = doubleBits.lo(x) if((y > x) === (x > 0)) { if(lo === UINT_MAX) { hi += 1 lo = 0 } else { lo += 1 } } else { if(lo === 0) { lo = UINT_MAX hi -= 1 } else { lo -= 1 } } return doubleBits.pack(lo, hi) } },{"double-bits":270}],272:[function(require,module,exports){ 'use strict' var bnadd = require('big-rat/add') module.exports = add function add(a, b) { var n = a.length var r = new Array(n) for(var i=0; i 0 && y0 > 0) || (x0 < 0 && y0 < 0)) { return false } var x1 = orient(b0, a0, a1) var y1 = orient(b1, a0, a1) if((x1 > 0 && y1 > 0) || (x1 < 0 && y1 < 0)) { return false } //Check for degenerate collinear case if(x0 === 0 && y0 === 0 && x1 === 0 && y1 === 0) { return checkCollinear(a0, a1, b0, b1) } return true } },{"robust-orientation":214}],277:[function(require,module,exports){ arguments[4][193][0].apply(exports,arguments) },{"dup":193}],278:[function(require,module,exports){ 'use strict' module.exports = trimLeaves var e2a = require('edges-to-adjacency-list') function trimLeaves(edges, positions) { var adj = e2a(edges, positions.length) var live = new Array(positions.length) var nbhd = new Array(positions.length) var dead = [] for(var i=0; i 0) { var v = dead.pop() live[v] = false var n = adj[v] for(var i=0; i 0) { nextCell = adj[i][b][0] nextDir = i break } } nextVertex = nextCell[nextDir^1] for(var dir=0; dir<2; ++dir) { var nbhd = adj[dir][b] for(var k=0; k 0) { nextCell = e nextVertex = p nextDir = dir } } } if(noCut) { return nextVertex } if(nextCell) { cut(nextCell, nextDir) } return nextVertex } function extractCycle(v, dir) { var e0 = adj[dir][v][0] var cycle = [v] cut(e0, dir) var u = e0[dir^1] var d0 = dir while(true) { while(u !== v) { cycle.push(u) u = next(cycle[cycle.length-2], u, false) } if(adj[0][v].length + adj[1][v].length === 0) { break } var a = cycle[cycle.length-1] var b = v var c = cycle[1] var d = next(a, b, true) if(compareAngle(positions[a], positions[b], positions[c], positions[d]) < 0) { break } cycle.push(v) u = next(a, b) } return cycle } function shouldGlue(pcycle, ncycle) { return (ncycle[1] === ncycle[ncycle.length-1]) } for(var i=0; i 0) { var ni = adj[0][i].length var ncycle = extractCycle(i,j) if(shouldGlue(pcycle, ncycle)) { //Glue together trivial cycles pcycle.push.apply(pcycle, ncycle) } else { if(pcycle.length > 0) { cycles.push(pcycle) } pcycle = ncycle } } if(pcycle.length > 0) { cycles.push(pcycle) } } } //Combine paths and loops together return cycles } },{"compare-angle":281}],281:[function(require,module,exports){ "use strict" module.exports = compareAngle var orient = require("robust-orientation") var sgn = require("signum") var twoSum = require("two-sum") var robustProduct = require("robust-product") var robustSum = require("robust-sum") function testInterior(a, b, c) { var x0 = twoSum(a[0], -b[0]) var y0 = twoSum(a[1], -b[1]) var x1 = twoSum(c[0], -b[0]) var y1 = twoSum(c[1], -b[1]) var d = robustSum( robustProduct(x0, x1), robustProduct(y0, y1)) return d[d.length-1] >= 0 } function compareAngle(a, b, c, d) { var bcd = orient(b, c, d) if(bcd === 0) { //Handle degenerate cases var sabc = sgn(orient(a, b, c)) var sabd = sgn(orient(a, b, d)) if(sabc === sabd) { if(sabc === 0) { var ic = testInterior(a, b, c) var id = testInterior(a, b, d) if(ic === id) { return 0 } else if(ic) { return 1 } else { return -1 } } return 0 } else if(sabd === 0) { if(sabc > 0) { return -1 } else if(testInterior(a, b, d)) { return -1 } else { return 1 } } else if(sabc === 0) { if(sabd > 0) { return 1 } else if(testInterior(a, b, c)) { return 1 } else { return -1 } } return sgn(sabd - sabc) } var abc = orient(a, b, c) if(abc > 0) { if(bcd > 0 && orient(a, b, d) > 0) { return 1 } return -1 } else if(abc < 0) { if(bcd > 0 || orient(a, b, d) > 0) { return 1 } return -1 } else { var abd = orient(a, b, d) if(abd > 0) { return 1 } else { if(testInterior(a, b, c)) { return 1 } else { return -1 } } } } },{"robust-orientation":214,"robust-product":282,"robust-sum":217,"signum":283,"two-sum":232}],282:[function(require,module,exports){ "use strict" var robustSum = require("robust-sum") var robustScale = require("robust-scale") module.exports = robustProduct function robustProduct(a, b) { if(a.length === 1) { return robustScale(b, a[0]) } if(b.length === 1) { return robustScale(a, b[0]) } if(a.length === 0 || b.length === 0) { return [0] } var r = [0] if(a.length < b.length) { for(var i=0; i 0) { return 1 } return 0.0 } },{}],284:[function(require,module,exports){ arguments[4][20][0].apply(exports,arguments) },{"dup":20}],285:[function(require,module,exports){ "use strict" var bounds = require("binary-search-bounds") var NOT_FOUND = 0 var SUCCESS = 1 var EMPTY = 2 module.exports = createWrapper function IntervalTreeNode(mid, left, right, leftPoints, rightPoints) { this.mid = mid this.left = left this.right = right this.leftPoints = leftPoints this.rightPoints = rightPoints this.count = (left ? left.count : 0) + (right ? right.count : 0) + leftPoints.length } var proto = IntervalTreeNode.prototype function copy(a, b) { a.mid = b.mid a.left = b.left a.right = b.right a.leftPoints = b.leftPoints a.rightPoints = b.rightPoints a.count = b.count } function rebuild(node, intervals) { var ntree = createIntervalTree(intervals) node.mid = ntree.mid node.left = ntree.left node.right = ntree.right node.leftPoints = ntree.leftPoints node.rightPoints = ntree.rightPoints node.count = ntree.count } function rebuildWithInterval(node, interval) { var intervals = node.intervals([]) intervals.push(interval) rebuild(node, intervals) } function rebuildWithoutInterval(node, interval) { var intervals = node.intervals([]) var idx = intervals.indexOf(interval) if(idx < 0) { return NOT_FOUND } intervals.splice(idx, 1) rebuild(node, intervals) return SUCCESS } proto.intervals = function(result) { result.push.apply(result, this.leftPoints) if(this.left) { this.left.intervals(result) } if(this.right) { this.right.intervals(result) } return result } proto.insert = function(interval) { var weight = this.count - this.leftPoints.length this.count += 1 if(interval[1] < this.mid) { if(this.left) { if(4*(this.left.count+1) > 3*(weight+1)) { rebuildWithInterval(this, interval) } else { this.left.insert(interval) } } else { this.left = createIntervalTree([interval]) } } else if(interval[0] > this.mid) { if(this.right) { if(4*(this.right.count+1) > 3*(weight+1)) { rebuildWithInterval(this, interval) } else { this.right.insert(interval) } } else { this.right = createIntervalTree([interval]) } } else { var l = bounds.ge(this.leftPoints, interval, compareBegin) var r = bounds.ge(this.rightPoints, interval, compareEnd) this.leftPoints.splice(l, 0, interval) this.rightPoints.splice(r, 0, interval) } } proto.remove = function(interval) { var weight = this.count - this.leftPoints if(interval[1] < this.mid) { if(!this.left) { return NOT_FOUND } var rw = this.right ? this.right.count : 0 if(4 * rw > 3 * (weight-1)) { return rebuildWithoutInterval(this, interval) } var r = this.left.remove(interval) if(r === EMPTY) { this.left = null this.count -= 1 return SUCCESS } else if(r === SUCCESS) { this.count -= 1 } return r } else if(interval[0] > this.mid) { if(!this.right) { return NOT_FOUND } var lw = this.left ? this.left.count : 0 if(4 * lw > 3 * (weight-1)) { return rebuildWithoutInterval(this, interval) } var r = this.right.remove(interval) if(r === EMPTY) { this.right = null this.count -= 1 return SUCCESS } else if(r === SUCCESS) { this.count -= 1 } return r } else { if(this.count === 1) { if(this.leftPoints[0] === interval) { return EMPTY } else { return NOT_FOUND } } if(this.leftPoints.length === 1 && this.leftPoints[0] === interval) { if(this.left && this.right) { var p = this var n = this.left while(n.right) { p = n n = n.right } if(p === this) { n.right = this.right } else { var l = this.left var r = this.right p.count -= n.count p.right = n.left n.left = l n.right = r } copy(this, n) this.count = (this.left?this.left.count:0) + (this.right?this.right.count:0) + this.leftPoints.length } else if(this.left) { copy(this, this.left) } else { copy(this, this.right) } return SUCCESS } for(var l = bounds.ge(this.leftPoints, interval, compareBegin); l=0 && arr[i][1] >= lo; --i) { var r = cb(arr[i]) if(r) { return r } } } function reportRange(arr, cb) { for(var i=0; i this.mid) { if(this.right) { var r = this.right.queryPoint(x, cb) if(r) { return r } } return reportRightRange(this.rightPoints, x, cb) } else { return reportRange(this.leftPoints, cb) } } proto.queryInterval = function(lo, hi, cb) { if(lo < this.mid && this.left) { var r = this.left.queryInterval(lo, hi, cb) if(r) { return r } } if(hi > this.mid && this.right) { var r = this.right.queryInterval(lo, hi, cb) if(r) { return r } } if(hi < this.mid) { return reportLeftRange(this.leftPoints, hi, cb) } else if(lo > this.mid) { return reportRightRange(this.rightPoints, lo, cb) } else { return reportRange(this.leftPoints, cb) } } function compareNumbers(a, b) { return a - b } function compareBegin(a, b) { var d = a[0] - b[0] if(d) { return d } return a[1] - b[1] } function compareEnd(a, b) { var d = a[1] - b[1] if(d) { return d } return a[0] - b[0] } function createIntervalTree(intervals) { if(intervals.length === 0) { return null } var pts = [] for(var i=0; i>1] var leftIntervals = [] var rightIntervals = [] var centerIntervals = [] for(var i=0; i b[1][0]) { bl = b[1] br = b[0] } else { var alo = Math.min(a[0][1], a[1][1]) var ahi = Math.max(a[0][1], a[1][1]) var blo = Math.min(b[0][1], b[1][1]) var bhi = Math.max(b[0][1], b[1][1]) if(ahi < blo) { return ahi - blo } if(alo > bhi) { return alo - bhi } return ahi - bhi } var al, ar if(a[0][1] < a[1][1]) { al = a[0] ar = a[1] } else { al = a[1] ar = a[0] } var d = orient(br, bl, al) if(d) { return d } d = orient(br, bl, ar) if(d) { return d } return ar - br } function orderSegments(b, a) { var al, ar if(a[0][0] < a[1][0]) { al = a[0] ar = a[1] } else if(a[0][0] > a[1][0]) { al = a[1] ar = a[0] } else { return horizontalOrder(a, b) } var bl, br if(b[0][0] < b[1][0]) { bl = b[0] br = b[1] } else if(b[0][0] > b[1][0]) { bl = b[1] br = b[0] } else { return -horizontalOrder(b, a) } var d1 = orient(al, ar, br) var d2 = orient(al, ar, bl) if(d1 < 0) { if(d2 <= 0) { return d1 } } else if(d1 > 0) { if(d2 >= 0) { return d1 } } else if(d2) { return d2 } d1 = orient(br, bl, ar) d2 = orient(br, bl, al) if(d1 < 0) { if(d2 <= 0) { return d1 } } else if(d1 > 0) { if(d2 >= 0) { return d1 } } else if(d2) { return d2 } return ar[0] - br[0] } },{"robust-orientation":214}],287:[function(require,module,exports){ "use strict" module.exports = createRBTree var RED = 0 var BLACK = 1 function RBNode(color, key, value, left, right, count) { this._color = color this.key = key this.value = value this.left = left this.right = right this._count = count } function cloneNode(node) { return new RBNode(node._color, node.key, node.value, node.left, node.right, node._count) } function repaint(color, node) { return new RBNode(color, node.key, node.value, node.left, node.right, node._count) } function recount(node) { node._count = 1 + (node.left ? node.left._count : 0) + (node.right ? node.right._count : 0) } function RedBlackTree(compare, root) { this._compare = compare this.root = root } var proto = RedBlackTree.prototype Object.defineProperty(proto, "keys", { get: function() { var result = [] this.forEach(function(k,v) { result.push(k) }) return result } }) Object.defineProperty(proto, "values", { get: function() { var result = [] this.forEach(function(k,v) { result.push(v) }) return result } }) //Returns the number of nodes in the tree Object.defineProperty(proto, "length", { get: function() { if(this.root) { return this.root._count } return 0 } }) //Insert a new item into the tree proto.insert = function(key, value) { var cmp = this._compare //Find point to insert new node at var n = this.root var n_stack = [] var d_stack = [] while(n) { var d = cmp(key, n.key) n_stack.push(n) d_stack.push(d) if(d <= 0) { n = n.left } else { n = n.right } } //Rebuild path to leaf node n_stack.push(new RBNode(RED, key, value, null, null, 1)) for(var s=n_stack.length-2; s>=0; --s) { var n = n_stack[s] if(d_stack[s] <= 0) { n_stack[s] = new RBNode(n._color, n.key, n.value, n_stack[s+1], n.right, n._count+1) } else { n_stack[s] = new RBNode(n._color, n.key, n.value, n.left, n_stack[s+1], n._count+1) } } //Rebalance tree using rotations //console.log("start insert", key, d_stack) for(var s=n_stack.length-1; s>1; --s) { var p = n_stack[s-1] var n = n_stack[s] if(p._color === BLACK || n._color === BLACK) { break } var pp = n_stack[s-2] if(pp.left === p) { if(p.left === n) { var y = pp.right if(y && y._color === RED) { //console.log("LLr") p._color = BLACK pp.right = repaint(BLACK, y) pp._color = RED s -= 1 } else { //console.log("LLb") pp._color = RED pp.left = p.right p._color = BLACK p.right = pp n_stack[s-2] = p n_stack[s-1] = n recount(pp) recount(p) if(s >= 3) { var ppp = n_stack[s-3] if(ppp.left === pp) { ppp.left = p } else { ppp.right = p } } break } } else { var y = pp.right if(y && y._color === RED) { //console.log("LRr") p._color = BLACK pp.right = repaint(BLACK, y) pp._color = RED s -= 1 } else { //console.log("LRb") p.right = n.left pp._color = RED pp.left = n.right n._color = BLACK n.left = p n.right = pp n_stack[s-2] = n n_stack[s-1] = p recount(pp) recount(p) recount(n) if(s >= 3) { var ppp = n_stack[s-3] if(ppp.left === pp) { ppp.left = n } else { ppp.right = n } } break } } } else { if(p.right === n) { var y = pp.left if(y && y._color === RED) { //console.log("RRr", y.key) p._color = BLACK pp.left = repaint(BLACK, y) pp._color = RED s -= 1 } else { //console.log("RRb") pp._color = RED pp.right = p.left p._color = BLACK p.left = pp n_stack[s-2] = p n_stack[s-1] = n recount(pp) recount(p) if(s >= 3) { var ppp = n_stack[s-3] if(ppp.right === pp) { ppp.right = p } else { ppp.left = p } } break } } else { var y = pp.left if(y && y._color === RED) { //console.log("RLr") p._color = BLACK pp.left = repaint(BLACK, y) pp._color = RED s -= 1 } else { //console.log("RLb") p.left = n.right pp._color = RED pp.right = n.left n._color = BLACK n.right = p n.left = pp n_stack[s-2] = n n_stack[s-1] = p recount(pp) recount(p) recount(n) if(s >= 3) { var ppp = n_stack[s-3] if(ppp.right === pp) { ppp.right = n } else { ppp.left = n } } break } } } } //Return new tree n_stack[0]._color = BLACK return new RedBlackTree(cmp, n_stack[0]) } //Visit all nodes inorder function doVisitFull(visit, node) { if(node.left) { var v = doVisitFull(visit, node.left) if(v) { return v } } var v = visit(node.key, node.value) if(v) { return v } if(node.right) { return doVisitFull(visit, node.right) } } //Visit half nodes in order function doVisitHalf(lo, compare, visit, node) { var l = compare(lo, node.key) if(l <= 0) { if(node.left) { var v = doVisitHalf(lo, compare, visit, node.left) if(v) { return v } } var v = visit(node.key, node.value) if(v) { return v } } if(node.right) { return doVisitHalf(lo, compare, visit, node.right) } } //Visit all nodes within a range function doVisit(lo, hi, compare, visit, node) { var l = compare(lo, node.key) var h = compare(hi, node.key) var v if(l <= 0) { if(node.left) { v = doVisit(lo, hi, compare, visit, node.left) if(v) { return v } } if(h > 0) { v = visit(node.key, node.value) if(v) { return v } } } if(h > 0 && node.right) { return doVisit(lo, hi, compare, visit, node.right) } } proto.forEach = function rbTreeForEach(visit, lo, hi) { if(!this.root) { return } switch(arguments.length) { case 1: return doVisitFull(visit, this.root) break case 2: return doVisitHalf(lo, this._compare, visit, this.root) break case 3: if(this._compare(lo, hi) >= 0) { return } return doVisit(lo, hi, this._compare, visit, this.root) break } } //First item in list Object.defineProperty(proto, "begin", { get: function() { var stack = [] var n = this.root while(n) { stack.push(n) n = n.left } return new RedBlackTreeIterator(this, stack) } }) //Last item in list Object.defineProperty(proto, "end", { get: function() { var stack = [] var n = this.root while(n) { stack.push(n) n = n.right } return new RedBlackTreeIterator(this, stack) } }) //Find the ith item in the tree proto.at = function(idx) { if(idx < 0) { return new RedBlackTreeIterator(this, []) } var n = this.root var stack = [] while(true) { stack.push(n) if(n.left) { if(idx < n.left._count) { n = n.left continue } idx -= n.left._count } if(!idx) { return new RedBlackTreeIterator(this, stack) } idx -= 1 if(n.right) { if(idx >= n.right._count) { break } n = n.right } else { break } } return new RedBlackTreeIterator(this, []) } proto.ge = function(key) { var cmp = this._compare var n = this.root var stack = [] var last_ptr = 0 while(n) { var d = cmp(key, n.key) stack.push(n) if(d <= 0) { last_ptr = stack.length } if(d <= 0) { n = n.left } else { n = n.right } } stack.length = last_ptr return new RedBlackTreeIterator(this, stack) } proto.gt = function(key) { var cmp = this._compare var n = this.root var stack = [] var last_ptr = 0 while(n) { var d = cmp(key, n.key) stack.push(n) if(d < 0) { last_ptr = stack.length } if(d < 0) { n = n.left } else { n = n.right } } stack.length = last_ptr return new RedBlackTreeIterator(this, stack) } proto.lt = function(key) { var cmp = this._compare var n = this.root var stack = [] var last_ptr = 0 while(n) { var d = cmp(key, n.key) stack.push(n) if(d > 0) { last_ptr = stack.length } if(d <= 0) { n = n.left } else { n = n.right } } stack.length = last_ptr return new RedBlackTreeIterator(this, stack) } proto.le = function(key) { var cmp = this._compare var n = this.root var stack = [] var last_ptr = 0 while(n) { var d = cmp(key, n.key) stack.push(n) if(d >= 0) { last_ptr = stack.length } if(d < 0) { n = n.left } else { n = n.right } } stack.length = last_ptr return new RedBlackTreeIterator(this, stack) } //Finds the item with key if it exists proto.find = function(key) { var cmp = this._compare var n = this.root var stack = [] while(n) { var d = cmp(key, n.key) stack.push(n) if(d === 0) { return new RedBlackTreeIterator(this, stack) } if(d <= 0) { n = n.left } else { n = n.right } } return new RedBlackTreeIterator(this, []) } //Removes item with key from tree proto.remove = function(key) { var iter = this.find(key) if(iter) { return iter.remove() } return this } //Returns the item at `key` proto.get = function(key) { var cmp = this._compare var n = this.root while(n) { var d = cmp(key, n.key) if(d === 0) { return n.value } if(d <= 0) { n = n.left } else { n = n.right } } return } //Iterator for red black tree function RedBlackTreeIterator(tree, stack) { this.tree = tree this._stack = stack } var iproto = RedBlackTreeIterator.prototype //Test if iterator is valid Object.defineProperty(iproto, "valid", { get: function() { return this._stack.length > 0 } }) //Node of the iterator Object.defineProperty(iproto, "node", { get: function() { if(this._stack.length > 0) { return this._stack[this._stack.length-1] } return null }, enumerable: true }) //Makes a copy of an iterator iproto.clone = function() { return new RedBlackTreeIterator(this.tree, this._stack.slice()) } //Swaps two nodes function swapNode(n, v) { n.key = v.key n.value = v.value n.left = v.left n.right = v.right n._color = v._color n._count = v._count } //Fix up a double black node in a tree function fixDoubleBlack(stack) { var n, p, s, z for(var i=stack.length-1; i>=0; --i) { n = stack[i] if(i === 0) { n._color = BLACK return } //console.log("visit node:", n.key, i, stack[i].key, stack[i-1].key) p = stack[i-1] if(p.left === n) { //console.log("left child") s = p.right if(s.right && s.right._color === RED) { //console.log("case 1: right sibling child red") s = p.right = cloneNode(s) z = s.right = cloneNode(s.right) p.right = s.left s.left = p s.right = z s._color = p._color n._color = BLACK p._color = BLACK z._color = BLACK recount(p) recount(s) if(i > 1) { var pp = stack[i-2] if(pp.left === p) { pp.left = s } else { pp.right = s } } stack[i-1] = s return } else if(s.left && s.left._color === RED) { //console.log("case 1: left sibling child red") s = p.right = cloneNode(s) z = s.left = cloneNode(s.left) p.right = z.left s.left = z.right z.left = p z.right = s z._color = p._color p._color = BLACK s._color = BLACK n._color = BLACK recount(p) recount(s) recount(z) if(i > 1) { var pp = stack[i-2] if(pp.left === p) { pp.left = z } else { pp.right = z } } stack[i-1] = z return } if(s._color === BLACK) { if(p._color === RED) { //console.log("case 2: black sibling, red parent", p.right.value) p._color = BLACK p.right = repaint(RED, s) return } else { //console.log("case 2: black sibling, black parent", p.right.value) p.right = repaint(RED, s) continue } } else { //console.log("case 3: red sibling") s = cloneNode(s) p.right = s.left s.left = p s._color = p._color p._color = RED recount(p) recount(s) if(i > 1) { var pp = stack[i-2] if(pp.left === p) { pp.left = s } else { pp.right = s } } stack[i-1] = s stack[i] = p if(i+1 < stack.length) { stack[i+1] = n } else { stack.push(n) } i = i+2 } } else { //console.log("right child") s = p.left if(s.left && s.left._color === RED) { //console.log("case 1: left sibling child red", p.value, p._color) s = p.left = cloneNode(s) z = s.left = cloneNode(s.left) p.left = s.right s.right = p s.left = z s._color = p._color n._color = BLACK p._color = BLACK z._color = BLACK recount(p) recount(s) if(i > 1) { var pp = stack[i-2] if(pp.right === p) { pp.right = s } else { pp.left = s } } stack[i-1] = s return } else if(s.right && s.right._color === RED) { //console.log("case 1: right sibling child red") s = p.left = cloneNode(s) z = s.right = cloneNode(s.right) p.left = z.right s.right = z.left z.right = p z.left = s z._color = p._color p._color = BLACK s._color = BLACK n._color = BLACK recount(p) recount(s) recount(z) if(i > 1) { var pp = stack[i-2] if(pp.right === p) { pp.right = z } else { pp.left = z } } stack[i-1] = z return } if(s._color === BLACK) { if(p._color === RED) { //console.log("case 2: black sibling, red parent") p._color = BLACK p.left = repaint(RED, s) return } else { //console.log("case 2: black sibling, black parent") p.left = repaint(RED, s) continue } } else { //console.log("case 3: red sibling") s = cloneNode(s) p.left = s.right s.right = p s._color = p._color p._color = RED recount(p) recount(s) if(i > 1) { var pp = stack[i-2] if(pp.right === p) { pp.right = s } else { pp.left = s } } stack[i-1] = s stack[i] = p if(i+1 < stack.length) { stack[i+1] = n } else { stack.push(n) } i = i+2 } } } } //Removes item at iterator from tree iproto.remove = function() { var stack = this._stack if(stack.length === 0) { return this.tree } //First copy path to node var cstack = new Array(stack.length) var n = stack[stack.length-1] cstack[cstack.length-1] = new RBNode(n._color, n.key, n.value, n.left, n.right, n._count) for(var i=stack.length-2; i>=0; --i) { var n = stack[i] if(n.left === stack[i+1]) { cstack[i] = new RBNode(n._color, n.key, n.value, cstack[i+1], n.right, n._count) } else { cstack[i] = new RBNode(n._color, n.key, n.value, n.left, cstack[i+1], n._count) } } //Get node n = cstack[cstack.length-1] //console.log("start remove: ", n.value) //If not leaf, then swap with previous node if(n.left && n.right) { //console.log("moving to leaf") //First walk to previous leaf var split = cstack.length n = n.left while(n.right) { cstack.push(n) n = n.right } //Copy path to leaf var v = cstack[split-1] cstack.push(new RBNode(n._color, v.key, v.value, n.left, n.right, n._count)) cstack[split-1].key = n.key cstack[split-1].value = n.value //Fix up stack for(var i=cstack.length-2; i>=split; --i) { n = cstack[i] cstack[i] = new RBNode(n._color, n.key, n.value, n.left, cstack[i+1], n._count) } cstack[split-1].left = cstack[split] } //console.log("stack=", cstack.map(function(v) { return v.value })) //Remove leaf node n = cstack[cstack.length-1] if(n._color === RED) { //Easy case: removing red leaf //console.log("RED leaf") var p = cstack[cstack.length-2] if(p.left === n) { p.left = null } else if(p.right === n) { p.right = null } cstack.pop() for(var i=0; i 0) { return this._stack[this._stack.length-1].key } return }, enumerable: true }) //Returns value Object.defineProperty(iproto, "value", { get: function() { if(this._stack.length > 0) { return this._stack[this._stack.length-1].value } return }, enumerable: true }) //Returns the position of this iterator in the sorted list Object.defineProperty(iproto, "index", { get: function() { var idx = 0 var stack = this._stack if(stack.length === 0) { var r = this.tree.root if(r) { return r._count } return 0 } else if(stack[stack.length-1].left) { idx = stack[stack.length-1].left._count } for(var s=stack.length-2; s>=0; --s) { if(stack[s+1] === stack[s].right) { ++idx if(stack[s].left) { idx += stack[s].left._count } } } return idx }, enumerable: true }) //Advances iterator to next element in list iproto.next = function() { var stack = this._stack if(stack.length === 0) { return } var n = stack[stack.length-1] if(n.right) { n = n.right while(n) { stack.push(n) n = n.left } } else { stack.pop() while(stack.length > 0 && stack[stack.length-1].right === n) { n = stack[stack.length-1] stack.pop() } } } //Checks if iterator is at end of tree Object.defineProperty(iproto, "hasNext", { get: function() { var stack = this._stack if(stack.length === 0) { return false } if(stack[stack.length-1].right) { return true } for(var s=stack.length-1; s>0; --s) { if(stack[s-1].left === stack[s]) { return true } } return false } }) //Update value iproto.update = function(value) { var stack = this._stack if(stack.length === 0) { throw new Error("Can't update empty node!") } var cstack = new Array(stack.length) var n = stack[stack.length-1] cstack[cstack.length-1] = new RBNode(n._color, n.key, value, n.left, n.right, n._count) for(var i=stack.length-2; i>=0; --i) { n = stack[i] if(n.left === stack[i+1]) { cstack[i] = new RBNode(n._color, n.key, n.value, cstack[i+1], n.right, n._count) } else { cstack[i] = new RBNode(n._color, n.key, n.value, n.left, cstack[i+1], n._count) } } return new RedBlackTree(this.tree._compare, cstack[0]) } //Moves iterator backward one element iproto.prev = function() { var stack = this._stack if(stack.length === 0) { return } var n = stack[stack.length-1] if(n.left) { n = n.left while(n) { stack.push(n) n = n.right } } else { stack.pop() while(stack.length > 0 && stack[stack.length-1].left === n) { n = stack[stack.length-1] stack.pop() } } } //Checks if iterator is at start of tree Object.defineProperty(iproto, "hasPrev", { get: function() { var stack = this._stack if(stack.length === 0) { return false } if(stack[stack.length-1].left) { return true } for(var s=stack.length-1; s>0; --s) { if(stack[s-1].right === stack[s]) { return true } } return false } }) //Default comparison function function defaultCompare(a, b) { if(a < b) { return -1 } if(a > b) { return 1 } return 0 } //Build a tree function createRBTree(compare) { return new RedBlackTree(compare || defaultCompare, null) } },{}],288:[function(require,module,exports){ "use strict" module.exports = createSlabDecomposition var bounds = require("binary-search-bounds") var createRBTree = require("functional-red-black-tree") var orient = require("robust-orientation") var orderSegments = require("./lib/order-segments") function SlabDecomposition(slabs, coordinates, horizontal) { this.slabs = slabs this.coordinates = coordinates this.horizontal = horizontal } var proto = SlabDecomposition.prototype function compareHorizontal(e, y) { return e.y - y } function searchBucket(root, p) { var lastNode = null while(root) { var seg = root.key var l, r if(seg[0][0] < seg[1][0]) { l = seg[0] r = seg[1] } else { l = seg[1] r = seg[0] } var o = orient(l, r, p) if(o < 0) { root = root.left } else if(o > 0) { if(p[0] !== seg[1][0]) { lastNode = root root = root.right } else { var val = searchBucket(root.right, p) if(val) { return val } root = root.left } } else { if(p[0] !== seg[1][0]) { return root } else { var val = searchBucket(root.right, p) if(val) { return val } root = root.left } } } return lastNode } proto.castUp = function(p) { var bucket = bounds.le(this.coordinates, p[0]) if(bucket < 0) { return -1 } var root = this.slabs[bucket] var hitNode = searchBucket(this.slabs[bucket], p) var lastHit = -1 if(hitNode) { lastHit = hitNode.value } //Edge case: need to handle horizontal segments (sucks) if(this.coordinates[bucket] === p[0]) { var lastSegment = null if(hitNode) { lastSegment = hitNode.key } if(bucket > 0) { var otherHitNode = searchBucket(this.slabs[bucket-1], p) if(otherHitNode) { if(lastSegment) { if(orderSegments(otherHitNode.key, lastSegment) > 0) { lastSegment = otherHitNode.key lastHit = otherHitNode.value } } else { lastHit = otherHitNode.value lastSegment = otherHitNode.key } } } var horiz = this.horizontal[bucket] if(horiz.length > 0) { var hbucket = bounds.ge(horiz, p[1], compareHorizontal) if(hbucket < horiz.length) { var e = horiz[hbucket] if(p[1] === e.y) { if(e.closed) { return e.index } else { while(hbucket < horiz.length-1 && horiz[hbucket+1].y === p[1]) { hbucket = hbucket+1 e = horiz[hbucket] if(e.closed) { return e.index } } if(e.y === p[1] && !e.start) { hbucket = hbucket+1 if(hbucket >= horiz.length) { return lastHit } e = horiz[hbucket] } } } //Check if e is above/below last segment if(e.start) { if(lastSegment) { var o = orient(lastSegment[0], lastSegment[1], [p[0], e.y]) if(lastSegment[0][0] > lastSegment[1][0]) { o = -o } if(o > 0) { lastHit = e.index } } else { lastHit = e.index } } else if(e.y !== p[1]) { lastHit = e.index } } } } return lastHit } function IntervalSegment(y, index, start, closed) { this.y = y this.index = index this.start = start this.closed = closed } function Event(x, segment, create, index) { this.x = x this.segment = segment this.create = create this.index = index } function createSlabDecomposition(segments) { var numSegments = segments.length var numEvents = 2 * numSegments var events = new Array(numEvents) for(var i=0; i 0 && coordinates[bucket] === p[0]) { root = slabs[bucket-1] } else { return 1 } } var lastOrientation = 1 while(root) { var s = root.key var o = orient(p, s[0], s[1]) if(s[0][0] < s[1][0]) { if(o < 0) { root = root.left } else if(o > 0) { lastOrientation = -1 root = root.right } else { return 0 } } else { if(o > 0) { root = root.left } else if(o < 0) { lastOrientation = 1 root = root.right } else { return 0 } } } return lastOrientation } } function classifyEmpty(p) { return 1 } function createClassifyVertical(testVertical) { return function classify(p) { if(testVertical(p[0], p[1])) { return 0 } return 1 } } function createClassifyPointDegen(testVertical, testNormal) { return function classify(p) { if(testVertical(p[0], p[1])) { return 0 } return testNormal(p) } } function preprocessPolygon(loops) { //Compute number of loops var numLoops = loops.length //Unpack segments var segments = [] var vsegments = [] var ptr = 0 for(var i=0; i 0 } //Extract all clockwise faces faces = faces.filter(ccw) //Detect which loops are contained in one another to handle parent-of relation var numFaces = faces.length var parent = new Array(numFaces) var containment = new Array(numFaces) for(var i=0; i 0) { var top = toVisit.pop() var nbhd = fadj[top] uniq(nbhd, function(a,b) { return a-b }) var nnbhr = nbhd.length var p = parity[top] var polyline if(p === 0) { var c = faces[top] polyline = [c] } for(var i=0; i= 0) { continue } parity[f] = p^1 toVisit.push(f) if(p === 0) { var c = faces[f] if(!sharedBoundary(c)) { c.reverse() polyline.push(c) } } } if(p === 0) { result.push(polyline) } } return result } },{"./lib/trim-leaves":278,"edges-to-adjacency-list":279,"planar-dual":280,"point-in-big-polygon":289,"robust-sum":217,"two-product":231,"uniq":234}],291:[function(require,module,exports){ arguments[4][49][0].apply(exports,arguments) },{"dup":49}],292:[function(require,module,exports){ "use strict"; "use restrict"; module.exports = UnionFind; function UnionFind(count) { this.roots = new Array(count); this.ranks = new Array(count); for(var i=0; i> 1 } return (i >> 1) - 1 } //Bubble element i down the heap function heapDown(i) { var w = heapWeight(i) while(true) { var tw = w var left = 2*i + 1 var right = 2*(i + 1) var next = i if(left < heapCount) { var lw = heapWeight(left) if(lw < tw) { next = left tw = lw } } if(right < heapCount) { var rw = heapWeight(right) if(rw < tw) { next = right } } if(next === i) { return i } heapSwap(i, next) i = next } } //Bubbles element i up the heap function heapUp(i) { var w = heapWeight(i) while(i > 0) { var parent = heapParent(i) if(parent >= 0) { var pw = heapWeight(parent) if(w < pw) { heapSwap(i, parent) i = parent continue } } return i } } //Pop minimum element function heapPop() { if(heapCount > 0) { var head = heap[0] heapSwap(0, heapCount-1) heapCount -= 1 heapDown(0) return head } return -1 } //Update heap item i function heapUpdate(i, w) { var a = heap[i] if(weights[a] === w) { return i } weights[a] = -Infinity heapUp(i) heapPop() weights[a] = w heapCount += 1 return heapUp(heapCount-1) } //Kills a vertex (assume vertex already removed from heap) function kill(i) { if(dead[i]) { return } //Kill vertex dead[i] = true //Fixup topology var s = inv[i] var t = outv[i] if(inv[t] >= 0) { inv[t] = s } if(outv[s] >= 0) { outv[s] = t } //Update weights on s and t if(index[s] >= 0) { heapUpdate(index[s], computeWeight(s)) } if(index[t] >= 0) { heapUpdate(index[t], computeWeight(t)) } } //Initialize weights and heap var heap = [] var index = new Array(n) for(var i=0; i>1; i>=0; --i) { heapDown(i) } //Kill vertices while(true) { var hmin = heapPop() if((hmin < 0) || (weights[hmin] > minArea)) { break } kill(hmin) } //Build collapsed vertex table var npositions = [] for(var i=0; i= 0 && tout >= 0 && tin !== tout) { var cin = index[tin] var cout = index[tout] if(cin !== cout) { ncells.push([ cin, cout ]) } } }) //Normalize result sc.unique(sc.normalize(ncells)) //Return final list of cells return { positions: npositions, edges: ncells } } },{"robust-orientation":214,"simplicial-complex":293}],295:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /** * centerx is a center of scaling tuned for maximum scalability of * the arrowhead ie throughout mag=0.3..3 the head is joined smoothly * to the line, but the endpoint moves. * backoff is the distance to move the arrowhead, and the end of the * line, in order to end at the right place * * TODO: option to have the pointed-to point a little in front of the * end of the line, as people tend to want a bit of a gap there... */ module.exports = [ // no arrow '', // wide with flat back { path: 'M-2.4,-3V3L0.6,0Z', backoff: 0.6 }, // narrower with flat back { path: 'M-3.7,-2.5V2.5L1.3,0Z', backoff: 1.3 }, // barbed { path: 'M-4.45,-3L-1.65,-0.2V0.2L-4.45,3L1.55,0Z', backoff: 1.55 }, // wide line-drawn { path: 'M-2.2,-2.2L-0.2,-0.2V0.2L-2.2,2.2L-1.4,3L1.6,0L-1.4,-3Z', backoff: 1.6 }, // narrower line-drawn { path: 'M-4.4,-2.1L-0.6,-0.2V0.2L-4.4,2.1L-4,3L2,0L-4,-3Z', backoff: 2 }, // circle { path: 'M2,0A2,2 0 1,1 0,-2A2,2 0 0,1 2,0Z', backoff: 0 }, // square { path: 'M2,2V-2H-2V2Z', backoff: 0 } ]; },{}],296:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var ARROWPATHS = require('./arrow_paths'); var Cartesian = require('../../plots/cartesian'); var fontAttrs = require('../../plots/font_attributes'); var extendFlat = require('../../lib/extend').extendFlat; module.exports = { _isLinkedToArray: true, text: { valType: 'string', }, textangle: { valType: 'angle', dflt: 0, }, font: extendFlat({}, fontAttrs, { }), opacity: { valType: 'number', min: 0, max: 1, dflt: 1, }, align: { valType: 'enumerated', values: ['left', 'center', 'right'], dflt: 'center', }, bgcolor: { valType: 'color', dflt: 'rgba(0,0,0,0)', }, bordercolor: { valType: 'color', dflt: 'rgba(0,0,0,0)', }, borderpad: { valType: 'number', min: 0, dflt: 1, }, borderwidth: { valType: 'number', min: 0, dflt: 1, }, // arrow showarrow: { valType: 'boolean', dflt: true, }, arrowcolor: { valType: 'color', }, arrowhead: { valType: 'integer', min: 0, max: ARROWPATHS.length, dflt: 1, }, arrowsize: { valType: 'number', min: 0.3, dflt: 1, }, arrowwidth: { valType: 'number', min: 0.1, }, ax: { valType: 'number', dflt: -10, }, ay: { valType: 'number', dflt: -30, }, // positioning xref: { valType: 'enumerated', values: [ 'paper', Cartesian.idRegex.x.toString() ], }, x: { valType: 'number', }, xanchor: { valType: 'enumerated', values: ['auto', 'left', 'center', 'right'], dflt: 'auto', }, yref: { valType: 'enumerated', values: [ 'paper', Cartesian.idRegex.y.toString() ], }, y: { valType: 'number', }, yanchor: { valType: 'enumerated', values: ['auto', 'top', 'middle', 'bottom'], dflt: 'auto', }, _deprecated: { ref: { valType: 'string', } } }; },{"../../lib/extend":345,"../../plots/cartesian":375,"../../plots/font_attributes":383,"./arrow_paths":295}],297:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../../plotly'); var d3 = require('d3'); var isNumeric = require('fast-isnumeric'); var annotations = module.exports = {}; annotations.ARROWPATHS = require('./arrow_paths'); annotations.layoutAttributes = require('./attributes'); annotations.supplyLayoutDefaults = function(layoutIn, layoutOut) { var containerIn = layoutIn.annotations || [], containerOut = layoutOut.annotations = []; for(var i = 0; i < containerIn.length; i++) { containerOut.push(handleAnnotationDefaults(containerIn[i] || {}, layoutOut)); } }; function handleAnnotationDefaults(annIn, fullLayout) { var annOut = {}; function coerce(attr, dflt) { return Plotly.Lib.coerce(annIn, annOut, annotations.layoutAttributes, attr, dflt); } coerce('opacity'); coerce('align'); coerce('bgcolor'); var borderColor = coerce('bordercolor'), borderOpacity = Plotly.Color.opacity(borderColor); coerce('borderpad'); var borderWidth = coerce('borderwidth'); var showArrow = coerce('showarrow'); if(showArrow) { coerce('arrowcolor', borderOpacity ? annOut.bordercolor : Plotly.Color.defaultLine); coerce('arrowhead'); coerce('arrowsize'); coerce('arrowwidth', ((borderOpacity && borderWidth) || 1) * 2); coerce('ax'); coerce('ay'); // if you have one part of arrow length you should have both Plotly.Lib.noneOrAll(annIn, annOut, ['ax', 'ay']); } coerce('text', showArrow ? ' ' : 'new text'); coerce('textangle'); Plotly.Lib.coerceFont(coerce, 'font', fullLayout.font); // positioning var axLetters = ['x','y']; for(var i = 0; i < 2; i++) { var axLetter = axLetters[i], tdMock = {_fullLayout: fullLayout}; // xref, yref var axRef = Plotly.Axes.coerceRef(annIn, annOut, tdMock, axLetter); // x, y var defaultPosition = 0.5; if(axRef!=='paper') { var ax = Plotly.Axes.getFromId(tdMock, axRef); defaultPosition = ax.range[0] + defaultPosition * (ax.range[1] - ax.range[0]); // convert date or category strings to numbers if(['date','category'].indexOf(ax.type)!==-1 && typeof annIn[axLetter]==='string') { var newval; if(ax.type==='date') { newval = Plotly.Lib.dateTime2ms(annIn[axLetter]); if(newval!==false) annIn[axLetter] = newval; } else if((ax._categories||[]).length) { newval = ax._categories.indexOf(annIn[axLetter]); if(newval!==-1) annIn[axLetter] = newval; } } } coerce(axLetter, defaultPosition); // xanchor, yanchor if(!showArrow) coerce(axLetter + 'anchor'); } // if you have one coordinate you should have both Plotly.Lib.noneOrAll(annIn, annOut, ['x', 'y']); return annOut; } annotations.drawAll = function(gd) { var fullLayout = gd._fullLayout; fullLayout._infolayer.selectAll('.annotation').remove(); for(var i = 0; i < fullLayout.annotations.length; i++) { annotations.draw(gd, i); } return Plotly.Plots.previousPromises(gd); }; annotations.add = function(gd) { var nextAnn = gd._fullLayout.annotations.length; Plotly.relayout(gd, 'annotations['+nextAnn+']', 'add'); }; // ----------------------------------------------------- // make or edit an annotation on the graph // ----------------------------------------------------- // annotations are stored in gd.layout.annotations, an array of objects // index can point to one item in this array, // or non-numeric to simply add a new one // or -1 to modify all existing // opt can be the full options object, or one key (to be set to value) // or undefined to simply redraw // if opt is blank, val can be 'add' or a full options object to add a new // annotation at that point in the array, or 'remove' to delete this one annotations.draw = function(gd, index, opt, value) { var layout = gd.layout, fullLayout = gd._fullLayout, i; if(!isNumeric(index) || index===-1) { // no index provided - we're operating on ALL annotations if(!index && Array.isArray(value)) { // a whole annotation array is passed in // (as in, redo of delete all) layout.annotations = value; annotations.supplyLayoutDefaults(layout, fullLayout); annotations.drawAll(gd); return; } else if(value==='remove') { // delete all delete layout.annotations; fullLayout.annotations = []; annotations.drawAll(gd); return; } else if(opt && value!=='add') { // make the same change to all annotations for(i = 0; i < fullLayout.annotations.length; i++) { annotations.draw(gd, i, opt, value); } return; } else { // add a new empty annotation index = fullLayout.annotations.length; fullLayout.annotations.push({}); } } if(!opt && value) { if(value==='remove') { fullLayout._infolayer.selectAll('.annotation[data-index="'+index+'"]') .remove(); fullLayout.annotations.splice(index,1); layout.annotations.splice(index,1); for(i=index; iindex; i--) { fullLayout._infolayer .selectAll('.annotation[data-index="'+(i-1)+'"]') .attr('data-index',String(i)); annotations.draw(gd,i); } } } // remove the existing annotation if there is one fullLayout._infolayer.selectAll('.annotation[data-index="'+index+'"]').remove(); // remember a few things about what was already there, var optionsIn = layout.annotations[index], oldPrivate = fullLayout.annotations[index]; // not sure how we're getting here... but C12 is seeing a bug // where we fail here when they add/remove annotations if(!optionsIn) return; var oldRef = {xref: optionsIn.xref, yref: optionsIn.yref}; // alter the input annotation as requested var optionsEdit = {}; if(typeof opt === 'string' && opt) optionsEdit[opt] = value; else if(Plotly.Lib.isPlainObject(opt)) optionsEdit = opt; var optionKeys = Object.keys(optionsEdit); for(i = 0; i < optionKeys.length; i++) { var k = optionKeys[i]; Plotly.Lib.nestedProperty(optionsIn, k).set(optionsEdit[k]); } var gs = fullLayout._size; var axLetters = ['x', 'y']; for(i = 0; i < 2; i++) { var axLetter = axLetters[i]; // if we don't have an explicit position already, // don't set one just because we're changing references // or axis type. // the defaults will be consistent most of the time anyway, // except in log/linear changes if(optionsEdit[axLetter]!==undefined || optionsIn[axLetter]===undefined) { continue; } var axOld = Plotly.Axes.getFromId(gd, Plotly.Axes.coerceRef(oldRef, {}, gd, axLetter)), axNew = Plotly.Axes.getFromId(gd, Plotly.Axes.coerceRef(optionsIn, {}, gd, axLetter)), position = optionsIn[axLetter], axTypeOld = oldPrivate['_' + axLetter + 'type']; if(optionsEdit[axLetter + 'ref']!==undefined) { var autoAnchor = optionsIn[axLetter + 'anchor'] === 'auto', plotSize = (axLetter === 'x' ? gs.w : gs.h), halfSizeFrac = (oldPrivate['_' + axLetter + 'size'] || 0) / (2 * plotSize); if(axOld && axNew) { // data -> different data // go to the same fraction of the axis length // whether or not these axes share a domain // first convert to fraction of the axis position = (position - axOld.range[0]) / (axOld.range[1] - axOld.range[0]); // then convert to new data coordinates at the same fraction position = axNew.range[0] + position * (axNew.range[1] - axNew.range[0]); } else if(axOld) { // data -> paper // first convert to fraction of the axis position = (position - axOld.range[0]) / (axOld.range[1] - axOld.range[0]); // next scale the axis to the whole plot position = axOld.domain[0] + position * (axOld.domain[1] - axOld.domain[0]); // finally see if we need to adjust auto alignment // because auto always means middle / center alignment for data, // but it changes for page alignment based on the closest side if(autoAnchor) { var posPlus = position + halfSizeFrac, posMinus = position - halfSizeFrac; if(position + posMinus < 2/3) position = posMinus; else if(position + posPlus > 4/3) position = posPlus; } } else if(axNew) { // paper -> data // first see if we need to adjust auto alignment if(autoAnchor) { if(position < 1/3) position += halfSizeFrac; else if(position > 2/3) position -= halfSizeFrac; } // next convert to fraction of the axis position = (position - axNew.domain[0]) / (axNew.domain[1] - axNew.domain[0]); // finally convert to data coordinates position = axNew.range[0] + position * (axNew.range[1] - axNew.range[0]); } } if(axNew && axNew===axOld && axTypeOld) { if(axTypeOld==='log' && axNew.type!=='log') { position = Math.pow(10,position); } else if(axTypeOld!=='log' && axNew.type==='log') { position = (position>0) ? Math.log(position)/Math.LN10 : undefined; } } optionsIn[axLetter] = position; } var options = handleAnnotationDefaults(optionsIn, fullLayout); fullLayout.annotations[index] = options; var xa = Plotly.Axes.getFromId(gd, options.xref), ya = Plotly.Axes.getFromId(gd, options.yref), annPosPx = {x: 0, y: 0}, textangle = +options.textangle || 0; // create the components // made a single group to contain all, so opacity can work right // with border/arrow together this could handle a whole bunch of // cleanup at this point, but works for now var anngroup = fullLayout._infolayer.append('g') .classed('annotation', true) .attr('data-index', String(index)) .style('opacity', options.opacity) .on('click', function() { gd._dragging = false; gd.emit('plotly_clickannotation', { index: index, annotation: optionsIn, fullAnnotation: options }); }); // another group for text+background so that they can rotate together var anng = anngroup.append('g') .classed('annotation-text-g', true) .attr('data-index', String(index)); var ann = anng.append('svg') .call(Plotly.Drawing.setPosition, 0, 0); var borderwidth = options.borderwidth, borderpad = options.borderpad, borderfull = borderwidth + borderpad; var annbg = ann.append('rect') .attr('class','bg') .style('stroke-width', borderwidth+'px') .call(Plotly.Color.stroke, options.bordercolor) .call(Plotly.Color.fill, options.bgcolor); var font = options.font; var anntext = ann.append('text') .classed('annotation', true) .attr('data-unformatted', options.text) .text(options.text); function textLayout(s) { s.call(Plotly.Drawing.font, font) .attr({ 'text-anchor': { left: 'start', right: 'end' }[options.align] || 'middle' }); Plotly.util.convertToTspans(s, drawGraphicalElements); return s; } function drawGraphicalElements() { // make sure lines are aligned the way they will be // at the end, even if their position changes anntext.selectAll('tspan.line').attr({y: 0, x: 0}); var mathjaxGroup = ann.select('.annotation-math-group'), hasMathjax = !mathjaxGroup.empty(), anntextBB = Plotly.Drawing.bBox( (hasMathjax ? mathjaxGroup : anntext).node()), annwidth = anntextBB.width, annheight = anntextBB.height, outerwidth = Math.round(annwidth + 2 * borderfull), outerheight = Math.round(annheight + 2 * borderfull); // save size in the annotation object for use by autoscale options._w = annwidth; options._h = annheight; function shiftFraction(v, anchor) { if(anchor==='auto') { if(v < 1/3) anchor = 'left'; else if(v > 2/3) anchor = 'right'; else anchor = 'center'; } return { center: 0, middle: 0, left: 0.5, bottom: -0.5, right: -0.5, top: 0.5 }[anchor]; } var annotationIsOffscreen = false; ['x', 'y'].forEach(function(axLetter) { var ax = Plotly.Axes.getFromId(gd, options[axLetter+'ref']||axLetter), dimAngle = (textangle + (axLetter==='x' ? 0 : 90)) * Math.PI/180, annSize = outerwidth * Math.abs(Math.cos(dimAngle)) + outerheight * Math.abs(Math.sin(dimAngle)), anchor = options[axLetter + 'anchor'], alignPosition; // calculate pixel position if(ax) { // hide the annotation if it's pointing // outside the visible plot (as long as the axis // isn't autoranged - then we need to draw it // anyway to get its bounding box) if(!ax.autorange && ((options[axLetter] - ax.range[0]) * (options[axLetter] - ax.range[1]) > 0)) { annotationIsOffscreen = true; return; } annPosPx[axLetter] = ax._offset+ax.l2p(options[axLetter]); alignPosition = 0.5; } else { alignPosition = options[axLetter]; if(axLetter === 'y') alignPosition = 1 - alignPosition; annPosPx[axLetter] = (axLetter === 'x') ? (gs.l + gs.w * alignPosition) : (gs.t + gs.h * alignPosition); } var alignShift = 0; if(options.showarrow) { alignShift = options['a' + axLetter]; } else { alignShift = annSize * shiftFraction(alignPosition, anchor); } annPosPx[axLetter] += alignShift; // save the current axis type for later log/linear changes options['_' + axLetter + 'type'] = ax && ax.type; // save the size and shift in this dim for autorange options['_' + axLetter + 'size'] = annSize; options['_' + axLetter + 'shift'] = alignShift; }); if(annotationIsOffscreen) { ann.remove(); return; } var arrowX, arrowY; // make sure the arrowhead (if there is one) // and the annotation center are visible if(options.showarrow) { arrowX = Plotly.Lib.constrain(annPosPx.x - options.ax, 1, fullLayout.width - 1); arrowY = Plotly.Lib.constrain(annPosPx.y - options.ay, 1, fullLayout.height - 1); } annPosPx.x = Plotly.Lib.constrain(annPosPx.x, 1, fullLayout.width - 1); annPosPx.y = Plotly.Lib.constrain(annPosPx.y, 1, fullLayout.height - 1); var texty = borderfull - anntextBB.top, textx = borderfull - anntextBB.left; if(hasMathjax) { mathjaxGroup.select('svg').attr({x: borderfull - 1, y: borderfull}); } else { anntext.attr({x: textx, y: texty}); anntext.selectAll('tspan.line').attr({y: texty, x: textx}); } annbg.call(Plotly.Drawing.setRect, borderwidth / 2, borderwidth / 2, outerwidth-borderwidth, outerheight - borderwidth); ann.call(Plotly.Drawing.setRect, Math.round(annPosPx.x - outerwidth / 2), Math.round(annPosPx.y - outerheight / 2), outerwidth, outerheight); var annbase = 'annotations['+index+']'; // add the arrow // uses options[arrowwidth,arrowcolor,arrowhead] for styling var drawArrow = function(dx, dy) { d3.select(gd) .selectAll('.annotation-arrow-g[data-index="' + index + '"]') .remove(); // find where to start the arrow: // at the border of the textbox, if that border is visible, // or at the edge of the lines of text, if the border is hidden // TODO: tspan bounding box fails in chrome // looks like there may be a cross-browser solution, see // http://stackoverflow.com/questions/5364980/ // how-to-get-the-width-of-an-svg-tspan-element var arrowX0 = annPosPx.x + dx, arrowY0 = annPosPx.y + dy, // create transform matrix and related functions transform = Plotly.Lib.rotationXYMatrix(textangle, arrowX0, arrowY0), applyTransform = Plotly.Lib.apply2DTransform(transform), applyTransform2 = Plotly.Lib.apply2DTransform2(transform), // calculate and transform bounding box xHalf = annbg.attr('width')/2, yHalf = annbg.attr('height')/2, edges = [ [arrowX0 - xHalf, arrowY0 - yHalf, arrowX0 - xHalf, arrowY0 + yHalf], [arrowX0 - xHalf, arrowY0 + yHalf, arrowX0 + xHalf, arrowY0 + yHalf], [arrowX0 + xHalf, arrowY0 + yHalf, arrowX0 + xHalf, arrowY0 - yHalf], [arrowX0 + xHalf, arrowY0 - yHalf, arrowX0 - xHalf, arrowY0 - yHalf] ].map(applyTransform2); // Remove the line if it ends inside the box. Use ray // casting for rotated boxes: see which edges intersect a // line from the arrowhead to far away and reduce with xor // to get the parity of the number of intersections. if(edges.reduce(function(a, x) { return a ^ !!lineIntersect(arrowX, arrowY, arrowX + 1e6, arrowY + 1e6, x[0], x[1], x[2], x[3]); }, false)) { // no line or arrow - so quit drawArrow now return; } edges.forEach(function(x) { var p = lineIntersect(arrowX0, arrowY0, arrowX, arrowY, x[0], x[1], x[2], x[3]); if(p) { arrowX0 = p.x; arrowY0 = p.y; } }); var strokewidth = options.arrowwidth, arrowColor = options.arrowcolor; var arrowgroup = anngroup.append('g') .style({opacity: Plotly.Color.opacity(arrowColor)}) .classed('annotation-arrow-g', true) .attr('data-index', String(index)); var arrow = arrowgroup.append('path') .attr('d', 'M'+arrowX0+','+arrowY0+'L'+arrowX+','+arrowY) .style('stroke-width', strokewidth+'px') .call(Plotly.Color.stroke, Plotly.Color.rgb(arrowColor)); annotations.arrowhead(arrow, options.arrowhead, 'end', options.arrowsize); var arrowdrag = arrowgroup.append('path') .classed('annotation', true) .classed('anndrag', true) .attr({ 'data-index': String(index), d: 'M3,3H-3V-3H3ZM0,0L' + (arrowX0-arrowX) + ',' + (arrowY0-arrowY), transform: 'translate('+arrowX+','+arrowY+')' }) .style('stroke-width', (strokewidth+6)+'px') .call(Plotly.Color.stroke, 'rgba(0,0,0,0)') .call(Plotly.Color.fill, 'rgba(0,0,0,0)'); if(gd._context.editable) { var update, annx0, anny0; Plotly.Fx.dragElement({ element: arrowdrag.node(), prepFn: function() { annx0 = Number(ann.attr('x')); anny0 = Number(ann.attr('y')); update = {}; if(xa && xa.autorange) { update[xa._name+'.autorange'] = true; } if(ya && ya.autorange) { update[ya._name+'.autorange'] = true; } }, moveFn: function(dx, dy) { arrowgroup.attr('transform', 'translate('+dx+','+dy+')'); var annxy0 = applyTransform(annx0, anny0), xcenter = annxy0[0] + dx, ycenter = annxy0[1] + dy; ann.call(Plotly.Drawing.setPosition, xcenter, ycenter); update[annbase+'.x'] = xa ? (options.x + dx / xa._m) : ((arrowX + dx - gs.l) / gs.w); update[annbase+'.y'] = ya ? (options.y + dy / ya._m) : (1 - ((arrowY + dy - gs.t) / gs.h)); anng.attr({ transform: 'rotate(' + textangle + ',' + xcenter + ',' + ycenter + ')' }); }, doneFn: function(dragged) { if(dragged) { Plotly.relayout(gd, update); var notesBox = document.querySelector('.js-notes-box-panel'); if(notesBox) notesBox.redraw(notesBox.selectedObj); } } }); } }; if(options.showarrow) drawArrow(0, 0); // create transform matrix and related functions var transform = Plotly.Lib.rotationXYMatrix(textangle, annPosPx.x, annPosPx.y), applyTransform = Plotly.Lib.apply2DTransform(transform); // user dragging the annotation (text, not arrow) if(gd._context.editable) { var x0, y0, update; Plotly.Fx.dragElement({ element: ann.node(), prepFn: function() { x0 = Number(ann.attr('x')); y0 = Number(ann.attr('y')); update = {}; }, moveFn: function(dx, dy) { ann.call(Plotly.Drawing.setPosition, x0 + dx, y0 + dy); var csr = 'pointer'; if(options.showarrow) { update[annbase+'.ax'] = options.ax + dx; update[annbase+'.ay'] = options.ay + dy; drawArrow(dx, dy); } else { if(xa) update[annbase + '.x'] = options.x + dx / xa._m; else { var widthFraction = options._xsize / gs.w, xLeft = options.x + options._xshift / gs.w - widthFraction / 2; update[annbase + '.x'] = Plotly.Fx.dragAlign(xLeft + dx / gs.w, widthFraction, 0, 1, options.xanchor); } if(ya) update[annbase + '.y'] = options.y + dy / ya._m; else { var heightFraction = options._ysize / gs.h, yBottom = options.y - options._yshift / gs.h - heightFraction / 2; update[annbase + '.y'] = Plotly.Fx.dragAlign(yBottom - dy / gs.h, heightFraction, 0, 1, options.yanchor); } if(!xa || !ya) { csr = Plotly.Fx.dragCursors( xa ? 0.5 : update[annbase + '.x'], ya ? 0.5 : update[annbase + '.y'], options.xanchor, options.yanchor ); } } var xy1 = applyTransform(x0, y0), x1 = xy1[0] + dx, y1 = xy1[1] + dy; ann.call(Plotly.Drawing.setPosition, x1, y1); anng.attr({ transform: 'rotate(' + textangle + ',' + x1 + ',' + y1 + ')' }); Plotly.Fx.setCursor(ann, csr); }, doneFn: function(dragged) { Plotly.Fx.setCursor(ann); if(dragged) { Plotly.relayout(gd, update); var notesBox = document.querySelector('.js-notes-box-panel'); if(notesBox) notesBox.redraw(notesBox.selectedObj); } } }); } } if(gd._context.editable) { anntext.call(Plotly.util.makeEditable, ann) .call(textLayout) .on('edit', function(_text) { options.text = _text; this.attr({'data-unformatted': options.text}); this.call(textLayout); var update = {}; update['annotations['+index+'].text'] = options.text; if(xa && xa.autorange) { update[xa._name+'.autorange'] = true; } if(ya && ya.autorange) { update[ya._name+'.autorange'] = true; } Plotly.relayout(gd,update); }); } else anntext.call(textLayout); // rotate and position text and background anng.attr({transform: 'rotate(' + textangle + ',' + annPosPx.x + ',' + annPosPx.y + ')'}) .call(Plotly.Drawing.setPosition, annPosPx.x, annPosPx.y); }; // add arrowhead(s) to a path or line d3 element el3 // style: 1-6, first 5 are pointers, 6 is circle, 7 is square, 8 is none // ends is 'start', 'end' (default), 'start+end' // mag is magnification vs. default (default 1) annotations.arrowhead = function(el3, style, ends, mag) { if(!isNumeric(mag)) mag = 1; var el = el3.node(), headStyle = annotations.ARROWPATHS[style||0]; if(!headStyle) return; if(typeof ends !== 'string' || !ends) ends = 'end'; var scale = (Plotly.Drawing.getPx(el3,'stroke-width') || 1) * mag, stroke = el3.style('stroke') || Plotly.Color.defaultLine, opacity = el3.style('stroke-opacity') || 1, doStart = ends.indexOf('start') >= 0, doEnd = ends.indexOf('end') >= 0, backOff = headStyle.backoff * scale, start, end, startRot, endRot; if(el.nodeName === 'line') { start = {x: +el3.attr('x1'), y: +el3.attr('y1')}; end = {x: +el3.attr('x2'), y: +el3.attr('y2')}; startRot = Math.atan2(start.y - end.y, start.x - end.x); endRot = startRot + Math.PI; if(backOff) { var backOffX = backOff * Math.cos(startRot), backOffY = backOff * Math.sin(startRot); if(doStart) { start.x -= backOffX; start.y -= backOffY; el3.attr({x1: start.x, y1: start.y}); } if(doEnd) { end.x += backOffX; end.y += backOffY; el3.attr({x2: end.x, y2: end.y}); } } } else if(el.nodeName === 'path') { var pathlen = el.getTotalLength(), // using dash to hide the backOff region of the path. // if we ever allow dash for the arrow we'll have to // do better than this hack... maybe just manually // combine the two dashArray = ''; if(doStart) { var start0 = el.getPointAtLength(0), dstart = el.getPointAtLength(0.1); startRot = Math.atan2(start0.y - dstart.y, start0.x - dstart.x); start = el.getPointAtLength(Math.min(backOff, pathlen)); if(backOff) dashArray = '0px,' + backOff + 'px,'; } if(doEnd) { var end0 = el.getPointAtLength(pathlen), dend = el.getPointAtLength(pathlen - 0.1); endRot = Math.atan2(end0.y - dend.y, end0.x - dend.x); end = el.getPointAtLength(Math.max(0, pathlen - backOff)); if(backOff) { var shortening = dashArray ? 2 * backOff : backOff; dashArray += (pathlen - shortening) + 'px,' + pathlen + 'px'; } } else if(dashArray) dashArray += pathlen + 'px'; if(dashArray) el3.style('stroke-dasharray', dashArray); } var drawhead = function(p, rot) { if(style>5) rot=0; // don't rotate square or circle d3.select(el.parentElement).append('path') .attr({ 'class': el3.attr('class'), d: headStyle.path, transform: 'translate(' + p.x + ',' + p.y + ')' + 'rotate(' + (rot * 180 / Math.PI) + ')' + 'scale(' + scale + ')' }) .style({ fill: stroke, opacity: opacity, 'stroke-width': 0 }); }; if(doStart) drawhead(start, startRot); if(doEnd) drawhead(end, endRot); }; annotations.calcAutorange = function(gd) { var fullLayout = gd._fullLayout, annotationList = fullLayout.annotations; if(!annotationList.length || !gd._fullData.length) return; var annotationAxes = {}; annotationList.forEach(function(ann) { annotationAxes[ann.xref] = true; annotationAxes[ann.yref] = true; }); var autorangedAnnos = Plotly.Axes.list(gd) .filter(function(ax) { return ax.autorange && annotationAxes[ax._id]; }); if(!autorangedAnnos.length) return; return Plotly.Lib.syncOrAsync([ annotations.drawAll, annAutorange ], gd); }; function annAutorange(gd) { var fullLayout = gd._fullLayout; // find the bounding boxes for each of these annotations' // relative to their anchor points // use the arrow and the text bg rectangle, // as the whole anno may include hidden text in its bbox fullLayout.annotations.forEach(function(ann) { var xa = Plotly.Axes.getFromId(gd, ann.xref), ya = Plotly.Axes.getFromId(gd, ann.yref); if(!(xa || ya)) return; var halfWidth = (ann._xsize || 0)/2, xShift = ann._xshift || 0, halfHeight = (ann._ysize || 0)/2, yShift = ann._yshift || 0, leftSize = halfWidth - xShift, rightSize = halfWidth + xShift, topSize = halfHeight - yShift, bottomSize = halfHeight + yShift; if(ann.showarrow) { var headSize = 3 * ann.arrowsize * ann.arrowwidth; leftSize = Math.max(leftSize, headSize); rightSize = Math.max(rightSize, headSize); topSize = Math.max(topSize, headSize); bottomSize = Math.max(bottomSize, headSize); } if(xa && xa.autorange) { Plotly.Axes.expand(xa, [xa.l2c(ann.x)],{ ppadplus: rightSize, ppadminus: leftSize }); } if(ya && ya.autorange) { Plotly.Axes.expand(ya, [ya.l2c(ann.y)], { ppadplus: bottomSize, ppadminus: topSize }); } }); } // look for intersection of two line segments // (1->2 and 3->4) - returns array [x,y] if they do, null if not function lineIntersect(x1, y1, x2, y2, x3, y3, x4, y4) { var a = x2 - x1, b = x3 - x1, c = x4 - x3, d = y2 - y1, e = y3 - y1, f = y4 - y3, det = a * f - c * d; // parallel lines? intersection is undefined // ignore the case where they are colinear if(det === 0) return null; var t = (b * f - c * e) / det, u = (b * d - a * e) / det; // segments do not intersect? if(u<0 || u>1 || t<0 || t>1) return null; return {x: x1 + a * t, y: y1 + d * t}; } },{"../../plotly":366,"./arrow_paths":295,"./attributes":296,"d3":70,"fast-isnumeric":74}],298:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; // IMPORTANT - default colors should be in hex for compatibility exports.defaults = [ '#1f77b4', // muted blue '#ff7f0e', // safety orange '#2ca02c', // cooked asparagus green '#d62728', // brick red '#9467bd', // muted purple '#8c564b', // chestnut brown '#e377c2', // raspberry yogurt pink '#7f7f7f', // middle gray '#bcbd22', // curry yellow-green '#17becf' // blue-teal ]; exports.defaultLine = '#444'; exports.lightLine = '#eee'; exports.background = '#fff'; },{}],299:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var tinycolor = require('tinycolor2'); var isNumeric = require('fast-isnumeric'); var color = module.exports = {}; var colorAttrs = require('./attributes'); color.defaults = colorAttrs.defaults; color.defaultLine = colorAttrs.defaultLine; color.lightLine = colorAttrs.lightLine; color.background = colorAttrs.background; color.tinyRGB = function(tc) { var c = tc.toRgb(); return 'rgb(' + Math.round(c.r) + ', ' + Math.round(c.g) + ', ' + Math.round(c.b) + ')'; }; color.rgb = function(cstr) { return color.tinyRGB(tinycolor(cstr)); }; color.opacity = function(cstr) { return cstr ? tinycolor(cstr).getAlpha() : 0; }; color.addOpacity = function(cstr, op) { var c = tinycolor(cstr).toRgb(); return 'rgba(' + Math.round(c.r) + ', ' + Math.round(c.g) + ', ' + Math.round(c.b) + ', ' + op + ')'; }; // combine two colors into one apparent color // if back has transparency or is missing, // color.background is assumed behind it color.combine = function(front, back) { var fc = tinycolor(front).toRgb(); if(fc.a===1) return tinycolor(front).toRgbString(); var bc = tinycolor(back||color.background).toRgb(), bcflat = bc.a===1 ? bc : { r: 255 * (1-bc.a) + bc.r*bc.a, g: 255 * (1-bc.a) + bc.g*bc.a, b: 255 * (1-bc.a) + bc.b*bc.a }, fcflat = { r: bcflat.r*(1-fc.a) + fc.r*fc.a, g: bcflat.g*(1-fc.a) + fc.g*fc.a, b: bcflat.b*(1-fc.a) + fc.b*fc.a }; return tinycolor(fcflat).toRgbString(); }; color.stroke = function(s, c) { var tc = tinycolor(c); s.style({'stroke': color.tinyRGB(tc), 'stroke-opacity': tc.getAlpha()}); }; color.fill = function(s, c) { var tc = tinycolor(c); s.style({'fill': color.tinyRGB(tc), 'fill-opacity': tc.getAlpha()}); }; // search container for colors with the deprecated rgb(fractions) format // and convert them to rgb(0-255 values) color.clean = function(container) { if(!container || typeof container !== 'object') return; var keys = Object.keys(container), i, j, key, val; for(i = 0; i < keys.length; i++) { key = keys[i]; val = container[key]; // only sanitize keys that end in "color" or "colorscale" if(key.substr(key.length - 5) === 'color') { if(Array.isArray(val)) { for(j = 0; j < val.length; j++) val[j] = cleanOne(val[j]); } else container[key] = cleanOne(val); } else if(key.substr(key.length - 10) === 'colorscale' && Array.isArray(val)) { // colorscales have the format [[0, color1], [frac, color2], ... [1, colorN]] for(j = 0; j < val.length; j++) { if(Array.isArray(val[j])) val[j][1] = cleanOne(val[j][1]); } } // recurse into arrays of objects, and plain objects else if(Array.isArray(val)) { var el0 = val[0]; if(!Array.isArray(el0) && el0 && typeof el0 === 'object') { for(j = 0; j < val.length; j++) color.clean(val[j]); } } else if(val && typeof val === 'object') color.clean(val); } }; function cleanOne(val) { if(isNumeric(val) || typeof val !== 'string') return val; var valTrim = val.trim(); if(valTrim.substr(0,3) !== 'rgb') return val; var match = valTrim.match(/^rgba?\s*\(([^()]*)\)$/); if(!match) return val; var parts = match[1].trim().split(/\s*[\s,]\s*/), rgba = valTrim.charAt(3) === 'a' && parts.length === 4; if(!rgba && parts.length !== 3) return val; for(var i = 0; i < parts.length; i++) { if(!parts[i].length) return val; parts[i] = Number(parts[i]); // all parts must be non-negative numbers if(!(parts[i] >= 0)) return val; // alpha>1 gets clipped to 1 if(i === 3) { if(parts[i] > 1) parts[i] = 1; } // r, g, b must be < 1 (ie 1 itself is not allowed) else if(parts[i] >= 1) return val; } var rgbStr = Math.round(parts[0] * 255) + ', ' + Math.round(parts[1] * 255) + ', ' + Math.round(parts[2] * 255); if(rgba) return 'rgba(' + rgbStr + ', ' + parts[3] + ')'; return 'rgb(' + rgbStr + ')'; } },{"./attributes":298,"fast-isnumeric":74,"tinycolor2":229}],300:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var axesAttrs = require('../../plots/cartesian/layout_attributes'); var fontAttrs = require('../../plots/font_attributes'); var extendFlat = require('../../lib/extend').extendFlat; module.exports = { // TODO: only right is supported currently // orient: { // valType: 'enumerated', // // values: ['left', 'right', 'top', 'bottom'], // dflt: 'right', // // }, thicknessmode: { valType: 'enumerated', values: ['fraction', 'pixels'], dflt: 'pixels', }, thickness: { valType: 'number', min: 0, dflt: 30, }, lenmode: { valType: 'enumerated', values: ['fraction', 'pixels'], dflt: 'fraction', }, len: { valType: 'number', min: 0, dflt: 1, }, x: { valType: 'number', dflt: 1.02, min: -2, max: 3, }, xanchor: { valType: 'enumerated', values: ['left', 'center', 'right'], dflt: 'left', }, xpad: { valType: 'number', min: 0, dflt: 10, }, y: { valType: 'number', dflt: 0.5, min: -2, max: 3, }, yanchor: { valType: 'enumerated', values: ['top', 'middle', 'bottom'], dflt: 'middle', }, ypad: { valType: 'number', min: 0, dflt: 10, }, // a possible line around the bar itself outlinecolor: axesAttrs.linecolor, outlinewidth: axesAttrs.linewidth, // Should outlinewidth have {dflt: 0} ? // another possible line outside the padding and tick labels bordercolor: axesAttrs.linecolor, borderwidth: { valType: 'number', min: 0, dflt: 0, }, bgcolor: { valType: 'color', dflt: 'rgba(0,0,0,0)', }, // tick and title properties named and function exactly as in axes tickmode: axesAttrs.tickmode, nticks: axesAttrs.nticks, tick0: axesAttrs.tick0, dtick: axesAttrs.dtick, tickvals: axesAttrs.tickvals, ticktext: axesAttrs.ticktext, ticks: extendFlat({}, axesAttrs.ticks, {dflt: ''}), ticklen: axesAttrs.ticklen, tickwidth: axesAttrs.tickwidth, tickcolor: axesAttrs.tickcolor, showticklabels: axesAttrs.showticklabels, tickfont: axesAttrs.tickfont, tickangle: axesAttrs.tickangle, tickformat: axesAttrs.tickformat, tickprefix: axesAttrs.tickprefix, showtickprefix: axesAttrs.showtickprefix, ticksuffix: axesAttrs.ticksuffix, showticksuffix: axesAttrs.showticksuffix, exponentformat: axesAttrs.exponentformat, showexponent: axesAttrs.showexponent, title: { valType: 'string', dflt: 'Click to enter colorscale title', }, titlefont: extendFlat({}, fontAttrs, { }), titleside: { valType: 'enumerated', values: ['right', 'top', 'bottom'], dflt: 'top', } }; },{"../../lib/extend":345,"../../plots/cartesian/layout_attributes":376,"../../plots/font_attributes":383}],301:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var handleTickValueDefaults = require('../../plots/cartesian/tick_value_defaults'); var handleTickDefaults = require('../../plots/cartesian/tick_defaults'); var attributes = require('./attributes'); module.exports = function colorbarDefaults(containerIn, containerOut, layout) { var colorbarOut = containerOut.colorbar = {}, colorbarIn = containerIn.colorbar || {}; function coerce(attr, dflt) { return Lib.coerce(colorbarIn, colorbarOut, attributes, attr, dflt); } var thicknessmode = coerce('thicknessmode'); coerce('thickness', (thicknessmode === 'fraction') ? 30 / (layout.width - layout.margin.l - layout.margin.r) : 30 ); var lenmode = coerce('lenmode'); coerce('len', (lenmode === 'fraction') ? 1 : layout.height - layout.margin.t - layout.margin.b ); coerce('x'); coerce('xanchor'); coerce('xpad'); coerce('y'); coerce('yanchor'); coerce('ypad'); Lib.noneOrAll(colorbarIn, colorbarOut, ['x', 'y']); coerce('outlinecolor'); coerce('outlinewidth'); coerce('bordercolor'); coerce('borderwidth'); coerce('bgcolor'); handleTickValueDefaults(colorbarIn, colorbarOut, coerce, 'linear'); handleTickDefaults(colorbarIn, colorbarOut, coerce, 'linear', {outerTicks: false, font: layout.font, noHover: true}); coerce('title'); Lib.coerceFont(coerce, 'titlefont', layout.font); coerce('titleside'); }; },{"../../lib":349,"../../plots/cartesian/tick_defaults":381,"../../plots/cartesian/tick_value_defaults":382,"./attributes":300}],302:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Plotly = require('../../plotly'); var Plots = require('../../plots/plots'); var Axes = require('../../plots/cartesian/axes'); var Fx = require('../../plots/cartesian/graph_interact'); var Lib = require('../../lib'); var Drawing = require('../drawing'); var Color = require('../color'); var Titles = require('../titles'); var handleAxisDefaults = require('../../plots/cartesian/axis_defaults'); var handleAxisPositionDefaults = require('../../plots/cartesian/position_defaults'); var axisLayoutAttrs = require('../../plots/cartesian/layout_attributes'); var attributes = require('./attributes'); module.exports = function draw(gd, id) { // opts: options object, containing everything from attributes // plus a few others that are the equivalent of the colorbar "data" var opts = {}; Object.keys(attributes).forEach(function(k) { opts[k] = null; }); // fillcolor can be a d3 scale, domain is z values, range is colors // or leave it out for no fill, // or set to a string constant for single-color fill opts.fillcolor = null; // line.color has the same options as fillcolor opts.line = {color: null, width: null, dash: null}; // levels of lines to draw. // note that this DOES NOT determine the extent of the bar // that's given by the domain of fillcolor // (or line.color if no fillcolor domain) opts.levels = {start: null, end: null, size: null}; // separate fill levels (for example, heatmap coloring of a // contour map) if this is omitted, fillcolors will be // evaluated halfway between levels opts.filllevels = null; function component() { var fullLayout = gd._fullLayout; if((typeof opts.fillcolor !== 'function') && (typeof opts.line.color !== 'function')) { fullLayout._infolayer.selectAll('g.'+id).remove(); return; } var zrange = d3.extent(((typeof opts.fillcolor === 'function') ? opts.fillcolor : opts.line.color).domain()), linelevels = [], filllevels = [], l, linecolormap = typeof opts.line.color === 'function' ? opts.line.color : function() { return opts.line.color; }, fillcolormap = typeof opts.fillcolor === 'function' ? opts.fillcolor : function() { return opts.fillcolor; }; var l0 = opts.levels.end + opts.levels.size/100, ls = opts.levels.size, zr0 = (1.001 * zrange[0] - 0.001 * zrange[1]), zr1 = (1.001 * zrange[1] - 0.001 * zrange[0]); for(l = opts.levels.start; (l - l0) * ls < 0; l += ls) { if(l > zr0 && l < zr1) linelevels.push(l); } if(typeof opts.fillcolor === 'function') { if(opts.filllevels) { l0 = opts.filllevels.end + opts.filllevels.size / 100; ls = opts.filllevels.size; for(l = opts.filllevels.start; (l - l0) * ls < 0; l += ls) { if(l > zrange[0] && l < zrange[1]) filllevels.push(l); } } else { filllevels = linelevels.map(function(v) { return v-opts.levels.size / 2; }); filllevels.push(filllevels[filllevels.length - 1] + opts.levels.size); } } else if(opts.fillcolor && typeof opts.fillcolor==='string') { // doesn't matter what this value is, with a single value // we'll make a single fill rect covering the whole bar filllevels = [0]; } if(opts.levels.size<0) { linelevels.reverse(); filllevels.reverse(); } // now make a Plotly Axes object to scale with and draw ticks // TODO: does not support orientation other than right // we calculate pixel sizes based on the specified graph size, // not the actual (in case something pushed the margins around) // which is a little odd but avoids an odd iterative effect // when the colorbar itself is pushing the margins. // but then the fractional size is calculated based on the // actual graph size, so that the axes will size correctly. var originalPlotHeight = fullLayout.height - fullLayout.margin.t - fullLayout.margin.b, originalPlotWidth = fullLayout.width - fullLayout.margin.l - fullLayout.margin.r, thickPx = Math.round(opts.thickness * (opts.thicknessmode==='fraction' ? originalPlotWidth : 1)), thickFrac = thickPx / fullLayout._size.w, lenPx = Math.round(opts.len * (opts.lenmode==='fraction' ? originalPlotHeight : 1)), lenFrac = lenPx / fullLayout._size.h, xpadFrac = opts.xpad/fullLayout._size.w, yExtraPx = (opts.borderwidth + opts.outlinewidth)/2, ypadFrac = opts.ypad / fullLayout._size.h, // x positioning: do it initially just for left anchor, // then fix at the end (since we don't know the width yet) xLeft = Math.round(opts.x*fullLayout._size.w + opts.xpad), // for dragging... this is getting a little muddled... xLeftFrac = opts.x - thickFrac * ({middle: 0.5, right: 1}[opts.xanchor]||0), // y positioning we can do correctly from the start yBottomFrac = opts.y + lenFrac * (({top: -0.5, bottom: 0.5}[opts.yanchor] || 0) - 0.5), yBottomPx = Math.round(fullLayout._size.h * (1-yBottomFrac)), yTopPx = yBottomPx-lenPx, titleEl, cbAxisIn = { type: 'linear', range: zrange, tickmode: opts.tickmode, nticks: opts.nticks, tick0: opts.tick0, dtick: opts.dtick, tickvals: opts.tickvals, ticktext: opts.ticktext, ticks: opts.ticks, ticklen: opts.ticklen, tickwidth: opts.tickwidth, tickcolor: opts.tickcolor, showticklabels: opts.showticklabels, tickfont: opts.tickfont, tickangle: opts.tickangle, tickformat: opts.tickformat, exponentformat: opts.exponentformat, showexponent: opts.showexponent, showtickprefix: opts.showtickprefix, tickprefix: opts.tickprefix, showticksuffix: opts.showticksuffix, ticksuffix: opts.ticksuffix, title: opts.title, titlefont: opts.titlefont, anchor: 'free', position: 1 }, cbAxisOut = {}, axisOptions = { letter: 'y', font: fullLayout.font, noHover: true }; // Coerce w.r.t. Axes layoutAttributes: // re-use axes.js logic without updating _fullData function coerce(attr, dflt) { return Lib.coerce(cbAxisIn, cbAxisOut, axisLayoutAttrs, attr, dflt); } // Prepare the Plotly axis object handleAxisDefaults(cbAxisIn, cbAxisOut, coerce, axisOptions); handleAxisPositionDefaults(cbAxisIn, cbAxisOut, coerce, axisOptions); cbAxisOut._id = 'y' + id; cbAxisOut._td = gd; // position can't go in through supplyDefaults // because that restricts it to [0,1] cbAxisOut.position = opts.x + xpadFrac + thickFrac; // save for other callers to access this axis component.axis = cbAxisOut; if(['top','bottom'].indexOf(opts.titleside)!==-1) { cbAxisOut.titleside = opts.titleside; cbAxisOut.titlex = opts.x + xpadFrac; cbAxisOut.titley = yBottomFrac + (opts.titleside==='top' ? lenFrac-ypadFrac : ypadFrac); } if(opts.line.color && opts.tickmode === 'auto') { cbAxisOut.tickmode = 'linear'; cbAxisOut.tick0 = opts.levels.start; var dtick = opts.levels.size; // expand if too many contours, so we don't get too many ticks var autoNtick = Lib.constrain( (yBottomPx-yTopPx)/50, 4, 15) + 1, dtFactor = (zrange[1]-zrange[0]) / ((opts.nticks||autoNtick)*dtick); if(dtFactor>1) { var dtexp = Math.pow(10,Math.floor( Math.log(dtFactor)/Math.LN10)); dtick *= dtexp * Lib.roundUp(dtFactor/dtexp,[2,5,10]); // if the contours are at round multiples, reset tick0 // so they're still at round multiples. Otherwise, // keep the first label on the first contour level if((Math.abs(opts.levels.start)/ opts.levels.size+1e-6)%1 < 2e-6) { cbAxisOut.tick0 = 0; } } cbAxisOut.dtick = dtick; } // set domain after init, because we may want to // allow it outside [0,1] cbAxisOut.domain = [ yBottomFrac+ypadFrac, yBottomFrac+lenFrac-ypadFrac ]; cbAxisOut.setScale(); // now draw the elements var container = fullLayout._infolayer.selectAll('g.'+id).data([0]); container.enter().append('g').classed(id,true) .each(function() { var s = d3.select(this); s.append('rect').classed('cbbg',true); s.append('g').classed('cbfills',true); s.append('g').classed('cblines',true); s.append('g').classed('cbaxis',true).classed('crisp',true); s.append('g').classed('cbtitleunshift',true) .append('g').classed('cbtitle',true); s.append('rect').classed('cboutline',true); }); container.attr('transform','translate('+Math.round(fullLayout._size.l)+ ','+Math.round(fullLayout._size.t)+')'); // TODO: this opposite transform is a hack until we make it // more rational which items get this offset var titleCont = container.select('.cbtitleunshift') .attr('transform', 'translate(-'+ Math.round(fullLayout._size.l) + ',-' + Math.round(fullLayout._size.t) + ')'); cbAxisOut._axislayer = container.select('.cbaxis'); var titleHeight = 0; if(['top', 'bottom'].indexOf(opts.titleside) !== -1) { // draw the title so we know how much room it needs // when we squish the axis Titles.draw(gd, cbAxisOut._id + 'title'); } function drawAxis() { if(['top','bottom'].indexOf(opts.titleside)!==-1) { // squish the axis top to make room for the title var titleGroup = container.select('.cbtitle'), titleText = titleGroup.select('text'), titleTrans = [-opts.outlinewidth/2, opts.outlinewidth/2], mathJaxNode = titleGroup .select('.h'+cbAxisOut._id+'title-math-group') .node(), lineSize = 15.6; if(titleText.node()) { lineSize = parseInt(titleText.style('font-size'), 10) * 1.3; } if(mathJaxNode) { titleHeight = Drawing.bBox(mathJaxNode).height; if(titleHeight>lineSize) { // not entirely sure how mathjax is doing // vertical alignment, but this seems to work. titleTrans[1] -= (titleHeight-lineSize)/2; } } else if(titleText.node() && !titleText.classed('js-placeholder')) { titleHeight = Drawing.bBox( titleGroup.node()).height; } if(titleHeight) { // buffer btwn colorbar and title // TODO: configurable titleHeight += 5; if(opts.titleside==='top') { cbAxisOut.domain[1] -= titleHeight/fullLayout._size.h; titleTrans[1] *= -1; } else { cbAxisOut.domain[0] += titleHeight/fullLayout._size.h; var nlines = Math.max(1, titleText.selectAll('tspan.line').size()); titleTrans[1] += (1-nlines)*lineSize; } titleGroup.attr('transform', 'translate('+titleTrans+')'); cbAxisOut.setScale(); } } container.selectAll('.cbfills,.cblines,.cbaxis') .attr('transform','translate(0,'+ Math.round(fullLayout._size.h*(1-cbAxisOut.domain[1]))+')'); var fills = container.select('.cbfills') .selectAll('rect.cbfill') .data(filllevels); fills.enter().append('rect') .classed('cbfill',true) .style('stroke','none'); fills.exit().remove(); fills.each(function(d,i) { var z = [ (i===0) ? zrange[0] : (filllevels[i]+filllevels[i-1])/2, (i===filllevels.length-1) ? zrange[1] : (filllevels[i]+filllevels[i+1])/2 ] .map(cbAxisOut.c2p) .map(Math.round); // offset the side adjoining the next rectangle so they // overlap, to prevent antialiasing gaps if(i!==filllevels.length-1) { z[1] += (z[1]>z[0]) ? 1 : -1; } d3.select(this).attr({ x: xLeft, width: Math.max(thickPx,2), y: d3.min(z), height: Math.max(d3.max(z)-d3.min(z),2) }) .style('fill',fillcolormap(d)); }); var lines = container.select('.cblines') .selectAll('path.cbline') .data(opts.line.color && opts.line.width ? linelevels : []); lines.enter().append('path') .classed('cbline',true); lines.exit().remove(); lines.each(function(d) { d3.select(this) .attr('d','M'+xLeft+',' + (Math.round(cbAxisOut.c2p(d))+(opts.line.width/2)%1) + 'h'+thickPx) .call(Drawing.lineGroupStyle, opts.line.width, linecolormap(d), opts.line.dash); }); // force full redraw of labels and ticks cbAxisOut._axislayer.selectAll('g.'+cbAxisOut._id+'tick,path') .remove(); cbAxisOut._pos = xLeft+thickPx + (opts.outlinewidth||0)/2 - (opts.ticks==='outside' ? 1 : 0); cbAxisOut.side = 'right'; return Axes.doTicks(gd, cbAxisOut); } function positionCB() { // wait for the axis & title to finish rendering before // continuing positioning // TODO: why are we redrawing multiple times now with this? // I guess autoMargin doesn't like being post-promise? var innerWidth = thickPx + opts.outlinewidth/2 + Drawing.bBox(cbAxisOut._axislayer.node()).width; titleEl = titleCont.select('text'); if(titleEl.node() && !titleEl.classed('js-placeholder')) { var mathJaxNode = titleCont .select('.h'+cbAxisOut._id+'title-math-group') .node(), titleWidth; if(mathJaxNode && ['top','bottom'].indexOf(opts.titleside)!==-1) { titleWidth = Drawing.bBox(mathJaxNode).width; } else { // note: the formula below works for all titlesides, // (except for top/bottom mathjax, above) // but the weird fullLayout._size.l is because the titleunshift // transform gets removed by Drawing.bBox titleWidth = Drawing.bBox(titleCont.node()).right - xLeft - fullLayout._size.l; } innerWidth = Math.max(innerWidth,titleWidth); } var outerwidth = 2*opts.xpad + innerWidth + opts.borderwidth + opts.outlinewidth/2, outerheight = yBottomPx-yTopPx; container.select('.cbbg').attr({ x: xLeft-opts.xpad - (opts.borderwidth + opts.outlinewidth)/2, y: yTopPx - yExtraPx, width: Math.max(outerwidth,2), height: Math.max(outerheight + 2*yExtraPx,2) }) .call(Color.fill, opts.bgcolor) .call(Color.stroke, opts.bordercolor) .style({'stroke-width': opts.borderwidth}); container.selectAll('.cboutline').attr({ x: xLeft, y: yTopPx + opts.ypad + (opts.titleside==='top' ? titleHeight : 0), width: Math.max(thickPx,2), height: Math.max(outerheight - 2*opts.ypad - titleHeight, 2) }) .call(Color.stroke, opts.outlinecolor) .style({ fill: 'None', 'stroke-width': opts.outlinewidth }); // fix positioning for xanchor!='left' var xoffset = ({center: 0.5, right: 1}[opts.xanchor] || 0) * outerwidth; container.attr('transform', 'translate('+(fullLayout._size.l-xoffset)+','+fullLayout._size.t+')'); //auto margin adjustment Plots.autoMargin(gd, id,{ x: opts.x, y: opts.y, l: outerwidth * ({right: 1, center: 0.5}[opts.xanchor] || 0), r: outerwidth * ({left: 1, center: 0.5}[opts.xanchor] || 0), t: outerheight * ({bottom: 1, middle: 0.5}[opts.yanchor] || 0), b: outerheight * ({top: 1, middle: 0.5}[opts.yanchor] || 0) }); } var cbDone = Lib.syncOrAsync([ Plots.previousPromises, drawAxis, Plots.previousPromises, positionCB ], gd); if(cbDone && cbDone.then) (gd._promises || []).push(cbDone); // dragging... if(gd._context.editable) { var t0, xf, yf; Fx.dragElement({ element: container.node(), prepFn: function() { t0 = container.attr('transform'); Fx.setCursor(container); }, moveFn: function(dx, dy) { var gs = gd._fullLayout._size; container.attr('transform', t0+' ' + 'translate('+dx+','+dy+')'); xf = Fx.dragAlign(xLeftFrac + (dx/gs.w), thickFrac, 0, 1, opts.xanchor); yf = Fx.dragAlign(yBottomFrac - (dy/gs.h), lenFrac, 0, 1, opts.yanchor); var csr = Fx.dragCursors(xf, yf, opts.xanchor, opts.yanchor); Fx.setCursor(container, csr); }, doneFn: function(dragged) { Fx.setCursor(container); if(dragged && xf!==undefined && yf!==undefined) { var idNum = id.substr(2), traceNum; gd._fullData.some(function(trace) { if(trace.uid===idNum) { traceNum = trace.index; return true; } }); Plotly.restyle(gd, {'colorbar.x': xf, 'colorbar.y': yf}, traceNum); } } }); } return cbDone; } // setter/getters for every item defined in opts Object.keys(opts).forEach(function(name) { component[name] = function(v) { // getter if(!arguments.length) return opts[name]; // setter - for multi-part properties, // set only the parts that are provided opts[name] = Lib.isPlainObject(opts[name]) ? Lib.extendFlat(opts[name], v) : v; return component; }; }); // or use .options to set multiple options at once via a dictionary component.options = function(o) { Object.keys(o).forEach(function(name) { // in case something random comes through // that's not an option, ignore it if(typeof component[name]==='function') { component[name](o[name]); } }); return component; }; component._opts = opts; return component; }; },{"../../lib":349,"../../plotly":366,"../../plots/cartesian/axes":369,"../../plots/cartesian/axis_defaults":370,"../../plots/cartesian/graph_interact":374,"../../plots/cartesian/layout_attributes":376,"../../plots/cartesian/position_defaults":378,"../../plots/plots":413,"../color":299,"../drawing":317,"../titles":332,"./attributes":300,"d3":70}],303:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = function hasColorbar(container) { return ( typeof container.colorbar === 'object' && container.colorbar !== null ); }; },{}],304:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; exports.attributes = require('./attributes'); exports.supplyDefaults = require('./defaults'); exports.draw = require('./draw'); exports.hasColorbar = require('./has_colorbar'); },{"./attributes":300,"./defaults":301,"./draw":302,"./has_colorbar":303}],305:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { zauto: { valType: 'boolean', dflt: true, }, zmin: { valType: 'number', dflt: null, }, zmax: { valType: 'number', dflt: null, }, colorscale: { valType: 'colorscale', }, autocolorscale: { valType: 'boolean', dflt: true, // gets overrode in 'heatmap' & 'surface' for backwards comp. }, reversescale: { valType: 'boolean', dflt: false, }, showscale: { valType: 'boolean', dflt: true, }, _deprecated: { scl: { valType: 'colorscale', }, reversescl: { valType: 'boolean', } } }; },{}],306:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var scales = require('./scales'); var flipScale = require('./flip_scale'); module.exports = function calc(trace, vals, containerStr, cLetter) { var container, inputContainer; if(containerStr) { container = Lib.nestedProperty(trace, containerStr).get(); inputContainer = Lib.nestedProperty(trace._input, containerStr).get(); } else { container = trace; inputContainer = trace._input; } var auto = container[cLetter + 'auto'], min = container[cLetter + 'min'], max = container[cLetter + 'max'], scl = container.colorscale; if(auto!==false || min===undefined) { min = Lib.aggNums(Math.min, null, vals); } if(auto!==false || max===undefined) { max = Lib.aggNums(Math.max, null, vals); } if(min === max) { min -= 0.5; max += 0.5; } container[cLetter + 'min'] = min; container[cLetter + 'max'] = max; inputContainer[cLetter + 'min'] = min; inputContainer[cLetter + 'max'] = max; if(container.autocolorscale) { if(min * max < 0) scl = scales.RdBu; else if(min >= 0) scl = scales.Reds; else scl = scales.Blues; // reversescale is handled at the containerOut level inputContainer.colorscale = scl; if(container.reversescale) scl = flipScale(scl); container.colorscale = scl; } }; },{"../../lib":349,"./flip_scale":309,"./scales":316}],307:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var scales = require('./scales'); module.exports = scales.RdBu; },{"./scales":316}],308:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var hasColorbar = require('../colorbar/has_colorbar'); var colorbarDefaults = require('../colorbar/defaults'); var isValidScale = require('./is_valid_scale'); var flipScale = require('./flip_scale'); module.exports = function colorScaleDefaults(traceIn, traceOut, layout, coerce, opts) { var prefix = opts.prefix, cLetter = opts.cLetter, containerStr = prefix.slice(0, prefix.length-1), containerIn = prefix ? Lib.nestedProperty(traceIn, containerStr).get() || {} : traceIn, containerOut = prefix ? Lib.nestedProperty(traceOut, containerStr).get() || {} : traceOut, minIn = containerIn[cLetter + 'min'], maxIn = containerIn[cLetter + 'max'], sclIn = containerIn.colorscale; var validMinMax = isNumeric(minIn) && isNumeric(maxIn) && (minIn < maxIn); coerce(prefix + cLetter + 'auto', !validMinMax); coerce(prefix + cLetter + 'min'); coerce(prefix + cLetter + 'max'); // handles both the trace case (autocolorscale is false by default) and // the marker and marker.line case (autocolorscale is true by default) var autoColorscaleDftl; if(sclIn!==undefined) autoColorscaleDftl = !isValidScale(sclIn); coerce(prefix + 'autocolorscale', autoColorscaleDftl); var sclOut = coerce(prefix + 'colorscale'); // reversescale is handled at the containerOut level var reverseScale = coerce(prefix + 'reversescale'); if(reverseScale) containerOut.colorscale = flipScale(sclOut); // ... until Scatter.colorbar can handle marker line colorbars if(prefix === 'marker.line.') return; // handle both the trace case where the dflt is listed in attributes and // the marker case where the dflt is determined by hasColorbar var showScaleDftl; if(prefix) showScaleDftl = hasColorbar(containerIn); var showScale = coerce(prefix + 'showscale', showScaleDftl); if(showScale) colorbarDefaults(containerIn, containerOut, layout); }; },{"../../lib":349,"../colorbar/defaults":301,"../colorbar/has_colorbar":303,"./flip_scale":309,"./is_valid_scale":313,"fast-isnumeric":74}],309:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = function flipScale(scl) { var N = scl.length, sclNew = new Array(N), si; for(var i = N-1, j = 0; i >= 0; i--, j++) { si = scl[i]; sclNew[j] = [1 - si[0], si[1]]; } return sclNew; }; },{}],310:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var scales = require('./scales'); var defaultScale = require('./default_scale'); var isValidScaleArray = require('./is_valid_scale_array'); module.exports = function getScale(scl, dflt) { if(!dflt) dflt = defaultScale; if(!scl) return dflt; function parseScale() { try { scl = scales[scl] || JSON.parse(scl); } catch(e) { scl = dflt; } } if(typeof scl === 'string') { parseScale(); // occasionally scl is double-JSON encoded... if(typeof scl === 'string') parseScale(); } if(!isValidScaleArray(scl)) return dflt; return scl; }; },{"./default_scale":307,"./is_valid_scale_array":314,"./scales":316}],311:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var isValidScale = require('./is_valid_scale'); module.exports = function hasColorscale(trace, containerStr) { var container = containerStr ? Lib.nestedProperty(trace, containerStr).get() || {} : trace, color = container.color, isArrayWithOneNumber = false; if(Array.isArray(color)) { for(var i = 0; i < color.length; i++) { if(isNumeric(color[i])) { isArrayWithOneNumber = true; break; } } } return ( (typeof container==='object' && container!==null) && ( isArrayWithOneNumber || container.showscale===true || (isNumeric(container.cmin) && isNumeric(container.cmax)) || isValidScale(container.colorscale) || (typeof container.colorbar==='object' && container.colorbar!==null) ) ); }; },{"../../lib":349,"./is_valid_scale":313,"fast-isnumeric":74}],312:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; exports.scales = require('./scales'); exports.defaultScale = require('./default_scale'); exports.attributes = require('./attributes'); exports.handleDefaults = require('./defaults'); exports.calc = require('./calc'); exports.hasColorscale = require('./has_colorscale'); exports.isValidScale = require('./is_valid_scale'); exports.getScale = require('./get_scale'); exports.flipScale = require('./flip_scale'); exports.makeScaleFunction = require('./make_scale_function'); },{"./attributes":305,"./calc":306,"./default_scale":307,"./defaults":308,"./flip_scale":309,"./get_scale":310,"./has_colorscale":311,"./is_valid_scale":313,"./make_scale_function":315,"./scales":316}],313:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var scales = require('./scales'); var isValidScaleArray = require('./is_valid_scale_array'); module.exports = function isValidScale(scl) { if(scales[scl] !== undefined) return true; else return isValidScaleArray(scl); }; },{"./is_valid_scale_array":314,"./scales":316}],314:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var tinycolor = require('tinycolor2'); module.exports = function isValidScaleArray(scl) { var isValid = true, highestVal = 0, si; if(!Array.isArray(scl)) return false; else { if(+scl[0][0]!==0 || +scl[scl.length-1][0]!==1) return false; for(var i = 0; i < scl.length; i++) { si = scl[i]; if(si.length!==2 || +si[0] 0) { vbase = 100; v = v.replace('-open',''); } if(v.indexOf('-dot') > 0) { vbase += 200; v = v.replace('-dot',''); } v = drawing.symbolNames.indexOf(v); if(v>=0) { v += vbase; } } if((v%100 >= MAXSYMBOL) || v>=400) { return 0; } return Math.floor(Math.max(v,0)); }; drawing.pointStyle = function(s, trace) { if(!s.size()) return; var marker = trace.marker, markerLine = marker.line; // only scatter & box plots get marker path and opacity // bars, histograms don't if(Plotly.Plots.traceIs(trace, 'symbols')) { var sizeFn = makeBubbleSizeFn(trace); s.attr('d', function(d) { var r; // handle multi-trace graph edit case if(d.ms==='various' || marker.size==='various') r = 3; else r = subTypes.isBubble(trace) ? sizeFn(d.ms) : (marker.size || 6) / 2; // store the calculated size so hover can use it d.mrc = r; // turn the symbol into a sanitized number var x = drawing.symbolNumber(d.mx || marker.symbol) || 0, xBase = x%100; // save if this marker is open // because that impacts how to handle colors d.om = x%200 >= 100; return drawing.symbolFuncs[xBase](r) + (x >= 200 ? DOTPATH : ''); }) .style('opacity',function(d) { return (d.mo+1 || marker.opacity+1) - 1; }); } // allow array marker and marker line colors to be // scaled by given max and min to colorscales var markerIn = (trace._input||{}).marker||{}, markerScale = drawing.tryColorscale(marker, markerIn, ''), lineScale = drawing.tryColorscale(marker, markerIn, 'line.'); s.each(function(d) { // 'so' is suspected outliers, for box plots var fillColor, lineColor, lineWidth; if(d.so) { lineWidth = markerLine.outlierwidth; lineColor = markerLine.outliercolor; fillColor = marker.outliercolor; } else { lineWidth = (d.mlw+1 || markerLine.width+1 || // TODO: we need the latter for legends... can we get rid of it? (d.trace ? d.trace.marker.line.width : 0) + 1) -1; if('mlc' in d) lineColor = d.mlcc = lineScale(d.mlc); // weird case: array wasn't long enough to apply to every point else if(Array.isArray(markerLine.color)) lineColor = Plotly.Color.defaultLine; else lineColor = markerLine.color; if('mc' in d) fillColor = d.mcc = markerScale(d.mc); else if(Array.isArray(marker.color)) fillColor = Plotly.Color.defaultLine; else fillColor = marker.color || 'rgba(0,0,0,0)'; } var p = d3.select(this); if(d.om) { // open markers can't have zero linewidth, default to 1px, // and use fill color as stroke color p.call(Plotly.Color.stroke, fillColor) .style({ 'stroke-width': (lineWidth||1) + 'px', fill: 'none' }); } else { p.style('stroke-width', lineWidth + 'px') .call(Plotly.Color.fill, fillColor); if(lineWidth) { p.call(Plotly.Color.stroke, lineColor); } } }); }; // for a given color attribute (ie m -> mc = marker.color) look to see if we // have a colorscale for it (ie mscl, mcmin, mcmax) - if we do, translate // all numeric color values according to that scale drawing.tryColorscale = function(cont, contIn, prefix) { var colorArray = Plotly.Lib.nestedProperty(cont, prefix + 'color').get(), scl = Plotly.Lib.nestedProperty(cont, prefix + 'colorscale').get(), auto = Plotly.Lib.nestedProperty(cont, prefix + 'cauto').get(), minProp = Plotly.Lib.nestedProperty(cont, prefix + 'cmin'), maxProp = Plotly.Lib.nestedProperty(cont, prefix + 'cmax'), min = minProp.get(), max = maxProp.get(); // TODO handle this in Colorscale.calc if(scl && Array.isArray(colorArray)) { if(auto || !isNumeric(min) || !isNumeric(max)) { min = Infinity; max = -Infinity; colorArray.forEach(function(color) { if(isNumeric(color)) { if(min > color) min = +color; if(max < color) max = +color; } }); if(min > max) { min = 0; max = 1; } minProp.set(min); maxProp.set(max); Plotly.Lib.nestedProperty(contIn, prefix + 'cmin').set(min); Plotly.Lib.nestedProperty(contIn, prefix + 'cmax').set(max); } return Plotly.Colorscale.makeScaleFunction(scl, min, max); } else return Plotly.Lib.identity; }; // draw text at points var TEXTOFFSETSIGN = {start: 1, end: -1, middle: 0, bottom: 1, top: -1}, LINEEXPAND = 1.3; drawing.textPointStyle = function(s, trace) { s.each(function(d) { var p = d3.select(this), text = d.tx || trace.text; if(!text || Array.isArray(text)) { // isArray test handles the case of (intentionally) missing // or empty text within a text array p.remove(); return; } var pos = d.tp || trace.textposition, v = pos.indexOf('top')!==-1 ? 'top' : pos.indexOf('bottom')!==-1 ? 'bottom' : 'middle', h = pos.indexOf('left')!==-1 ? 'end' : pos.indexOf('right')!==-1 ? 'start' : 'middle', fontSize = d.ts || trace.textfont.size, // if markers are shown, offset a little more than // the nominal marker size // ie 2/1.6 * nominal, bcs some markers are a bit bigger r = d.mrc ? (d.mrc/0.8 + 1) : 0; fontSize = (isNumeric(fontSize) && fontSize>0) ? fontSize : 0; p.call(drawing.font, d.tf || trace.textfont.family, fontSize, d.tc || trace.textfont.color) .attr('text-anchor',h) .text(text) .call(Plotly.util.convertToTspans); var pgroup = d3.select(this.parentNode), tspans = p.selectAll('tspan.line'), numLines = ((tspans[0].length||1)-1)*LINEEXPAND+1, dx = TEXTOFFSETSIGN[h]*r, dy = fontSize*0.75 + TEXTOFFSETSIGN[v]*r + (TEXTOFFSETSIGN[v]-1)*numLines*fontSize/2; // fix the overall text group position pgroup.attr('transform','translate('+dx+','+dy+')'); // then fix multiline text if(numLines>1) { tspans.attr({ x: p.attr('x'), y: p.attr('y') }); } }); }; // generalized Catmull-Rom splines, per // http://www.cemyuksel.com/research/catmullrom_param/catmullrom.pdf var CatmullRomExp = 0.5; drawing.smoothopen = function(pts,smoothness) { if(pts.length<3) { return 'M' + pts.join('L');} var path = 'M'+pts[0], tangents = [], i; for(i=1; i=maxSavedBBoxes) { d3.selectAll('[data-bb]').attr('data-bb', null); savedBBoxes = []; } // cache this bbox node.setAttribute('data-bb',savedBBoxes.length); savedBBoxes.push(bb); return Plotly.Lib.extendFlat({}, bb); }; /* * make a robust clipPath url from a local id * note! We'd better not be exporting from a page * with a or the svg will not be portable! */ drawing.setClipUrl = function(s, localId) { if(!localId) { s.attr('clip-path', null); return; } var url = '#' + localId, base = d3.select('base'); if(base.size() && base.attr('href')) url = window.location.href + url; s.attr('clip-path', 'url(' + url + ')'); }; },{"../../constants/xmlns_namespaces":338,"../../plotly":366,"../../traces/scatter/make_bubble_size_func":514,"../../traces/scatter/subtypes":520,"./symbol_defs":318,"d3":70,"fast-isnumeric":74}],318:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); /** Marker symbol definitions * users can specify markers either by number or name * add 100 (or '-open') and you get an open marker * open markers have no fill and use line color as the stroke color * add 200 (or '-dot') and you get a dot in the middle * add both and you get both */ module.exports = { circle: { n: 0, f: function(r) { var rs = d3.round(r,2); return 'M'+rs+',0A'+rs+','+rs+' 0 1,1 0,-'+rs+ 'A'+rs+','+rs+' 0 0,1 '+rs+',0Z'; } }, square: { n: 1, f: function(r) { var rs = d3.round(r,2); return 'M'+rs+','+rs+'H-'+rs+'V-'+rs+'H'+rs+'Z'; } }, diamond: { n: 2, f: function(r) { var rd = d3.round(r*1.3,2); return 'M'+rd+',0L0,'+rd+'L-'+rd+',0L0,-'+rd+'Z'; } }, cross: { n: 3, f: function(r) { var rc = d3.round(r*0.4,2), rc2 = d3.round(r*1.2,2); return 'M'+rc2+','+rc+'H'+rc+'V'+rc2+'H-'+rc+ 'V'+rc+'H-'+rc2+'V-'+rc+'H-'+rc+'V-'+rc2+ 'H'+rc+'V-'+rc+'H'+rc2+'Z'; } }, x: { n: 4, f: function(r) { var rx = d3.round(r*0.8/Math.sqrt(2),2), ne = 'l'+rx+','+rx, se = 'l'+rx+',-'+rx, sw = 'l-'+rx+',-'+rx, nw = 'l-'+rx+','+rx; return 'M0,'+rx+ne+se+sw+se+sw+nw+sw+nw+ne+nw+ne+'Z'; } }, 'triangle-up': { n: 5, f: function(r) { var rt = d3.round(r*2/Math.sqrt(3),2), r2 = d3.round(r/2,2), rs = d3.round(r,2); return 'M-'+rt+','+r2+'H'+rt+'L0,-'+rs+'Z'; } }, 'triangle-down': { n: 6, f: function(r) { var rt = d3.round(r*2/Math.sqrt(3),2), r2 = d3.round(r/2,2), rs = d3.round(r,2); return 'M-'+rt+',-'+r2+'H'+rt+'L0,'+rs+'Z'; } }, 'triangle-left': { n: 7, f: function(r) { var rt = d3.round(r*2/Math.sqrt(3),2), r2 = d3.round(r/2,2), rs = d3.round(r,2); return 'M'+r2+',-'+rt+'V'+rt+'L-'+rs+',0Z'; } }, 'triangle-right': { n: 8, f: function(r) { var rt = d3.round(r*2/Math.sqrt(3),2), r2 = d3.round(r/2,2), rs = d3.round(r,2); return 'M-'+r2+',-'+rt+'V'+rt+'L'+rs+',0Z'; } }, 'triangle-ne': { n: 9, f: function(r) { var r1 = d3.round(r*0.6,2), r2 = d3.round(r*1.2,2); return 'M-'+r2+',-'+r1+'H'+r1+'V'+r2+'Z'; } }, 'triangle-se': { n: 10, f: function(r) { var r1 = d3.round(r*0.6,2), r2 = d3.round(r*1.2,2); return 'M'+r1+',-'+r2+'V'+r1+'H-'+r2+'Z'; } }, 'triangle-sw': { n: 11, f: function(r) { var r1 = d3.round(r*0.6,2), r2 = d3.round(r*1.2,2); return 'M'+r2+','+r1+'H-'+r1+'V-'+r2+'Z'; } }, 'triangle-nw': { n: 12, f: function(r) { var r1 = d3.round(r*0.6,2), r2 = d3.round(r*1.2,2); return 'M-'+r1+','+r2+'V-'+r1+'H'+r2+'Z'; } }, pentagon: { n: 13, f: function(r) { var x1 = d3.round(r*0.951,2), x2 = d3.round(r*0.588,2), y0 = d3.round(-r,2), y1 = d3.round(r*-0.309,2), y2 = d3.round(r*0.809,2); return 'M'+x1+','+y1+'L'+x2+','+y2+'H-'+x2+ 'L-'+x1+','+y1+'L0,'+y0+'Z'; } }, hexagon: { n: 14, f: function(r) { var y0 = d3.round(r,2), y1 = d3.round(r/2,2), x = d3.round(r*Math.sqrt(3)/2,2); return 'M'+x+',-'+y1+'V'+y1+'L0,'+y0+ 'L-'+x+','+y1+'V-'+y1+'L0,-'+y0+'Z'; } }, hexagon2: { n: 15, f: function(r) { var x0 = d3.round(r,2), x1 = d3.round(r/2,2), y = d3.round(r*Math.sqrt(3)/2,2); return 'M-'+x1+','+y+'H'+x1+'L'+x0+ ',0L'+x1+',-'+y+'H-'+x1+'L-'+x0+',0Z'; } }, octagon: { n: 16, f: function(r) { var a = d3.round(r*0.924,2), b = d3.round(r*0.383,2); return 'M-'+b+',-'+a+'H'+b+'L'+a+',-'+b+'V'+b+ 'L'+b+','+a+'H-'+b+'L-'+a+','+b+'V-'+b+'Z'; } }, star: { n: 17, f: function(r) { var rs = r*1.4, x1 = d3.round(rs*0.225,2), x2 = d3.round(rs*0.951,2), x3 = d3.round(rs*0.363,2), x4 = d3.round(rs*0.588,2), y0 = d3.round(-rs,2), y1 = d3.round(rs*-0.309,2), y3 = d3.round(rs*0.118,2), y4 = d3.round(rs*0.809,2), y5 = d3.round(rs*0.382,2); return 'M'+x1+','+y1+'H'+x2+'L'+x3+','+y3+ 'L'+x4+','+y4+'L0,'+y5+'L-'+x4+','+y4+ 'L-'+x3+','+y3+'L-'+x2+','+y1+'H-'+x1+ 'L0,'+y0+'Z'; } }, hexagram: { n: 18, f: function(r) { var y = d3.round(r*0.66,2), x1 = d3.round(r*0.38,2), x2 = d3.round(r*0.76,2); return 'M-'+x2+',0l-'+x1+',-'+y+'h'+x2+ 'l'+x1+',-'+y+'l'+x1+','+y+'h'+x2+ 'l-'+x1+','+y+'l'+x1+','+y+'h-'+x2+ 'l-'+x1+','+y+'l-'+x1+',-'+y+'h-'+x2+'Z'; } }, 'star-triangle-up': { n: 19, f: function(r) { var x = d3.round(r*Math.sqrt(3)*0.8,2), y1 = d3.round(r*0.8,2), y2 = d3.round(r*1.6,2), rc = d3.round(r*4,2), aPart = 'A '+rc+','+rc+' 0 0 1 '; return 'M-'+x+','+y1+aPart+x+','+y1+ aPart+'0,-'+y2+aPart+'-'+x+','+y1+'Z'; } }, 'star-triangle-down': { n: 20, f: function(r) { var x = d3.round(r*Math.sqrt(3)*0.8,2), y1 = d3.round(r*0.8,2), y2 = d3.round(r*1.6,2), rc = d3.round(r*4,2), aPart = 'A '+rc+','+rc+' 0 0 1 '; return 'M'+x+',-'+y1+aPart+'-'+x+',-'+y1+ aPart+'0,'+y2+aPart+x+',-'+y1+'Z'; } }, 'star-square': { n: 21, f: function(r) { var rp = d3.round(r*1.1,2), rc = d3.round(r*2,2), aPart = 'A '+rc+','+rc+' 0 0 1 '; return 'M-'+rp+',-'+rp+aPart+'-'+rp+','+rp+ aPart+rp+','+rp+aPart+rp+',-'+rp+ aPart+'-'+rp+',-'+rp+'Z'; } }, 'star-diamond': { n: 22, f: function(r) { var rp = d3.round(r*1.4,2), rc = d3.round(r*1.9,2), aPart = 'A '+rc+','+rc+' 0 0 1 '; return 'M-'+rp+',0'+aPart+'0,'+rp+ aPart+rp+',0'+aPart+'0,-'+rp+ aPart+'-'+rp+',0'+'Z'; } }, 'diamond-tall': { n: 23, f: function(r) { var x = d3.round(r*0.7,2), y = d3.round(r*1.4,2); return 'M0,'+y+'L'+x+',0L0,-'+y+'L-'+x+',0Z'; } }, 'diamond-wide': { n: 24, f: function(r) { var x = d3.round(r*1.4,2), y = d3.round(r*0.7,2); return 'M0,'+y+'L'+x+',0L0,-'+y+'L-'+x+',0Z'; } }, hourglass: { n: 25, f: function(r) { var rs = d3.round(r,2); return 'M'+rs+','+rs+'H-'+rs+'L'+rs+',-'+rs+'H-'+rs+'Z'; }, noDot: true }, bowtie: { n: 26, f: function(r) { var rs = d3.round(r,2); return 'M'+rs+','+rs+'V-'+rs+'L-'+rs+','+rs+'V-'+rs+'Z'; }, noDot: true }, 'circle-cross': { n: 27, f: function(r) { var rs = d3.round(r,2); return 'M0,'+rs+'V-'+rs+'M'+rs+',0H-'+rs+ 'M'+rs+',0A'+rs+','+rs+' 0 1,1 0,-'+rs+ 'A'+rs+','+rs+' 0 0,1 '+rs+',0Z'; }, needLine: true, noDot: true }, 'circle-x': { n: 28, f: function(r) { var rs = d3.round(r,2), rc = d3.round(r/Math.sqrt(2),2); return 'M'+rc+','+rc+'L-'+rc+',-'+rc+ 'M'+rc+',-'+rc+'L-'+rc+','+rc+ 'M'+rs+',0A'+rs+','+rs+' 0 1,1 0,-'+rs+ 'A'+rs+','+rs+' 0 0,1 '+rs+',0Z'; }, needLine: true, noDot: true }, 'square-cross': { n: 29, f: function(r) { var rs = d3.round(r,2); return 'M0,'+rs+'V-'+rs+'M'+rs+',0H-'+rs+ 'M'+rs+','+rs+'H-'+rs+'V-'+rs+'H'+rs+'Z'; }, needLine: true, noDot: true }, 'square-x': { n: 30, f: function(r) { var rs = d3.round(r,2); return 'M'+rs+','+rs+'L-'+rs+',-'+rs+ 'M'+rs+',-'+rs+'L-'+rs+','+rs+ 'M'+rs+','+rs+'H-'+rs+'V-'+rs+'H'+rs+'Z'; }, needLine: true, noDot: true }, 'diamond-cross': { n: 31, f: function(r) { var rd = d3.round(r*1.3,2); return 'M'+rd+',0L0,'+rd+'L-'+rd+',0L0,-'+rd+'Z'+ 'M0,-'+rd+'V'+rd+'M-'+rd+',0H'+rd; }, needLine: true, noDot: true }, 'diamond-x': { n: 32, f: function(r) { var rd = d3.round(r*1.3,2), r2 = d3.round(r*0.65,2); return 'M'+rd+',0L0,'+rd+'L-'+rd+',0L0,-'+rd+'Z'+ 'M-'+r2+',-'+r2+'L'+r2+','+r2+ 'M-'+r2+','+r2+'L'+r2+',-'+r2; }, needLine: true, noDot: true }, 'cross-thin': { n: 33, f: function(r) { var rc = d3.round(r*1.4,2); return 'M0,'+rc+'V-'+rc+'M'+rc+',0H-'+rc; }, needLine: true, noDot: true }, 'x-thin': { n: 34, f: function(r) { var rx = d3.round(r,2); return 'M'+rx+','+rx+'L-'+rx+',-'+rx+ 'M'+rx+',-'+rx+'L-'+rx+','+rx; }, needLine: true, noDot: true }, asterisk: { n: 35, f: function(r) { var rc = d3.round(r*1.2,2); var rs = d3.round(r*0.85,2); return 'M0,'+rc+'V-'+rc+'M'+rc+',0H-'+rc+ 'M'+rs+','+rs+'L-'+rs+',-'+rs+ 'M'+rs+',-'+rs+'L-'+rs+','+rs; }, needLine: true, noDot: true }, hash: { n: 36, f: function(r) { var r1 = d3.round(r/2,2), r2 = d3.round(r,2); return 'M'+r1+','+r2+'V-'+r2+ 'm-'+r2+',0V'+r2+ 'M'+r2+','+r1+'H-'+r2+ 'm0,-'+r2+'H'+r2; }, needLine: true }, 'y-up': { n: 37, f: function(r) { var x = d3.round(r*1.2,2), y0 = d3.round(r*1.6,2), y1 = d3.round(r*0.8,2); return 'M-'+x+','+y1+'L0,0M'+x+','+y1+'L0,0M0,-'+y0+'L0,0'; }, needLine: true, noDot: true }, 'y-down': { n: 38, f: function(r) { var x = d3.round(r*1.2,2), y0 = d3.round(r*1.6,2), y1 = d3.round(r*0.8,2); return 'M-'+x+',-'+y1+'L0,0M'+x+',-'+y1+'L0,0M0,'+y0+'L0,0'; }, needLine: true, noDot: true }, 'y-left': { n: 39, f: function(r) { var y = d3.round(r*1.2,2), x0 = d3.round(r*1.6,2), x1 = d3.round(r*0.8,2); return 'M'+x1+','+y+'L0,0M'+x1+',-'+y+'L0,0M-'+x0+',0L0,0'; }, needLine: true, noDot: true }, 'y-right': { n: 40, f: function(r) { var y = d3.round(r*1.2,2), x0 = d3.round(r*1.6,2), x1 = d3.round(r*0.8,2); return 'M-'+x1+','+y+'L0,0M-'+x1+',-'+y+'L0,0M'+x0+',0L0,0'; }, needLine: true, noDot: true }, 'line-ew': { n: 41, f: function(r) { var rc = d3.round(r*1.4,2); return 'M'+rc+',0H-'+rc; }, needLine: true, noDot: true }, 'line-ns': { n: 42, f: function(r) { var rc = d3.round(r*1.4,2); return 'M0,'+rc+'V-'+rc; }, needLine: true, noDot: true }, 'line-ne': { n: 43, f: function(r) { var rx = d3.round(r,2); return 'M'+rx+',-'+rx+'L-'+rx+','+rx; }, needLine: true, noDot: true }, 'line-nw': { n: 44, f: function(r) { var rx = d3.round(r,2); return 'M'+rx+','+rx+'L-'+rx+',-'+rx; }, needLine: true, noDot: true } }; },{"d3":70}],319:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { visible: { valType: 'boolean', }, type: { valType: 'enumerated', values: ['percent', 'constant', 'sqrt', 'data'], }, symmetric: { valType: 'boolean', }, array: { valType: 'data_array', }, arrayminus: { valType: 'data_array', }, value: { valType: 'number', min: 0, dflt: 10, }, valueminus: { valType: 'number', min: 0, dflt: 10, }, traceref: { valType: 'integer', min: 0, dflt: 0, }, tracerefminus: { valType: 'integer', min: 0, dflt: 0, }, copy_ystyle: { valType: 'boolean', }, copy_zstyle: { valType: 'boolean', }, color: { valType: 'color', }, thickness: { valType: 'number', min: 0, dflt: 2, }, width: { valType: 'number', min: 0, }, _deprecated: { opacity: { valType: 'number', } } }; },{}],320:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Plots = require('../../plots/plots'); var Axes = require('../../plots/cartesian/axes'); var makeComputeError = require('./compute_error'); module.exports = function calc(gd) { var calcdata = gd.calcdata; for(var i = 0; i < calcdata.length; i++) { var calcTrace = calcdata[i], trace = calcTrace[0].trace; if(!Plots.traceIs(trace, 'errorBarsOK')) continue; var xa = Axes.getFromId(gd, trace.xaxis), ya = Axes.getFromId(gd, trace.yaxis); calcOneAxis(calcTrace, trace, xa, 'x'); calcOneAxis(calcTrace, trace, ya, 'y'); } }; function calcOneAxis(calcTrace, trace, axis, coord) { var opts = trace['error_' + coord] || {}, isVisible = (opts.visible && ['linear', 'log'].indexOf(axis.type) !== -1), vals = []; if(!isVisible) return; var computeError = makeComputeError(opts); for(var i = 0; i < calcTrace.length; i++) { var calcPt = calcTrace[i], calcCoord = calcPt[coord]; if(!isNumeric(axis.c2l(calcCoord))) continue; var errors = computeError(calcCoord, i); if(isNumeric(errors[0]) && isNumeric(errors[1])) { var shoe = calcPt[coord + 's'] = calcCoord - errors[0], hat = calcPt[coord + 'h'] = calcCoord + errors[1]; vals.push(shoe, hat); } } Axes.expand(axis, vals, {padded: true}); } },{"../../plots/cartesian/axes":369,"../../plots/plots":413,"./compute_error":321,"fast-isnumeric":74}],321:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /** * Error bar computing function generator * * N.B. The generated function does not clean the dataPt entries. Non-numeric * entries result in undefined error magnitudes. * * @param {object} opts error bar attributes * * @return {function} : * @param {numeric} dataPt data point from where to compute the error magnitude * @param {number} index index of dataPt in its corresponding data array * @return {array} * - error[0] : error magnitude in the negative direction * - error[1] : " " " " positive " */ module.exports = function makeComputeError(opts) { var type = opts.type, symmetric = opts.symmetric; if(type === 'data') { var array = opts.array, arrayminus = opts.arrayminus; if(symmetric || arrayminus === undefined) { return function computeError(dataPt, index) { var val = +(array[index]); return [val, val]; }; } else { return function computeError(dataPt, index) { return [+arrayminus[index], +array[index]]; }; } } else { var computeErrorValue = makeComputeErrorValue(type, opts.value), computeErrorValueMinus = makeComputeErrorValue(type, opts.valueminus); if(symmetric || opts.valueminus === undefined) { return function computeError(dataPt) { var val = computeErrorValue(dataPt); return [val, val]; }; } else { return function computeError(dataPt) { return [ computeErrorValueMinus(dataPt), computeErrorValue(dataPt) ]; }; } } }; /** * Compute error bar magnitude (for all types except data) * * @param {string} type error bar type * @param {numeric} value error bar value * * @return {function} : * @param {numeric} dataPt */ function makeComputeErrorValue(type, value) { if(type === 'percent') { return function(dataPt) { return Math.abs(dataPt * value / 100); }; } if(type === 'constant') { return function() { return Math.abs(value); }; } if(type === 'sqrt') { return function(dataPt) { return Math.sqrt(Math.abs(dataPt)); }; } } },{}],322:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Plots = require('../../plots/plots'); var Lib = require('../../lib'); var attributes = require('./attributes'); module.exports = function(traceIn, traceOut, defaultColor, opts) { var objName = 'error_' + opts.axis, containerOut = traceOut[objName] = {}, containerIn = traceIn[objName] || {}; function coerce(attr, dflt) { return Lib.coerce(containerIn, containerOut, attributes, attr, dflt); } var hasErrorBars = ( containerIn.array !== undefined || containerIn.value !== undefined || containerIn.type === 'sqrt' ); var visible = coerce('visible', hasErrorBars); if(visible === false) return; var type = coerce('type', 'array' in containerIn ? 'data' : 'percent'), symmetric = true; if(type !== 'sqrt') { symmetric = coerce('symmetric', !((type === 'data' ? 'arrayminus' : 'valueminus') in containerIn)); } if(type === 'data') { var array = coerce('array'); if(!array) containerOut.array = []; coerce('traceref'); if(!symmetric) { var arrayminus = coerce('arrayminus'); if(!arrayminus) containerOut.arrayminus = []; coerce('tracerefminus'); } } else if(type==='percent' || type==='constant') { coerce('value'); if(!symmetric) coerce('valueminus'); } var copyAttr = 'copy_'+opts.inherit+'style'; if(opts.inherit) { var inheritObj = traceOut['error_' + opts.inherit]; if((inheritObj||{}).visible) { coerce(copyAttr, !(containerIn.color || isNumeric(containerIn.thickness) || isNumeric(containerIn.width))); } } if(!opts.inherit || !containerOut[copyAttr]) { coerce('color', defaultColor); coerce('thickness'); coerce('width', Plots.traceIs(traceOut, 'gl3d') ? 0 : 4); } }; },{"../../lib":349,"../../plots/plots":413,"./attributes":319,"fast-isnumeric":74}],323:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var Color = require('../color'); var subTypes = require('../../traces/scatter/subtypes'); var errorBars = module.exports = {}; errorBars.attributes = require('./attributes'); errorBars.supplyDefaults = require('./defaults'); errorBars.calc = require('./calc'); errorBars.calcFromTrace = function(trace, layout) { var x = trace.x || [], y = trace.y, len = x.length || y.length; var calcdataMock = new Array(len); for(var i = 0; i < len; i++) { calcdataMock[i] = { x: x[i], y: y[i] }; } calcdataMock[0].trace = trace; errorBars.calc({ calcdata: [calcdataMock], _fullLayout: layout }); return calcdataMock; }; // the main drawing function for errorbars errorBars.plot = function(gd, plotinfo, cd) { // ___ <-- "errorhats" // | // | <-- "errorbars" // | // ___ <-- "errorshoes" var xa = plotinfo.x(), ya = plotinfo.y(); // first remove all existing errorbars // TODO: use enter/exit instead plotinfo.plot.select('.errorlayer').selectAll('g.errorbars').remove(); var coords; // draw the errorbars plotinfo.plot.select('.errorlayer').selectAll('g.errorbars') .data(cd) .enter().append('g') .attr('class','errorbars') .each(function(d) { var trace = d[0].trace, xObj = trace.error_x, yObj = trace.error_y, sparse = subTypes.hasMarkers(trace) && trace.marker.maxdisplayed>0; if(!yObj.visible && !xObj.visible) return; d3.select(this).selectAll('g') .data(Lib.identity) .enter().append('g') .each(function(d) { coords = errorcoords(d, xa, ya); var eb = d3.select(this), path; if(sparse && !d.vis) return; if(yObj.visible && isNumeric(coords.x) && isNumeric(coords.yh) && isNumeric(coords.ys)) { var yw = yObj.width; path = 'M'+(coords.x-yw)+','+coords.yh+'h'+(2*yw) + // hat 'm-'+yw+',0V'+coords.ys; // bar if(!coords.noYS) path += 'm-'+yw+',0h'+(2*yw); // shoe eb.append('path') .classed('yerror', true) .attr('d', path); } if(xObj.visible && isNumeric(coords.y) && isNumeric(coords.xh) && isNumeric(coords.xs)) { var xw = (xObj.copy_ystyle ? yObj : xObj).width; path = 'M'+coords.xh+','+(coords.y-xw)+'v'+(2*xw) + // hat 'm0,-'+xw+'H'+coords.xs; // bar if(!coords.noXS) path += 'm0,-'+xw+'v'+(2*xw); // shoe eb.append('path') .classed('xerror', true) .attr('d', path); } }); }); }; errorBars.style = function(gd) { d3.select(gd).selectAll('g.errorbars').each(function(d) { var eb = d3.select(this), trace = d[0].trace, yObj = trace.error_y||{}, xObj = trace.error_x||{}; eb.selectAll('g path.yerror') .style('stroke-width', yObj.thickness+'px') .call(Color.stroke, yObj.color); if(xObj.copy_ystyle) xObj = yObj; eb.selectAll('g path.xerror') .style('stroke-width', xObj.thickness+'px') .call(Color.stroke, xObj.color); }); }; function errorcoords(d, xa, ya) { // compute the coordinates of the error-bar objects var out = { x: xa.c2p(d.x), y: ya.c2p(d.y) }; // calculate the error bar size and hat and shoe locations if(d.yh!==undefined) { out.yh = ya.c2p(d.yh); out.ys = ya.c2p(d.ys); // if the shoes go off-scale (ie log scale, error bars past zero) // clip the bar and hide the shoes if(!isNumeric(out.ys)) { out.noYS = true; out.ys = ya.c2p(d.ys, true); } } if(d.xh!==undefined) { out.xh = xa.c2p(d.xh); out.xs = xa.c2p(d.xs); if(!isNumeric(out.xs)) { out.noXS = true; out.xs = xa.c2p(d.xs, true); } } return out; } errorBars.hoverInfo = function(calcPoint, trace, hoverPoint) { if(trace.error_y.visible) { hoverPoint.yerr = calcPoint.yh - calcPoint.y; if(!trace.error_y.symmetric) hoverPoint.yerrneg = calcPoint.y - calcPoint.ys; } if(trace.error_x.visible) { hoverPoint.xerr = calcPoint.xh - calcPoint.x; if(!trace.error_x.symmetric) hoverPoint.xerrneg = calcPoint.x - calcPoint.xs; } }; },{"../../lib":349,"../../traces/scatter/subtypes":520,"../color":299,"./attributes":319,"./calc":320,"./defaults":322,"d3":70,"fast-isnumeric":74}],324:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var fontAttrs = require('../../plots/font_attributes'); var colorAttrs = require('../color/attributes'); var extendFlat = require('../../lib/extend').extendFlat; module.exports = { bgcolor: { valType: 'color', }, bordercolor: { valType: 'color', dflt: colorAttrs.defaultLine, }, borderwidth: { valType: 'number', min: 0, dflt: 0, }, font: extendFlat({}, fontAttrs, { }), traceorder: { valType: 'flaglist', flags: ['reversed', 'grouped'], extras: ['normal'], }, tracegroupgap: { valType: 'number', min: 0, dflt: 10, }, x: { valType: 'number', min: -2, max: 3, dflt: 1.02, }, xanchor: { valType: 'enumerated', values: ['auto', 'left', 'center', 'right'], dflt: 'left', }, y: { valType: 'number', min: -2, max: 3, dflt: 1, }, yanchor: { valType: 'enumerated', values: ['auto', 'top', 'middle', 'bottom'], dflt: 'auto', } }; },{"../../lib/extend":345,"../../plots/font_attributes":383,"../color/attributes":298}],325:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { scrollBarWidth: 4, scrollBarHeight: 20, scrollBarColor: '#808BA4', scrollBarMargin: 4 }; },{}],326:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../../plotly'); var d3 = require('d3'); var Lib = require('../../lib'); var Plots = require('../../plots/plots'); var Fx = require('../../plots/cartesian/graph_interact'); var Color = require('../color'); var Drawing = require('../drawing'); var subTypes = require('../../traces/scatter/subtypes'); var styleOne = require('../../traces/pie/style_one'); var legend = module.exports = {}; var constants = require('./constants'); legend.layoutAttributes = require('./attributes'); legend.supplyLayoutDefaults = function(layoutIn, layoutOut, fullData) { var containerIn = layoutIn.legend || {}, containerOut = layoutOut.legend = {}; var visibleTraces = 0, defaultOrder = 'normal', trace; for(var i = 0; i < fullData.length; i++) { trace = fullData[i]; if(legendGetsTrace(trace)) { visibleTraces++; // always show the legend by default if there's a pie if(Plots.traceIs(trace, 'pie')) visibleTraces++; } if((Plots.traceIs(trace, 'bar') && layoutOut.barmode==='stack') || ['tonextx','tonexty'].indexOf(trace.fill)!==-1) { defaultOrder = isGrouped({traceorder: defaultOrder}) ? 'grouped+reversed' : 'reversed'; } if(trace.legendgroup !== undefined && trace.legendgroup !== '') { defaultOrder = isReversed({traceorder: defaultOrder}) ? 'reversed+grouped' : 'grouped'; } } function coerce(attr, dflt) { return Lib.coerce(containerIn, containerOut, legend.layoutAttributes, attr, dflt); } var showLegend = Lib.coerce(layoutIn, layoutOut, Plots.layoutAttributes, 'showlegend', visibleTraces > 1); if(showLegend === false) return; coerce('bgcolor', layoutOut.paper_bgcolor); coerce('bordercolor'); coerce('borderwidth'); Lib.coerceFont(coerce, 'font', layoutOut.font); coerce('traceorder', defaultOrder); if(isGrouped(layoutOut.legend)) coerce('tracegroupgap'); coerce('x'); coerce('xanchor'); coerce('y'); coerce('yanchor'); Lib.noneOrAll(containerIn, containerOut, ['x', 'y']); }; // ----------------------------------------------------- // styling functions for traces in legends. // same functions for styling traces in the popovers // ----------------------------------------------------- legend.lines = function(d) { var trace = d[0].trace, showFill = trace.visible && trace.fill && trace.fill!=='none', showLine = subTypes.hasLines(trace); var fill = d3.select(this).select('.legendfill').selectAll('path') .data(showFill ? [d] : []); fill.enter().append('path').classed('js-fill',true); fill.exit().remove(); fill.attr('d', 'M5,0h30v6h-30z') .call(Drawing.fillGroupStyle); var line = d3.select(this).select('.legendlines').selectAll('path') .data(showLine ? [d] : []); line.enter().append('path').classed('js-line',true) .attr('d', 'M5,0h30'); line.exit().remove(); line.call(Drawing.lineGroupStyle); }; legend.points = function(d) { var d0 = d[0], trace = d0.trace, showMarkers = subTypes.hasMarkers(trace), showText = subTypes.hasText(trace), showLines = subTypes.hasLines(trace); var dMod, tMod; // 'scatter3d' and 'scattergeo' don't use gd.calcdata yet; // use d0.trace to infer arrayOk attributes function boundVal(attrIn, arrayToValFn, bounds) { var valIn = Lib.nestedProperty(trace, attrIn).get(), valToBound = (Array.isArray(valIn) && arrayToValFn) ? arrayToValFn(valIn) : valIn; if(bounds) { if(valToBound < bounds[0]) return bounds[0]; else if(valToBound > bounds[1]) return bounds[1]; } return valToBound; } function pickFirst(array) { return array[0]; } // constrain text, markers, etc so they'll fit on the legend if(showMarkers || showText || showLines) { var dEdit = {}, tEdit = {}; if(showMarkers) { dEdit.mc = boundVal('marker.color', pickFirst); dEdit.mo = boundVal('marker.opacity', Lib.mean, [0.2, 1]); dEdit.ms = boundVal('marker.size', Lib.mean, [2, 16]); dEdit.mlc = boundVal('marker.line.color', pickFirst); dEdit.mlw = boundVal('marker.line.width', Lib.mean, [0, 5]); tEdit.marker = { sizeref: 1, sizemin: 1, sizemode: 'diameter' }; } if(showLines) { tEdit.line = { width: boundVal('line.width', pickFirst, [0, 10]) }; } if(showText) { dEdit.tx = 'Aa'; dEdit.tp = boundVal('textposition', pickFirst); dEdit.ts = 10; dEdit.tc = boundVal('textfont.color', pickFirst); dEdit.tf = boundVal('textfont.family', pickFirst); } dMod = [Lib.minExtend(d0, dEdit)]; tMod = Lib.minExtend(trace, tEdit); } var ptgroup = d3.select(this).select('g.legendpoints'); var pts = ptgroup.selectAll('path.scatterpts') .data(showMarkers ? dMod : []); pts.enter().append('path').classed('scatterpts', true) .attr('transform', 'translate(20,0)'); pts.exit().remove(); pts.call(Drawing.pointStyle, tMod); // 'mrc' is set in pointStyle and used in textPointStyle: // constrain it here if(showMarkers) dMod[0].mrc = 3; var txt = ptgroup.selectAll('g.pointtext') .data(showText ? dMod : []); txt.enter() .append('g').classed('pointtext',true) .append('text').attr('transform', 'translate(20,0)'); txt.exit().remove(); txt.selectAll('text').call(Drawing.textPointStyle, tMod); }; legend.bars = function(d) { var trace = d[0].trace, marker = trace.marker||{}, markerLine = marker.line||{}, barpath = d3.select(this).select('g.legendpoints') .selectAll('path.legendbar') .data(Plots.traceIs(trace, 'bar') ? [d] : []); barpath.enter().append('path').classed('legendbar',true) .attr('d','M6,6H-6V-6H6Z') .attr('transform','translate(20,0)'); barpath.exit().remove(); barpath.each(function(d) { var w = (d.mlw+1 || markerLine.width+1) - 1, p = d3.select(this); p.style('stroke-width',w+'px') .call(Color.fill, d.mc || marker.color); if(w) { p.call(Color.stroke, d.mlc || markerLine.color); } }); }; legend.boxes = function(d) { var trace = d[0].trace, pts = d3.select(this).select('g.legendpoints') .selectAll('path.legendbox') .data(Plots.traceIs(trace, 'box') && trace.visible ? [d] : []); pts.enter().append('path').classed('legendbox', true) // if we want the median bar, prepend M6,0H-6 .attr('d', 'M6,6H-6V-6H6Z') .attr('transform', 'translate(20,0)'); pts.exit().remove(); pts.each(function(d) { var w = (d.lw+1 || trace.line.width+1) - 1, p = d3.select(this); p.style('stroke-width', w+'px') .call(Color.fill, d.fc || trace.fillcolor); if(w) { p.call(Color.stroke, d.lc || trace.line.color); } }); }; legend.pie = function(d) { var trace = d[0].trace, pts = d3.select(this).select('g.legendpoints') .selectAll('path.legendpie') .data(Plots.traceIs(trace, 'pie') && trace.visible ? [d] : []); pts.enter().append('path').classed('legendpie', true) .attr('d', 'M6,6H-6V-6H6Z') .attr('transform', 'translate(20,0)'); pts.exit().remove(); if(pts.size()) pts.call(styleOne, d[0], trace); }; legend.style = function(s) { s.each(function(d) { var traceGroup = d3.select(this); var fill = traceGroup .selectAll('g.legendfill') .data([d]); fill.enter().append('g') .classed('legendfill',true); var line = traceGroup .selectAll('g.legendlines') .data([d]); line.enter().append('g') .classed('legendlines',true); var symbol = traceGroup .selectAll('g.legendsymbols') .data([d]); symbol.enter().append('g') .classed('legendsymbols',true); symbol.style('opacity', d[0].trace.opacity); symbol.selectAll('g.legendpoints') .data([d]) .enter().append('g') .classed('legendpoints',true); }) .each(legend.bars) .each(legend.boxes) .each(legend.pie) .each(legend.lines) .each(legend.points); }; legend.texts = function(context, td, d, i, traces) { var fullLayout = td._fullLayout, trace = d[0].trace, isPie = Plots.traceIs(trace, 'pie'), traceIndex = trace.index, name = isPie ? d[0].label : trace.name; var text = d3.select(context).selectAll('text.legendtext') .data([0]); text.enter().append('text').classed('legendtext', true); text.attr({ x: 40, y: 0, 'data-unformatted': name }) .style({ 'text-anchor': 'start', '-webkit-user-select': 'none', '-moz-user-select': 'none', '-ms-user-select': 'none', 'user-select': 'none' }) .call(Drawing.font, fullLayout.legend.font) .text(name); function textLayout(s) { Plotly.util.convertToTspans(s, function() { if(td.firstRender) legend.repositionLegend(td, traces); }); s.selectAll('tspan.line').attr({x: s.attr('x')}); } if(td._context.editable && !isPie) { text.call(Plotly.util.makeEditable) .call(textLayout) .on('edit', function(text) { this.attr({'data-unformatted': text}); this.text(text) .call(textLayout); if(!this.text()) text = ' \u0020\u0020 '; Plotly.restyle(td, 'name', text, traceIndex); }); } else text.call(textLayout); }; // ----------------------------------------------------- // legend drawing // ----------------------------------------------------- function legendGetsTrace(trace) { return trace.visible && Plots.traceIs(trace, 'showLegend'); } function isGrouped(legendLayout) { return (legendLayout.traceorder || '').indexOf('grouped') !== -1; } function isReversed(legendLayout) { return (legendLayout.traceorder || '').indexOf('reversed') !== -1; } legend.getLegendData = function(calcdata, opts) { // build an { legendgroup: [cd0, cd0], ... } object var lgroupToTraces = {}, lgroups = [], hasOneNonBlankGroup = false, slicesShown = {}, lgroupi = 0; var cd, cd0, trace, lgroup, i, j, labelj; function addOneItem(legendGroup, legendItem) { // each '' legend group is treated as a separate group if(legendGroup==='' || !isGrouped(opts)) { var uniqueGroup = '~~i' + lgroupi; // TODO: check this against fullData legendgroups? lgroups.push(uniqueGroup); lgroupToTraces[uniqueGroup] = [[legendItem]]; lgroupi++; } else if(lgroups.indexOf(legendGroup) === -1) { lgroups.push(legendGroup); hasOneNonBlankGroup = true; lgroupToTraces[legendGroup] = [[legendItem]]; } else lgroupToTraces[legendGroup].push([legendItem]); } for(i = 0; i < calcdata.length; i++) { cd = calcdata[i]; cd0 = cd[0]; trace = cd0.trace; lgroup = trace.legendgroup; if(!legendGetsTrace(trace) || !trace.showlegend) continue; if(Plots.traceIs(trace, 'pie')) { if(!slicesShown[lgroup]) slicesShown[lgroup] = {}; for(j = 0; j < cd.length; j++) { labelj = cd[j].label; if(!slicesShown[lgroup][labelj]) { addOneItem(lgroup, { label: labelj, color: cd[j].color, i: cd[j].i, trace: trace }); slicesShown[lgroup][labelj] = true; } } } else addOneItem(lgroup, cd0); } // won't draw a legend in this case if(!lgroups.length) return []; // rearrange lgroupToTraces into a d3-friendly array of arrays var lgroupsLength = lgroups.length, ltraces, legendData; if(hasOneNonBlankGroup && isGrouped(opts)) { legendData = new Array(lgroupsLength); for(i = 0; i < lgroupsLength; i++) { ltraces = lgroupToTraces[lgroups[i]]; legendData[i] = isReversed(opts) ? ltraces.reverse() : ltraces; } } else { // collapse all groups into one if all groups are blank legendData = [new Array(lgroupsLength)]; for(i = 0; i < lgroupsLength; i++) { ltraces = lgroupToTraces[lgroups[i]][0]; legendData[0][isReversed(opts) ? lgroupsLength-i-1 : i] = ltraces; } lgroupsLength = 1; } // needed in repositionLegend opts._lgroupsLength = lgroupsLength; return legendData; }; legend.draw = function(td) { var fullLayout = td._fullLayout; if(!fullLayout._infolayer || !td.calcdata) return; var opts = fullLayout.legend, legendData = fullLayout.showlegend && legend.getLegendData(td.calcdata, opts), hiddenSlices = fullLayout.hiddenlabels || []; if(!fullLayout.showlegend || !legendData.length) { fullLayout._infolayer.selectAll('.legend').remove(); Plots.autoMargin(td, 'legend'); return; } if(typeof td.firstRender === 'undefined') td.firstRender = true; else if(td.firstRender) td.firstRender = false; var legendsvg = fullLayout._infolayer.selectAll('svg.legend') .data([0]); legendsvg.enter().append('svg') .attr({ 'class': 'legend', 'pointer-events': 'all' }); var bg = legendsvg.selectAll('rect.bg') .data([0]); bg.enter().append('rect') .attr({ 'class': 'bg', 'shape-rendering': 'crispEdges' }) .call(Color.stroke, opts.bordercolor) .call(Color.fill, opts.bgcolor) .style('stroke-width', opts.borderwidth + 'px'); var scrollBox = legendsvg.selectAll('g.scrollbox') .data([0]); scrollBox.enter().append('g') .attr('class', 'scrollbox'); scrollBox.exit().remove(); var scrollBar = legendsvg.selectAll('rect.scrollbar') .data([0]); scrollBar.enter().append('rect') .attr({ 'class': 'scrollbar', 'rx': 20, 'ry': 2, 'width': 0, 'height': 0 }) .call(Color.fill, '#808BA4'); var groups = scrollBox.selectAll('g.groups') .data(legendData); groups.enter().append('g') .attr('class', 'groups'); groups.exit().remove(); if(isGrouped(opts)) { groups.attr('transform', function(d, i) { return 'translate(0,' + i * opts.tracegroupgap + ')'; }); } var traces = groups.selectAll('g.traces') .data(Lib.identity); traces.enter().append('g').attr('class', 'traces'); traces.exit().remove(); traces.call(legend.style) .style('opacity', function(d) { var trace = d[0].trace; if(Plots.traceIs(trace, 'pie')) { return hiddenSlices.indexOf(d[0].label) !== -1 ? 0.5 : 1; } else { return trace.visible === 'legendonly' ? 0.5 : 1; } }) .each(function(d, i) { legend.texts(this, td, d, i, traces); var traceToggle = d3.select(this).selectAll('rect') .data([0]); traceToggle.enter().append('rect') .classed('legendtoggle', true) .style('cursor', 'pointer') .attr('pointer-events', 'all') .call(Color.fill, 'rgba(0,0,0,0)'); traceToggle.on('click', function() { if(td._dragged) return; var fullData = td._fullData, trace = d[0].trace, legendgroup = trace.legendgroup, traceIndicesInGroup = [], tracei, newVisible; if(Plots.traceIs(trace, 'pie')) { var thisLabel = d[0].label, newHiddenSlices = hiddenSlices.slice(), thisLabelIndex = newHiddenSlices.indexOf(thisLabel); if(thisLabelIndex === -1) newHiddenSlices.push(thisLabel); else newHiddenSlices.splice(thisLabelIndex, 1); Plotly.relayout(td, 'hiddenlabels', newHiddenSlices); } else { if(legendgroup === '') { traceIndicesInGroup = [trace.index]; } else { for(var i = 0; i < fullData.length; i++) { tracei = fullData[i]; if(tracei.legendgroup === legendgroup) { traceIndicesInGroup.push(tracei.index); } } } newVisible = trace.visible === true ? 'legendonly' : true; Plotly.restyle(td, 'visible', newVisible, traceIndicesInGroup); } }); }); // Position and size the legend legend.repositionLegend(td, traces); // Scroll section must be executed after repositionLegend. // It requires the legend width, height, x and y to position the scrollbox // and these values are mutated in repositionLegend. var gs = fullLayout._size, lx = gs.l + gs.w * opts.x, ly = gs.t + gs.h * (1-opts.y); if(opts.xanchor === 'right' || (opts.xanchor === 'auto' && opts.x >= 2 / 3)) { lx -= opts.width; } else if(opts.xanchor === 'center' || (opts.xanchor === 'auto' && opts.x > 1 / 3)) { lx -= opts.width / 2; } if(opts.yanchor === 'bottom' || (opts.yanchor === 'auto' && opts.y <= 1 / 3)) { ly -= opts.height; } else if(opts.yanchor === 'middle' || (opts.yanchor === 'auto' && opts.y < 2 / 3)) { ly -= opts.height / 2; } // Deal with scrolling var plotHeight = fullLayout.height - fullLayout.margin.b, scrollheight = Math.min(plotHeight - ly, opts.height), scrollPosition = scrollBox.attr('data-scroll') ? scrollBox.attr('data-scroll') : 0; scrollBox.attr('transform', 'translate(0, ' + scrollPosition + ')'); bg.attr({ width: opts.width - 2 * opts.borderwidth, height: scrollheight - 2 * opts.borderwidth, x: opts.borderwidth, y: opts.borderwidth }); legendsvg.call(Drawing.setRect, lx, ly, opts.width, scrollheight); // If scrollbar should be shown. if(td.firstRender && opts.height - scrollheight > 0 && !td._context.staticPlot) { bg.attr({ width: opts.width - 2 * opts.borderwidth + constants.scrollBarWidth }); legendsvg.node().addEventListener('wheel', function(e) { e.preventDefault(); scrollHandler(e.deltaY / 20); }); scrollBar.node().addEventListener('mousedown', function(e) { e.preventDefault(); function mMove(e) { if(e.buttons === 1) { scrollHandler(e.movementY); } } function mUp() { scrollBar.node().removeEventListener('mousemove', mMove); window.removeEventListener('mouseup', mUp); } window.addEventListener('mousemove', mMove); window.addEventListener('mouseup', mUp); }); // Move scrollbar to starting position on the first render scrollBar.call( Drawing.setRect, opts.width - (constants.scrollBarWidth + constants.scrollBarMargin), constants.scrollBarMargin, constants.scrollBarWidth, constants.scrollBarHeight ); } function scrollHandler(delta) { var scrollBarTrack = scrollheight - constants.scrollBarHeight - 2 * constants.scrollBarMargin, translateY = scrollBox.attr('data-scroll'), scrollBoxY = Lib.constrain(translateY - delta, Math.min(scrollheight - opts.height, 0), 0), scrollBarY = -scrollBoxY / (opts.height - scrollheight) * scrollBarTrack + constants.scrollBarMargin; scrollBox.attr('data-scroll', scrollBoxY); scrollBox.attr('transform', 'translate(0, ' + scrollBoxY + ')'); scrollBar.call( Drawing.setRect, opts.width - (constants.scrollBarWidth + constants.scrollBarMargin), scrollBarY, constants.scrollBarWidth, constants.scrollBarHeight ); } if(td._context.editable) { var xf, yf, x0, y0, lw, lh; Fx.dragElement({ element: legendsvg.node(), prepFn: function() { x0 = Number(legendsvg.attr('x')); y0 = Number(legendsvg.attr('y')); lw = Number(legendsvg.attr('width')); lh = Number(legendsvg.attr('height')); Fx.setCursor(legendsvg); }, moveFn: function(dx, dy) { var gs = td._fullLayout._size; legendsvg.call(Drawing.setPosition, x0+dx, y0+dy); xf = Fx.dragAlign(x0+dx, lw, gs.l, gs.l+gs.w, opts.xanchor); yf = Fx.dragAlign(y0+dy+lh, -lh, gs.t+gs.h, gs.t, opts.yanchor); var csr = Fx.dragCursors(xf, yf, opts.xanchor, opts.yanchor); Fx.setCursor(legendsvg, csr); }, doneFn: function(dragged) { Fx.setCursor(legendsvg); if(dragged && xf !== undefined && yf !== undefined) { Plotly.relayout(td, {'legend.x': xf, 'legend.y': yf}); } } }); } }; legend.repositionLegend = function(td, traces) { var fullLayout = td._fullLayout, gs = fullLayout._size, opts = fullLayout.legend, borderwidth = opts.borderwidth; opts.width = 0, opts.height = 0, traces.each(function(d) { var trace = d[0].trace, g = d3.select(this), bg = g.selectAll('.legendtoggle'), text = g.selectAll('.legendtext'), tspans = g.selectAll('.legendtext>tspan'), tHeight = opts.font.size * 1.3, tLines = tspans[0].length || 1, tWidth = text.node() && Drawing.bBox(text.node()).width, mathjaxGroup = g.select('g[class*=math-group]'), textY, tHeightFull; if(!trace.showlegend) { g.remove(); return; } if(mathjaxGroup.node()) { var mathjaxBB = Drawing.bBox(mathjaxGroup.node()); tHeight = mathjaxBB.height; tWidth = mathjaxBB.width; mathjaxGroup.attr('transform','translate(0,' + (tHeight / 4) + ')'); } else { // approximation to height offset to center the font // to avoid getBoundingClientRect textY = tHeight * (0.3 + (1-tLines) / 2); text.attr('y',textY); tspans.attr('y',textY); } tHeightFull = Math.max(tHeight*tLines, 16) + 3; g.attr('transform', 'translate(' + borderwidth + ',' + (5 + borderwidth + opts.height + tHeightFull / 2) + ')' ); bg.attr({x: 0, y: -tHeightFull / 2, height: tHeightFull}); opts.height += tHeightFull; opts.width = Math.max(opts.width, tWidth || 0); }); opts.width += 45 + borderwidth * 2; opts.height += 10 + borderwidth * 2; if(isGrouped(opts)) opts.height += (opts._lgroupsLength-1) * opts.tracegroupgap; traces.selectAll('.legendtoggle') .attr('width', (td._context.editable ? 0 : opts.width) + 40); // now position the legend. for both x,y the positions are recorded as // fractions of the plot area (left, bottom = 0,0). Outside the plot // area is allowed but position will be clipped to the page. // values <1/3 align the low side at that fraction, 1/3-2/3 align the // center at that fraction, >2/3 align the right at that fraction var lx = gs.l + gs.w * opts.x, ly = gs.t + gs.h * (1-opts.y); var xanchor = 'left'; if(opts.xanchor === 'right' || (opts.xanchor === 'auto' && opts.x >= 2 / 3)) { lx -= opts.width; xanchor = 'right'; } else if(opts.xanchor === 'center' || (opts.xanchor === 'auto' && opts.x > 1 / 3)) { lx -= opts.width / 2; xanchor = 'center'; } var yanchor = 'top'; if(opts.yanchor === 'bottom' || (opts.yanchor === 'auto' && opts.y <= 1 / 3)) { ly -= opts.height; yanchor = 'bottom'; } else if(opts.yanchor === 'middle' || (opts.yanchor === 'auto' && opts.y < 2 / 3)) { ly -= opts.height / 2; yanchor = 'middle'; } // make sure we're only getting full pixels opts.width = Math.ceil(opts.width); opts.height = Math.ceil(opts.height); lx = Math.round(lx); ly = Math.round(ly); // lastly check if the margin auto-expand has changed Plots.autoMargin(td,'legend',{ x: opts.x, y: opts.y, l: opts.width * ({right: 1, center: 0.5}[xanchor] || 0), r: opts.width * ({left: 1, center: 0.5}[xanchor] || 0), b: opts.height * ({top: 1, middle: 0.5}[yanchor] || 0), t: opts.height * ({bottom: 1, middle: 0.5}[yanchor] || 0) }); }; },{"../../lib":349,"../../plotly":366,"../../plots/cartesian/graph_interact":374,"../../plots/plots":413,"../../traces/pie/style_one":500,"../../traces/scatter/subtypes":520,"../color":299,"../drawing":317,"./attributes":324,"./constants":325,"d3":70}],327:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../../plotly'); var Lib = require('../../lib'); var Snapshot = require('../../snapshot'); var Icons = require('../../../build/ploticon'); var modeBarButtons = module.exports = {}; /** * ModeBar buttons configuration * * @param {string} name * name / id of the buttons (for tracking) * @param {string} title * text that appears while hovering over the button, * enter null, false or '' for no hover text * @param {string} icon * svg icon object associated with the button * can be linked to Plotly.Icons to use the default plotly icons * @param {string} [gravity] * icon positioning * @param {function} click * click handler associated with the button, a function of * 'gd' (the main graph object) and * 'ev' (the event object) * @param {string} [attr] * attribute associated with button, * use this with 'val' to keep track of the state * @param {*} [val] * initial 'attr' value, can be a function of gd * @param {boolean} [toggle] * is the button a toggle button? */ modeBarButtons.toImage = { name: 'toImage', title: 'Download plot as a png', icon: Icons.camera, click: function(gd) { var format = 'png'; if(Lib.isIE()) { Lib.notifier('Snapshotting is unavailable in Internet Explorer. ' + 'Consider exporting your images using the Plotly Cloud', 'long'); return; } if(gd._snapshotInProgress) { Lib.notifier('Snapshotting is still in progress - please hold', 'long'); return; } gd._snapshotInProgress = true; Lib.notifier('Taking snapshot - this may take a few seconds', 'long'); var ev = Snapshot.toImage(gd, {format: format}); var filename = gd.fn || 'newplot'; filename += '.' + format; ev.once('success', function(result) { gd._snapshotInProgress = false; var downloadLink = document.createElement('a'); downloadLink.href = result; downloadLink.download = filename; // only supported by FF and Chrome document.body.appendChild(downloadLink); downloadLink.click(); document.body.removeChild(downloadLink); ev.clean(); }); ev.once('error', function(err) { gd._snapshotInProgress = false; Lib.notifier('Sorry there was a problem downloading your ' + format, 'long'); console.error(err); ev.clean(); }); } }; modeBarButtons.sendDataToCloud = { name: 'sendDataToCloud', title: 'Save and edit plot in cloud', icon: Icons.disk, click: function(gd) { Plotly.Plots.sendDataToCloud(gd); } }; modeBarButtons.zoom2d = { name: 'zoom2d', title: 'Zoom', attr: 'dragmode', val: 'zoom', icon: Icons.zoombox, click: handleCartesian }; modeBarButtons.pan2d = { name: 'pan2d', title: 'Pan', attr: 'dragmode', val: 'pan', icon: Icons.pan, click: handleCartesian }; modeBarButtons.select2d = { name: 'select2d', title: 'Box Select', attr: 'dragmode', val: 'select', icon: Icons.selectbox, click: handleCartesian }; modeBarButtons.lasso2d = { name: 'lasso2d', title: 'Lasso Select', attr: 'dragmode', val: 'lasso', icon: Icons.lasso, click: handleCartesian }; modeBarButtons.zoomIn2d = { name: 'zoomIn2d', title: 'Zoom in', attr: 'zoom', val: 'in', icon: Icons.zoom_plus, click: handleCartesian }; modeBarButtons.zoomOut2d = { name: 'zoomOut2d', title: 'Zoom out', attr: 'zoom', val: 'out', icon: Icons.zoom_minus, click: handleCartesian }; modeBarButtons.autoScale2d = { name: 'autoScale2d', title: 'Autoscale', attr: 'zoom', val: 'auto', icon: Icons.autoscale, click: handleCartesian }; modeBarButtons.resetScale2d = { name: 'resetScale2d', title: 'Reset axes', attr: 'zoom', val: 'reset', icon: Icons.home, click: handleCartesian }; modeBarButtons.hoverClosestCartesian = { name: 'hoverClosestCartesian', title: 'Show closest data on hover', attr: 'hovermode', val: 'closest', icon: Icons.tooltip_basic, gravity: 'ne', click: handleCartesian }; modeBarButtons.hoverCompareCartesian = { name: 'hoverCompareCartesian', title: 'Compare data on hover', attr: 'hovermode', val: function(gd) { return gd._fullLayout._isHoriz ? 'y' : 'x'; }, icon: Icons.tooltip_compare, gravity: 'ne', click: handleCartesian }; var DRAGCURSORS = { pan: 'move', zoom: 'crosshair', select: 'crosshair', lasso: 'crosshair' }; function handleCartesian(gd, ev) { var button = ev.currentTarget, astr = button.getAttribute('data-attr'), val = button.getAttribute('data-val') || true, fullLayout = gd._fullLayout, aobj = {}; if(astr === 'zoom') { var mag = (val === 'in') ? 0.5 : 2, r0 = (1 + mag) / 2, r1 = (1 - mag) / 2, axList = Plotly.Axes.list(gd, null, true); var ax, axName, initialRange; for(var i = 0; i < axList.length; i++) { ax = axList[i]; if(!ax.fixedrange) { axName = ax._name; if(val === 'auto') aobj[axName + '.autorange'] = true; else if(val === 'reset') { if(ax._rangeInitial === undefined) { aobj[axName + '.autorange'] = true; } else aobj[axName + '.range'] = ax._rangeInitial.slice(); } else { initialRange = ax.range; aobj[axName + '.range'] = [ r0 * initialRange[0] + r1 * initialRange[1], r0 * initialRange[1] + r1 * initialRange[0] ]; } } } } else { // if ALL traces have orientation 'h', 'hovermode': 'x' otherwise: 'y' if(astr==='hovermode' && (val==='x' || val==='y')) { val = fullLayout._isHoriz ? 'y' : 'x'; button.setAttribute('data-val', val); } aobj[astr] = val; } Plotly.relayout(gd, aobj).then(function() { if(astr === 'dragmode') { if(fullLayout._hasCartesian) { Plotly.Fx.setCursor( fullLayout._paper.select('.nsewdrag'), DRAGCURSORS[val] ); } Plotly.Fx.supplyLayoutDefaults(gd.layout, fullLayout, gd._fullData); Plotly.Fx.init(gd); } }); } modeBarButtons.zoom3d = { name: 'zoom3d', title: 'Zoom', attr: 'scene.dragmode', val: 'zoom', icon: Icons.zoombox, click: handleDrag3d }; modeBarButtons.pan3d = { name: 'pan3d', title: 'Pan', attr: 'scene.dragmode', val: 'pan', icon: Icons.pan, click: handleDrag3d }; modeBarButtons.orbitRotation = { name: 'orbitRotation', title: 'orbital rotation', attr: 'scene.dragmode', val: 'orbit', icon: Icons['3d_rotate'], click: handleDrag3d }; modeBarButtons.tableRotation = { name: 'tableRotation', title: 'turntable rotation', attr: 'scene.dragmode', val: 'turntable', icon: Icons['z-axis'], click: handleDrag3d }; function handleDrag3d(gd, ev) { var button = ev.currentTarget, attr = button.getAttribute('data-attr'), val = button.getAttribute('data-val') || true, fullLayout = gd._fullLayout, sceneIds = Plotly.Plots.getSubplotIds(fullLayout, 'gl3d'), layoutUpdate = {}; var parts = attr.split('.'); for(var i = 0; i < sceneIds.length; i++) { layoutUpdate[sceneIds[i] + '.' + parts[1]] = val; } Plotly.relayout(gd, layoutUpdate); } modeBarButtons.resetCameraDefault3d = { name: 'resetCameraDefault3d', title: 'Reset camera to default', attr: 'resetDefault', icon: Icons.home, click: handleCamera3d }; modeBarButtons.resetCameraLastSave3d = { name: 'resetCameraLastSave3d', title: 'Reset camera to last save', attr: 'resetLastSave', icon: Icons.movie, click: handleCamera3d }; function handleCamera3d(gd, ev) { var button = ev.currentTarget, attr = button.getAttribute('data-attr'), fullLayout = gd._fullLayout, sceneIds = Plotly.Plots.getSubplotIds(fullLayout, 'gl3d'); for(var i = 0; i < sceneIds.length; i++) { var sceneId = sceneIds[i], fullSceneLayout = fullLayout[sceneId], scene = fullSceneLayout._scene; if(attr === 'resetDefault') scene.setCameraToDefault(); else if(attr === 'resetLastSave') { scene.setCamera(fullSceneLayout.camera); } } } modeBarButtons.hoverClosest3d = { name: 'hoverClosest3d', title: 'Toggle show closest data on hover', attr: 'hovermode', val: null, toggle: true, icon: Icons.tooltip_basic, gravity: 'ne', click: handleHover3d }; function handleHover3d(gd, ev) { var button = ev.currentTarget, val = button._previousVal || false, layout = gd.layout, fullLayout = gd._fullLayout, sceneIds = Plotly.Plots.getSubplotIds(fullLayout, 'gl3d'); var axes = ['xaxis', 'yaxis', 'zaxis'], spikeAttrs = ['showspikes', 'spikesides', 'spikethickness', 'spikecolor']; // initialize 'current spike' object to be stored in the DOM var currentSpikes = {}, axisSpikes = {}, layoutUpdate = {}; if(val) { layoutUpdate = Lib.extendDeep(layout, val); button._previousVal = null; } else { layoutUpdate = { 'allaxes.showspikes': false }; for(var i = 0; i < sceneIds.length; i++) { var sceneId = sceneIds[i], sceneLayout = fullLayout[sceneId], sceneSpikes = currentSpikes[sceneId] = {}; sceneSpikes.hovermode = sceneLayout.hovermode; layoutUpdate[sceneId + '.hovermode'] = false; // copy all the current spike attrs for(var j = 0; j < 3; j++) { var axis = axes[j]; axisSpikes = sceneSpikes[axis] = {}; for(var k = 0; k < spikeAttrs.length; k++) { var spikeAttr = spikeAttrs[k]; axisSpikes[spikeAttr] = sceneLayout[axis][spikeAttr]; } } } button._previousVal = Lib.extendDeep({}, currentSpikes); } Plotly.relayout(gd, layoutUpdate); } modeBarButtons.zoomInGeo = { name: 'zoomInGeo', title: 'Zoom in', attr: 'zoom', val: 'in', icon: Icons.zoom_plus, click: handleGeo }; modeBarButtons.zoomOutGeo = { name: 'zoomOutGeo', title: 'Zoom out', attr: 'zoom', val: 'out', icon: Icons.zoom_minus, click: handleGeo }; modeBarButtons.resetGeo = { name: 'resetGeo', title: 'Reset', attr: 'reset', val: null, icon: Icons.autoscale, click: handleGeo }; modeBarButtons.hoverClosestGeo = { name: 'hoverClosestGeo', title: 'Toggle show closest data on hover', attr: 'hovermode', val: null, toggle: true, icon: Icons.tooltip_basic, gravity: 'ne', click: toggleHover }; function handleGeo(gd, ev) { var button = ev.currentTarget, attr = button.getAttribute('data-attr'), val = button.getAttribute('data-val') || true, fullLayout = gd._fullLayout, geoIds = Plotly.Plots.getSubplotIds(fullLayout, 'geo'); for(var i = 0; i < geoIds.length; i++) { var geo = fullLayout[geoIds[i]]._geo; if(attr === 'zoom') { var scale = geo.projection.scale(); var newScale = (val === 'in') ? 2 * scale : 0.5 * scale; geo.projection.scale(newScale); geo.zoom.scale(newScale); geo.render(); } else if(attr === 'reset') geo.zoomReset(); } } modeBarButtons.hoverClosestGl2d = { name: 'hoverClosestGl2d', title: 'Toggle show closest data on hover', attr: 'hovermode', val: null, toggle: true, icon: Icons.tooltip_basic, gravity: 'ne', click: toggleHover }; modeBarButtons.hoverClosestPie = { name: 'hoverClosestPie', title: 'Toggle show closest data on hover', attr: 'hovermode', val: 'closest', icon: Icons.tooltip_basic, gravity: 'ne', click: toggleHover }; function toggleHover(gd) { var fullLayout = gd._fullLayout; var onHoverVal; if(fullLayout._hasCartesian) { onHoverVal = fullLayout._isHoriz ? 'y' : 'x'; } else onHoverVal = 'closest'; var newHover = gd._fullLayout.hovermode ? false : onHoverVal; Plotly.relayout(gd, 'hovermode', newHover); } // buttons when more then one plot types are present modeBarButtons.toggleHover = { name: 'toggleHover', title: 'Toggle show closest data on hover', attr: 'hovermode', val: null, toggle: true, icon: Icons.tooltip_basic, gravity: 'ne', click: function(gd, ev) { toggleHover(gd); // the 3d hovermode update must come // last so that layout.hovermode update does not // override scene?.hovermode?.layout. handleHover3d(gd, ev); } }; modeBarButtons.resetViews = { name: 'resetViews', title: 'Reset views', icon: Icons.home, click: function(gd, ev) { var button = ev.currentTarget; button.setAttribute('data-attr', 'zoom'); button.setAttribute('data-val', 'reset'); handleCartesian(gd, ev); button.setAttribute('data-attr', 'resetLastSave'); handleCamera3d(gd, ev); // N.B handleCamera3d also triggers a replot for // geo subplots. } }; },{"../../../build/ploticon":2,"../../lib":349,"../../plotly":366,"../../snapshot":420}],328:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Lib = require('../../lib'); var Icons = require('../../../build/ploticon'); /** * UI controller for interactive plots * @Class * @Param {object} opts * @Param {object} opts.buttons nested arrays of grouped buttons config objects * @Param {object} opts.container container div to append modeBar * @Param {object} opts.graphInfo primary plot object containing data and layout */ function ModeBar(opts) { this.container = opts.container; this.element = document.createElement('div'); this.update(opts.graphInfo, opts.buttons); this.container.appendChild(this.element); } var proto = ModeBar.prototype; /** * Update modeBar (buttons and logo) * * @param {object} graphInfo primary plot object containing data and layout * @param {array of arrays} buttons nested arrays of grouped buttons to initialize * */ proto.update = function(graphInfo, buttons) { this.graphInfo = graphInfo; var context = this.graphInfo._context; if(context.displayModeBar === 'hover') { this.element.className = 'modebar modebar--hover'; } else this.element.className = 'modebar'; // if buttons or logo have changed, redraw modebar interior var needsNewButtons = !this.hasButtons(buttons), needsNewLogo = (this.hasLogo !== context.displaylogo); if(needsNewButtons || needsNewLogo) { this.removeAllButtons(); this.updateButtons(buttons); if(context.displaylogo) { this.element.appendChild(this.getLogo()); this.hasLogo = true; } } this.updateActiveButton(); }; proto.updateButtons = function(buttons) { var _this = this; this.buttons = buttons; this.buttonElements = []; this.buttonsNames = []; this.buttons.forEach(function(buttonGroup) { var group = _this.createGroup(); buttonGroup.forEach(function(buttonConfig) { var buttonName = buttonConfig.name; if(!buttonName) { throw new Error('must provide button \'name\' in button config'); } if(_this.buttonsNames.indexOf(buttonName) !== -1) { throw new Error('button name \'' + buttonName + '\' is taken'); } _this.buttonsNames.push(buttonName); var button = _this.createButton(buttonConfig); _this.buttonElements.push(button); group.appendChild(button); }); _this.element.appendChild(group); }); }; /** * Empty div for containing a group of buttons * @Return {HTMLelement} */ proto.createGroup = function() { var group = document.createElement('div'); group.className = 'modebar-group'; return group; }; /** * Create a new button div and set constant and configurable attributes * @Param {object} config (see ./buttons.js for more info) * @Return {HTMLelement} */ proto.createButton = function(config) { var _this = this, button = document.createElement('a'); button.setAttribute('rel', 'tooltip'); button.className = 'modebar-btn'; var title = config.title; if(title === undefined) title = config.name; if(title || title === 0) button.setAttribute('data-title', title); if(config.attr !== undefined) button.setAttribute('data-attr', config.attr); var val = config.val; if(val !== undefined) { if(typeof val === 'function') val = val(this.graphInfo); button.setAttribute('data-val', val); } var click = config.click; if(typeof click !== 'function') { throw new Error('must provide button \'click\' function in button config'); } else { button.addEventListener('click', function(ev) { config.click(_this.graphInfo, ev); // only needed for 'hoverClosestGeo' which does not call relayout _this.updateActiveButton(ev.currentTarget); }); } button.setAttribute('data-toggle', config.toggle || false); if(config.toggle) button.classList.add('active'); button.appendChild(this.createIcon(config.icon || Icons.question)); button.setAttribute('data-gravity', config.gravity || 'n'); return button; }; /** * Add an icon to a button * @Param {object} thisIcon * @Param {number} thisIcon.width * @Param {string} thisIcon.path * @Return {HTMLelement} */ proto.createIcon = function(thisIcon) { var iconHeight = thisIcon.ascent - thisIcon.descent, svgNS = 'http://www.w3.org/2000/svg', icon = document.createElementNS(svgNS, 'svg'), path = document.createElementNS(svgNS, 'path'); icon.setAttribute('height', '1em'); icon.setAttribute('width', (thisIcon.width / iconHeight) + 'em'); icon.setAttribute('viewBox', [0, 0, thisIcon.width, iconHeight].join(' ')); path.setAttribute('d', thisIcon.path); path.setAttribute('transform', 'matrix(1 0 0 -1 0 ' + thisIcon.ascent + ')'); icon.appendChild(path); return icon; }; /** * Updates active button with attribute specified in layout * @Param {object} graphInfo plot object containing data and layout * @Return {HTMLelement} */ proto.updateActiveButton = function(buttonClicked) { var fullLayout = this.graphInfo._fullLayout, dataAttrClicked = (buttonClicked !== undefined) ? buttonClicked.getAttribute('data-attr') : null; this.buttonElements.forEach(function(button) { var thisval = button.getAttribute('data-val') || true, dataAttr = button.getAttribute('data-attr'), isToggleButton = (button.getAttribute('data-toggle') === 'true'), button3 = d3.select(button); // Use 'data-toggle' and 'buttonClicked' to toggle buttons // that have no one-to-one equivalent in fullLayout if(isToggleButton) { if(dataAttr === dataAttrClicked) { button3.classed('active', !button3.classed('active')); } } else { var val = (dataAttr === null) ? dataAttr : Lib.nestedProperty(fullLayout, dataAttr).get(); button3.classed('active', val === thisval); } }); }; /** * Check if modeBar is configured as button configuration argument * * @Param {object} buttons 2d array of grouped button config objects * @Return {boolean} */ proto.hasButtons = function(buttons) { var currentButtons = this.buttons; if(!currentButtons) return false; if(buttons.length !== currentButtons.length) return false; for(var i = 0; i < buttons.length; ++i) { if(buttons[i].length !== currentButtons[i].length) return false; for(var j = 0; j < buttons[i].length; j++) { if(buttons[i][j].name !== currentButtons[i][j].name) return false; } } return true; }; /** * @return {HTMLDivElement} The logo image wrapped in a group */ proto.getLogo = function() { var group = this.createGroup(), a = document.createElement('a'); a.href = 'https://plot.ly/'; a.target = '_blank'; a.setAttribute('data-title', 'Produced with Plotly'); a.className = 'modebar-btn plotlyjsicon modebar-btn--logo'; a.appendChild(this.createIcon(Icons.plotlylogo)); group.appendChild(a); return group; }; proto.removeAllButtons = function() { while(this.element.firstChild) { this.element.removeChild(this.element.firstChild); } this.hasLogo = false; }; proto.destroy = function() { Lib.removeElement(this.container.querySelector('.modebar')); }; function createModeBar(gd, buttons) { var fullLayout = gd._fullLayout; var modeBar = new ModeBar({ graphInfo: gd, container: fullLayout._paperdiv.node(), buttons: buttons }); if(fullLayout._privateplot) { d3.select(modeBar.element).append('span') .classed('badge-private float--left', true) .text('PRIVATE'); } return modeBar; } module.exports = createModeBar; },{"../../../build/ploticon":2,"../../lib":349,"d3":70}],329:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../../plotly'); var scatterSubTypes = require('../../traces/scatter/subtypes'); var createModeBar = require('./'); var modeBarButtons = require('./buttons'); /** * ModeBar wrapper around 'create' and 'update', * chooses buttons to pass to ModeBar constructor based on * plot type and plot config. * * @param {object} gd main plot object * */ module.exports = function manageModeBar(gd) { var fullLayout = gd._fullLayout, context = gd._context, modeBar = fullLayout._modeBar; if(!context.displayModeBar) { if(modeBar) { modeBar.destroy(); delete fullLayout._modeBar; } return; } if(!Array.isArray(context.modeBarButtonsToRemove)) { throw new Error([ '*modeBarButtonsToRemove* configuration options', 'must be an array.' ].join(' ')); } if(!Array.isArray(context.modeBarButtonsToAdd)) { throw new Error([ '*modeBarButtonsToAdd* configuration options', 'must be an array.' ].join(' ')); } var customButtons = context.modeBarButtons; var buttonGroups; if(Array.isArray(customButtons) && customButtons.length) { buttonGroups = fillCustomButton(customButtons); } else { buttonGroups = getButtonGroups( gd, context.modeBarButtonsToRemove, context.modeBarButtonsToAdd ); } if(modeBar) modeBar.update(gd, buttonGroups); else fullLayout._modeBar = createModeBar(gd, buttonGroups); }; // logic behind which buttons are displayed by default function getButtonGroups(gd, buttonsToRemove, buttonsToAdd) { var fullLayout = gd._fullLayout, fullData = gd._fullData; var hasCartesian = fullLayout._hasCartesian, hasGL3D = fullLayout._hasGL3D, hasGeo = fullLayout._hasGeo, hasPie = fullLayout._hasPie, hasGL2D = fullLayout._hasGL2D; var groups = []; function addGroup(newGroup) { var out = []; for(var i = 0; i < newGroup.length; i++) { var button = newGroup[i]; if(buttonsToRemove.indexOf(button) !== -1) continue; out.push(modeBarButtons[button]); } groups.push(out); } // buttons common to all plot types addGroup(['toImage', 'sendDataToCloud']); // graphs with more than one plot types get 'union buttons' // which reset the view or toggle hover labels across all subplots. if((hasCartesian || hasGL2D || hasPie) + hasGeo + hasGL3D > 1) { addGroup(['resetViews', 'toggleHover']); return appendButtonsToGroups(groups, buttonsToAdd); } if(hasGL3D) { addGroup(['zoom3d', 'pan3d', 'orbitRotation', 'tableRotation']); addGroup(['resetCameraDefault3d', 'resetCameraLastSave3d']); addGroup(['hoverClosest3d']); } if(hasGeo) { addGroup(['zoomInGeo', 'zoomOutGeo', 'resetGeo']); addGroup(['hoverClosestGeo']); } var allAxesFixed = areAllAxesFixed(fullLayout), dragModeGroup = []; if((hasCartesian || hasGL2D) && !allAxesFixed) { dragModeGroup = ['zoom2d', 'pan2d']; } if(hasCartesian && isSelectable(fullData)) { dragModeGroup.push('select2d'); dragModeGroup.push('lasso2d'); } if(dragModeGroup.length) addGroup(dragModeGroup); if((hasCartesian || hasGL2D) && !allAxesFixed) { addGroup(['zoomIn2d', 'zoomOut2d', 'autoScale2d', 'resetScale2d']); } if(hasCartesian && hasPie) { addGroup(['toggleHover']); } else if(hasGL2D) { addGroup(['hoverClosestGl2d']); } else if(hasCartesian) { addGroup(['hoverClosestCartesian', 'hoverCompareCartesian']); } else if(hasPie) { addGroup(['hoverClosestPie']); } return appendButtonsToGroups(groups, buttonsToAdd); } function areAllAxesFixed(fullLayout) { var axList = Plotly.Axes.list({_fullLayout: fullLayout}, null, true); var allFixed = true; for(var i = 0; i < axList.length; i++) { if(!axList[i].fixedrange) { allFixed = false; break; } } return allFixed; } // look for traces that support selection // to be updated as we add more selectPoints handlers function isSelectable(fullData) { var selectable = false; for(var i = 0; i < fullData.length; i++) { if(selectable) break; var trace = fullData[i]; if(!trace._module || !trace._module.selectPoints) continue; if(trace.type === 'scatter') { if(scatterSubTypes.hasMarkers(trace) || scatterSubTypes.hasText(trace)) { selectable = true; } } // assume that in general if the trace module has selectPoints, // then it's selectable. Scatter is an exception to this because it must // have markers or text, not just be a scatter type. else selectable = true; } return selectable; } function appendButtonsToGroups(groups, buttons) { if(buttons.length) { if(Array.isArray(buttons[0])) { for(var i = 0; i < buttons.length; i++) { groups.push(buttons[i]); } } else groups.push(buttons); } return groups; } // fill in custom buttons referring to default mode bar buttons function fillCustomButton(customButtons) { for(var i = 0; i < customButtons.length; i++) { var buttonGroup = customButtons[i]; for(var j = 0; j < buttonGroup.length; j++) { var button = buttonGroup[j]; if(typeof button === 'string') { if(modeBarButtons[button] !== undefined) { customButtons[i][j] = modeBarButtons[button]; } else { throw new Error([ '*modeBarButtons* configuration options', 'invalid button name' ].join(' ')); } } } } return customButtons; } },{"../../plotly":366,"../../traces/scatter/subtypes":520,"./":328,"./buttons":327}],330:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var annAttrs = require('../annotations/attributes'); var scatterAttrs = require('../../traces/scatter/attributes'); var extendFlat = require('../../lib/extend').extendFlat; var scatterLineAttrs = scatterAttrs.line; module.exports = { _isLinkedToArray: true, type: { valType: 'enumerated', values: ['circle', 'rect', 'path', 'line'], }, xref: extendFlat({}, annAttrs.xref, { }), x0: { valType: 'any', }, x1: { valType: 'any', }, yref: extendFlat({}, annAttrs.yref, { }), y0: { valType: 'any', }, y1: { valType: 'any', }, path: { valType: 'string', }, opacity: { valType: 'number', min: 0, max: 1, dflt: 1, }, line: { color: scatterLineAttrs.color, width: scatterLineAttrs.width, dash: scatterLineAttrs.dash, }, fillcolor: { valType: 'color', dflt: 'rgba(0,0,0,0)', } }; },{"../../lib/extend":345,"../../traces/scatter/attributes":502,"../annotations/attributes":296}],331:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../../plotly'); var isNumeric = require('fast-isnumeric'); var shapes = module.exports = {}; shapes.layoutAttributes = require('./attributes'); shapes.supplyLayoutDefaults = function(layoutIn, layoutOut) { var containerIn = layoutIn.shapes || [], containerOut = layoutOut.shapes = []; for(var i = 0; i < containerIn.length; i++) { containerOut.push(handleShapeDefaults(containerIn[i] || {}, layoutOut)); } }; function handleShapeDefaults(shapeIn, fullLayout) { var shapeOut = {}; function coerce(attr, dflt) { return Plotly.Lib.coerce(shapeIn, shapeOut, shapes.layoutAttributes, attr, dflt); } coerce('opacity'); coerce('fillcolor'); coerce('line.color'); coerce('line.width'); coerce('line.dash'); var dfltType = shapeIn.path ? 'path' : 'rect', shapeType = coerce('type', dfltType); // positioning var axLetters = ['x','y']; for(var i = 0; i < 2; i++) { var axLetter = axLetters[i], tdMock = {_fullLayout: fullLayout}; // xref, yref var axRef = Plotly.Axes.coerceRef(shapeIn, shapeOut, tdMock, axLetter); if(shapeType !== 'path') { var dflt0 = 0.25, dflt1 = 0.75; if(axRef !== 'paper') { var ax = Plotly.Axes.getFromId(tdMock, axRef), convertFn = linearToData(ax); dflt0 = convertFn(ax.range[0] + dflt0 * (ax.range[1] - ax.range[0])); dflt1 = convertFn(ax.range[0] + dflt1 * (ax.range[1] - ax.range[0])); } // x0, x1 (and y0, y1) coerce(axLetter + '0', dflt0); coerce(axLetter + '1', dflt1); } } if(shapeType === 'path') { coerce('path'); } else { Plotly.Lib.noneOrAll(shapeIn, shapeOut, ['x0', 'x1', 'y0', 'y1']); } return shapeOut; } // special position conversion functions... category axis positions can't be // specified by their data values, because they don't make a continuous mapping. // so these have to be specified in terms of the category serial numbers, // but can take fractional values. Other axis types we specify position based on // the actual data values. // TODO: this should really be part of axes, but for now it's only used here. // eventually annotations and axis ranges will use this too. // what should we do, invent a new letter for "data except if it's category"? function dataToLinear(ax) { return ax.type === 'category' ? ax.c2l : ax.d2l; } function linearToData(ax) { return ax.type === 'category' ? ax.l2c : ax.l2d; } shapes.drawAll = function(gd) { var fullLayout = gd._fullLayout; fullLayout._shapelayer.selectAll('path').remove(); for(var i = 0; i < fullLayout.shapes.length; i++) { shapes.draw(gd, i); } // may need to resurrect this if we put text (LaTeX) in shapes // return Plotly.Plots.previousPromises(gd); }; shapes.add = function(gd) { var nextShape = gd._fullLayout.shapes.length; Plotly.relayout(gd, 'shapes['+nextShape+']', 'add'); }; // ----------------------------------------------------- // make or edit an annotation on the graph // ----------------------------------------------------- // shapes are stored in gd.layout.shapes, an array of objects // index can point to one item in this array, // or non-numeric to simply add a new one // or -1 to modify all existing // opt can be the full options object, or one key (to be set to value) // or undefined to simply redraw // if opt is blank, val can be 'add' or a full options object to add a new // annotation at that point in the array, or 'remove' to delete this one shapes.draw = function(gd, index, opt, value) { var layout = gd.layout, fullLayout = gd._fullLayout, i; // TODO: abstract out these drawAll, add, and remove blocks for shapes and annotations if(!isNumeric(index) || index===-1) { // no index provided - we're operating on ALL shapes if(!index && Array.isArray(value)) { // a whole annotation array is passed in // (as in, redo of delete all) layout.shapes = value; shapes.supplyLayoutDefaults(layout, fullLayout); shapes.drawAll(gd); return; } else if(value==='remove') { // delete all delete layout.shapes; fullLayout.shapes = []; shapes.drawAll(gd); return; } else if(opt && value!=='add') { // make the same change to all shapes for(i = 0; i < fullLayout.shapes.length; i++) { shapes.draw(gd, i, opt, value); } return; } else { // add a new empty annotation index = fullLayout.shapes.length; fullLayout.shapes.push({}); } } if(!opt && value) { if(value==='remove') { fullLayout._shapelayer.selectAll('[data-index="'+index+'"]') .remove(); fullLayout.shapes.splice(index,1); layout.shapes.splice(index,1); for(i=index; iindex; i--) { fullLayout._shapelayer .selectAll('[data-index="'+(i-1)+'"]') .attr('data-index',String(i)); shapes.draw(gd,i); } } } // remove the existing shape if there is one fullLayout._shapelayer.selectAll('[data-index="'+index+'"]').remove(); // remember a few things about what was already there, var optionsIn = layout.shapes[index]; // (from annos...) not sure how we're getting here... but C12 is seeing a bug // where we fail here when they add/remove annotations // TODO: clean this up and remove it. if(!optionsIn) return; var oldRef = {xref: optionsIn.xref, yref: optionsIn.yref}; // alter the input shape as requested var optionsEdit = {}; if(typeof opt === 'string' && opt) optionsEdit[opt] = value; else if(Plotly.Lib.isPlainObject(opt)) optionsEdit = opt; var optionKeys = Object.keys(optionsEdit); for(i = 0; i < optionsEdit.length; i++) { var k = optionKeys[i]; Plotly.Lib.nestedProperty(optionsIn, k).set(optionsEdit[k]); } var posAttrs = ['x0', 'x1', 'y0', 'y1']; for(i = 0; i < 4; i++) { var posAttr = posAttrs[i]; // if we don't have an explicit position already, // don't set one just because we're changing references // or axis type. // the defaults will be consistent most of the time anyway, // except in log/linear changes if(optionsEdit[posAttr]!==undefined || optionsIn[posAttr]===undefined) { continue; } var axLetter = posAttr.charAt(0), axOld = Plotly.Axes.getFromId(gd, Plotly.Axes.coerceRef(oldRef, {}, gd, axLetter)), axNew = Plotly.Axes.getFromId(gd, Plotly.Axes.coerceRef(optionsIn, {}, gd, axLetter)), position = optionsIn[posAttr], linearizedPosition; if(optionsEdit[axLetter + 'ref']!==undefined) { // first convert to fraction of the axis if(axOld) { linearizedPosition = dataToLinear(axOld)(position); position = (linearizedPosition - axOld.range[0]) / (axOld.range[1] - axOld.range[0]); } else { position = (position - axNew.domain[0]) / (axNew.domain[1] - axNew.domain[0]); } if(axNew) { // then convert to new data coordinates at the same fraction linearizedPosition = axNew.range[0] + position * (axNew.range[1] - axNew.range[0]); position = linearToData(axNew)(linearizedPosition); } else { // or scale to the whole plot position = axOld.domain[0] + position * (axOld.domain[1] - axOld.domain[0]); } } optionsIn[posAttr] = position; } var options = handleShapeDefaults(optionsIn, fullLayout); fullLayout.shapes[index] = options; var attrs = { 'data-index': String(index), 'fill-rule': 'evenodd', d: shapePath(gd, options) }, clipAxes = (options.xref + options.yref).replace(/paper/g, ''); var lineColor = options.line.width ? options.line.color : 'rgba(0,0,0,0)'; var path = fullLayout._shapelayer.append('path') .attr(attrs) .style('opacity', options.opacity) .call(Plotly.Color.stroke, lineColor) .call(Plotly.Color.fill, options.fillcolor) .call(Plotly.Drawing.dashLine, options.line.dash, options.line.width); if(clipAxes) path.call(Plotly.Drawing.setClipUrl, 'clip' + fullLayout._uid + clipAxes); }; function decodeDate(convertToPx) { return function(v) { return convertToPx(v.replace('_', ' ')); }; } function shapePath(gd, options) { var type = options.type, xa = Plotly.Axes.getFromId(gd, options.xref), ya = Plotly.Axes.getFromId(gd, options.yref), gs = gd._fullLayout._size, x2l, x2p, y2l, y2p; if(xa) { x2l = dataToLinear(xa); x2p = function(v) { return xa._offset + xa.l2p(x2l(v, true)); }; } else { x2p = function(v) { return gs.l + gs.w * v; }; } if(ya) { y2l = dataToLinear(ya); y2p = function(v) { return ya._offset + ya.l2p(y2l(v, true)); }; } else { y2p = function(v) { return gs.t + gs.h * (1 - v); }; } if(type==='path') { if(xa && xa.type==='date') x2p = decodeDate(x2p); if(ya && ya.type==='date') y2p = decodeDate(y2p); return shapes.convertPath(options.path, x2p, y2p); } var x0 = x2p(options.x0), x1 = x2p(options.x1), y0 = y2p(options.y0), y1 = y2p(options.y1); if(type==='line') return 'M'+x0+','+y0+'L'+x1+','+y1; if(type==='rect') return 'M'+x0+','+y0+'H'+x1+'V'+y1+'H'+x0+'Z'; // circle var cx = (x0 + x1) / 2, cy = (y0 + y1) / 2, rx = Math.abs(cx - x0), ry = Math.abs(cy - y0), rArc = 'A' + rx + ',' + ry, rightPt = (cx + rx) + ',' + cy, topPt = cx + ',' + (cy - ry); return 'M' + rightPt + rArc + ' 0 1,1 ' + topPt + rArc + ' 0 0,1 ' + rightPt + 'Z'; } var segmentRE = /[MLHVQCTSZ][^MLHVQCTSZ]*/g, paramRE = /[^\s,]+/g, // which numbers in each path segment are x (or y) values // drawn is which param is a drawn point, as opposed to a // control point (which doesn't count toward autorange. // TODO: this means curved paths could extend beyond the // autorange bounds. This is a bit tricky to get right // unless we revert to bounding boxes, but perhaps there's // a calculation we could do...) paramIsX = { M: {0: true, drawn: 0}, L: {0: true, drawn: 0}, H: {0: true, drawn: 0}, V: {}, Q: {0: true, 2: true, drawn: 2}, C: {0: true, 2: true, 4: true, drawn: 4}, T: {0: true, drawn: 0}, S: {0: true, 2: true, drawn: 2}, // A: {0: true, 5: true}, Z: {} }, paramIsY = { M: {1: true, drawn: 1}, L: {1: true, drawn: 1}, H: {}, V: {0: true, drawn: 0}, Q: {1: true, 3: true, drawn: 3}, C: {1: true, 3: true, 5: true, drawn: 5}, T: {1: true, drawn: 1}, S: {1: true, 3: true, drawn: 5}, // A: {1: true, 6: true}, Z: {} }, numParams = { M: 2, L: 2, H: 1, V: 1, Q: 4, C: 6, T: 2, S: 4, // A: 7, Z: 0 }; shapes.convertPath = function(pathIn, x2p, y2p) { // convert an SVG path string from data units to pixels return pathIn.replace(segmentRE, function(segment) { var paramNumber = 0, segmentType = segment.charAt(0), xParams = paramIsX[segmentType], yParams = paramIsY[segmentType], nParams = numParams[segmentType]; var paramString = segment.substr(1).replace(paramRE, function(param) { if(xParams[paramNumber]) param = x2p(param); else if(yParams[paramNumber]) param = y2p(param); paramNumber++; if(paramNumber > nParams) param = 'X'; return param; }); if(paramNumber > nParams) { paramString = paramString.replace(/[\s,]*X.*/, ''); console.log('ignoring extra params in segment ' + segment); } return segmentType + paramString; }); }; shapes.calcAutorange = function(gd) { var fullLayout = gd._fullLayout, shapeList = fullLayout.shapes, i, shape, ppad, ax, bounds; if(!shapeList.length || !gd._fullData.length) return; for(i = 0; i < shapeList.length; i++) { shape = shapeList[i]; ppad = shape.line.width / 2; if(shape.xref !== 'paper') { ax = Plotly.Axes.getFromId(gd, shape.xref); bounds = shapeBounds(ax, shape.x0, shape.x1, shape.path, paramIsX); if(bounds) Plotly.Axes.expand(ax, bounds, {ppad: ppad}); } if(shape.yref !== 'paper') { ax = Plotly.Axes.getFromId(gd, shape.yref); bounds = shapeBounds(ax, shape.y0, shape.y1, shape.path, paramIsY); if(bounds) Plotly.Axes.expand(ax, bounds, {ppad: ppad}); } } }; function shapeBounds(ax, v0, v1, path, paramsToUse) { var convertVal = (ax.type==='category') ? Number : ax.d2c; if(v0 !== undefined) return [convertVal(v0), convertVal(v1)]; if(!path) return; var min = Infinity, max = -Infinity, segments = path.match(segmentRE), i, segment, drawnParam, params, val; if(ax.type==='date') convertVal = decodeDate(convertVal); for(i = 0; i < segments.length; i++) { segment = segments[i]; drawnParam = paramsToUse[segment.charAt(0)].drawn; if(drawnParam === undefined) continue; params = segments[i].substr(1).match(paramRE); if(!params || params.length < drawnParam) continue; val = convertVal(params[drawnParam]); if(val < min) min = val; if(val > max) max = val; } if(max >= min) return [min, max]; } },{"../../plotly":366,"./attributes":330,"fast-isnumeric":74}],332:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var isNumeric = require('fast-isnumeric'); var Plotly = require('../../plotly'); var Plots = require('../../plots/plots'); var Lib = require('../../lib'); var Drawing = require('../drawing'); var Color = require('../color'); var svgTextUtils = require('../../lib/svg_text_utils'); var axisIds = require('../../plots/cartesian/axis_ids'); var Titles = module.exports = {}; /** * Titles - (re)draw titles on the axes and plot: * title can be 'xtitle', 'ytitle', 'gtitle' */ Titles.draw = function(gd, title) { var fullLayout = gd._fullLayout, gs = fullLayout._size, axletter = title.charAt(0), colorbar = (title.substr(1, 2) === 'cb'); var cbnum, cont, options; if(colorbar) { var uid = title.substr(3).replace('title', ''); gd._fullData.some(function(trace, i) { if(trace.uid === uid) { cbnum = i; cont = gd.calcdata[i][0].t.cb.axis; return true; } }); } else cont = fullLayout[axisIds.id2name(title.replace('title', ''))] || fullLayout; var prop = (cont === fullLayout) ? 'title' : cont._name+'.title', name = colorbar ? 'colorscale' : ((cont._id || axletter).toUpperCase()+' axis'), font = cont.titlefont.family, fontSize = cont.titlefont.size, fontColor = cont.titlefont.color, x, y, transform = '', xa, ya, avoid = { selection: d3.select(gd).selectAll('g.'+cont._id+'tick'), side: cont.side }, // multiples of fontsize to offset label from axis offsetBase = colorbar ? 0 : 1.5, avoidTransform; // find the transform applied to the parents of the avoid selection // which doesn't get picked up by Drawing.bBox if(colorbar) { avoid.offsetLeft = gs.l; avoid.offsetTop = gs.t; } else if(avoid.selection.size()) { avoidTransform = d3.select(avoid.selection.node().parentNode) .attr('transform') .match(/translate\(([-\.\d]+),([-\.\d]+)\)/); if(avoidTransform) { avoid.offsetLeft = +avoidTransform[1]; avoid.offsetTop = +avoidTransform[2]; } } if(colorbar && cont.titleside) { // argh, we only make it here if the title is on top or bottom, // not right x = gs.l + cont.titlex * gs.w; y = gs.t + (1 - cont.titley) * gs.h + ((cont.titleside === 'top') ? 3 + fontSize * 0.75 : - 3 - fontSize * 0.25); options = {x: x, y: y, 'text-anchor': 'start'}; avoid = {}; // convertToTspans rotates any 'y...' by 90 degrees... // TODO: need a better solution than this hack title = 'h' + title; } else if(axletter === 'x') { xa = cont; ya = (xa.anchor === 'free') ? {_offset: gs.t + (1 - (xa.position || 0)) * gs.h, _length: 0} : axisIds.getFromId(gd, xa.anchor); x = xa._offset + xa._length / 2; y = ya._offset + ((xa.side === 'top') ? -10 - fontSize*(offsetBase + (xa.showticklabels ? 1 : 0)) : ya._length + 10 + fontSize*(offsetBase + (xa.showticklabels ? 1.5 : 0.5))); options = {x: x, y: y, 'text-anchor': 'middle'}; if(!avoid.side) avoid.side = 'bottom'; } else if(axletter === 'y') { ya = cont; xa = (ya.anchor === 'free') ? {_offset: gs.l + (ya.position || 0) * gs.w, _length: 0} : axisIds.getFromId(gd, ya.anchor); y = ya._offset + ya._length / 2; x = xa._offset + ((ya.side === 'right') ? xa._length + 10 + fontSize*(offsetBase + (ya.showticklabels ? 1 : 0.5)) : -10 - fontSize*(offsetBase + (ya.showticklabels ? 0.5 : 0))); options = {x: x, y: y, 'text-anchor': 'middle'}; transform = {rotate: '-90', offset: 0}; if(!avoid.side) avoid.side = 'left'; } else { // plot title name = 'Plot'; fontSize = fullLayout.titlefont.size; x = fullLayout.width / 2; y = fullLayout._size.t / 2; options = {x: x, y: y, 'text-anchor': 'middle'}; avoid = {}; } var opacity = 1, isplaceholder = false, txt = cont.title.trim(); if(txt === '') opacity = 0; if(txt.match(/Click to enter .+ title/)) { opacity = 0.2; isplaceholder = true; } var group; if(colorbar) { group = d3.select(gd) .selectAll('.' + cont._id.substr(1) + ' .cbtitle'); // this class-to-rotate thing with convertToTspans is // getting hackier and hackier... delete groups with the // wrong class var otherClass = title.charAt(0) === 'h' ? title.substr(1) : ('h' + title); group.selectAll('.' + otherClass + ',.' + otherClass + '-math-group') .remove(); } else { group = fullLayout._infolayer.selectAll('.g-' + title) .data([0]); group.enter().append('g') .classed('g-' + title, true); } var el = group.selectAll('text') .data([0]); el.enter().append('text'); el.text(txt) // this is hacky, but convertToTspans uses the class // to determine whether to rotate mathJax... // so we need to clear out any old class and put the // correct one (only relevant for colorbars, at least // for now) - ie don't use .classed .attr('class', title); function titleLayout(titleEl) { Lib.syncOrAsync([drawTitle,scootTitle], titleEl); } function drawTitle(titleEl) { titleEl.attr('transform', transform ? 'rotate(' + [transform.rotate, options.x, options.y] + ') translate(0, ' + transform.offset + ')' : null); titleEl.style({ 'font-family': font, 'font-size': d3.round(fontSize,2) + 'px', fill: Color.rgb(fontColor), opacity: opacity * Color.opacity(fontColor), 'font-weight': Plots.fontWeight }) .attr(options) .call(svgTextUtils.convertToTspans) .attr(options); titleEl.selectAll('tspan.line') .attr(options); return Plots.previousPromises(gd); } function scootTitle(titleElIn) { var titleGroup = d3.select(titleElIn.node().parentNode); if(avoid && avoid.selection && avoid.side && txt) { titleGroup.attr('transform', null); // move toward avoid.side (= left, right, top, bottom) if needed // can include pad (pixels, default 2) var shift = 0, backside = { left: 'right', right: 'left', top: 'bottom', bottom: 'top' }[avoid.side], shiftSign = (['left','top'].indexOf(avoid.side) !== -1) ? -1 : 1, pad = isNumeric(avoid.pad) ? avoid.pad : 2, titlebb = Drawing.bBox(titleGroup.node()), paperbb = { left: 0, top: 0, right: fullLayout.width, bottom: fullLayout.height }, maxshift = colorbar ? fullLayout.width: (paperbb[avoid.side]-titlebb[avoid.side]) * ((avoid.side === 'left' || avoid.side === 'top') ? -1 : 1); // Prevent the title going off the paper if(maxshift < 0) shift = maxshift; else { // so we don't have to offset each avoided element, // give the title the opposite offset titlebb.left -= avoid.offsetLeft; titlebb.right -= avoid.offsetLeft; titlebb.top -= avoid.offsetTop; titlebb.bottom -= avoid.offsetTop; // iterate over a set of elements (avoid.selection) // to avoid collisions with avoid.selection.each(function() { var avoidbb = Drawing.bBox(this); if(Lib.bBoxIntersect(titlebb, avoidbb, pad)) { shift = Math.max(shift, shiftSign * ( avoidbb[avoid.side] - titlebb[backside]) + pad); } }); shift = Math.min(maxshift, shift); } if(shift > 0 || maxshift < 0) { var shiftTemplate = { left: [-shift, 0], right: [shift, 0], top: [0, -shift], bottom: [0, shift] }[avoid.side]; titleGroup.attr('transform', 'translate(' + shiftTemplate + ')'); } } } el.attr({'data-unformatted': txt}) .call(titleLayout); var placeholderText = 'Click to enter ' + name.replace(/\d+/, '') + ' title'; function setPlaceholder() { opacity = 0; isplaceholder = true; txt = placeholderText; fullLayout._infolayer.select('.' + title) .attr({'data-unformatted': txt}) .text(txt) .on('mouseover.opacity', function() { d3.select(this).transition() .duration(100).style('opacity', 1); }) .on('mouseout.opacity',function() { d3.select(this).transition() .duration(1000).style('opacity', 0); }); } if(gd._context.editable) { if(!txt) setPlaceholder(); el.call(svgTextUtils.makeEditable) .on('edit', function(text) { if(colorbar) { var trace = gd._fullData[cbnum]; if(Plots.traceIs(trace, 'markerColorscale')) { Plotly.restyle(gd, 'marker.colorbar.title', text, cbnum); } else Plotly.restyle(gd, 'colorbar.title', text, cbnum); } else Plotly.relayout(gd,prop,text); }) .on('cancel', function() { this.text(this.attr('data-unformatted')) .call(titleLayout); }) .on('input', function(d) { this.text(d || ' ').attr(options) .selectAll('tspan.line') .attr(options); }); } else if(!txt || txt.match(/Click to enter .+ title/)) { el.remove(); } el.classed('js-placeholder', isplaceholder); }; },{"../../lib":349,"../../lib/svg_text_utils":360,"../../plotly":366,"../../plots/cartesian/axis_ids":371,"../../plots/plots":413,"../color":299,"../drawing":317,"d3":70,"fast-isnumeric":74}],333:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { DZA: 'algeria', AGO: 'angola', EGY: 'egypt', BGD: 'bangladesh|^(?=.*east).*paki?stan', NER: '\\bniger(?!ia)', LIE: 'liechtenstein', NAM: 'namibia', BGR: 'bulgaria', BOL: 'bolivia', GHA: 'ghana|gold.?coast', CCK: '\\bcocos|keeling', PAK: '^(?!.*east).*paki?stan', CPV: 'verde', JOR: 'jordan', LBR: 'liberia', LBY: 'libya', MYS: 'malaysia', IOT: 'british.?indian.?ocean', PRI: 'puerto.?rico', MYT: 'mayotte', PRK: '^(?=.*democrat).*\\bkorea|^(?=.*people).*\\bkorea|^(?=.*north).*\\bkorea|\\bd\\.?p\\.?r\\.?k', PSE: 'palestin|\\bgaza|west.?bank', TZA: 'tanzania', BWA: 'botswana|bechuana', KHM: 'cambodia|kampuchea|khmer|^p\\.?r\\.?k\\.?$', UMI: 'minor.?outlying.?is', TTO: 'trinidad|tobago', PRY: 'paraguay', HKG: 'hong.?kong', SAU: '\\bsa\\w*.?arabia', LBN: 'lebanon', SVN: 'slovenia', BFA: 'burkina|\\bfaso|upper.?volta', SVK: '^(?!.*cze).*slovak', MRT: 'mauritania', HRV: 'croatia', CHL: '\\bchile', CHN: '^(?!.*\\bmac)(?!.*\\bhong)(?!.*\\btai).*china|^p\\.?r\\.?c\\.?$', KNA: 'kitts|\\bnevis', JAM: 'jamaica', SMR: 'san.?marino', GIB: 'gibraltar', DJI: 'djibouti', GIN: '^(?!.*eq)(?!.*span)(?!.*bissau)(?!.*portu)(?!.*new).*guinea', FIN: 'finland', URY: 'uruguay', VAT: 'holy.?see|vatican|papal.?st', STP: '\\bs(a|ã)o.?tom(e|é)', SYC: 'seychell', NPL: 'nepal', CXR: 'christmas', LAO: '\\blaos?\\b', YEM: '^(?!.*arab)(?!.*north)(?!.*sana)(?!.*peo)(?!.*dem)(?!.*south)(?!.*aden)(?!.*\\bp\\.?d\\.?r).*yemen', BVT: 'bouvet', ZAF: '\\bs\\w*.?africa', KIR: 'kiribati', PHL: 'philippines', SXM: '^(?!.*martin)(?!.*saba).*maarten', ROU: 'r(o|u|ou)mania', VIR: '^(?=.*\\bu\\.?\\s?s).*virgin|^(?=.*states).*virgin', SYR: 'syria', MAC: 'maca(o|u)', NFK: 'norfolk', NIC: 'nicaragua', MLT: '\\bmalta', KAZ: 'kazak', TCA: 'turks', PYF: 'french.?polynesia|tahiti', NIU: 'niue', DMA: 'dominica(?!n)', GBR: 'united.?kingdom|britain|^u\\.?k\\.?$', BEN: 'benin|dahome', GUF: '^(?=.*french).*guiana', BEL: '^(?!.*luxem).*belgium', MSR: 'montserrat', TGO: 'togo', DEU: '^(?!.*east).*germany|^(?=.*\\bfed.*\\brep).*german', GUM: '\\bguam', LKA: 'sri.?lanka|ceylon', SSD: '\\bs\\w*.?sudan', FLK: 'falkland|malvinas', PCN: 'pitcairn', BES: '^(?=.*bonaire).*eustatius|^(?=.*carib).*netherlands|\\bbes.?islands', GUY: 'guyana|british.?guiana', CRI: 'costa.?rica', COK: '\\bcook', MAR: 'morocco|\\bmaroc', MNP: 'mariana', LSO: 'lesotho|basuto', HUN: '^(?!.*austr).*hungary', TKM: 'turkmen', SUR: 'surinam|dutch.?guiana', NLD: '^(?!.*\\bant)(?!.*\\bcarib).*netherlands', BMU: 'bermuda', HMD: 'heard.*mcdonald', TCD: '\\bchad', GEO: '^(?!.*south).*georgia', MNE: '^(?!.*serbia).*montenegro', MNG: 'mongolia', MHL: 'marshall', MTQ: 'martinique', CSK: 'czechoslovakia', BLZ: 'belize|^(?=.*british).*honduras', DDR: 'german.?democratic.?republic|^(d|g)\\.?d\\.?r\\.?$|^(?=.*east).*germany', MMR: 'myanmar|burma', AFG: 'afghan', BDI: 'burundi', VGB: '^(?=.*\\bu\\.?\\s?k).*virgin|^(?=.*brit).*virgin|^(?=.*kingdom).*virgin', BLR: 'belarus|byelo', BLM: 'barth(e|é)lemy', GRD: 'grenada', TKL: 'tokelau', GRC: 'greece|hellenic|hellas', GRL: 'greenland', SHN: 'helena', AND: 'andorra', MOZ: 'mozambique', TJK: 'tajik', THA: 'thailand|\\bsiam', HTI: 'haiti', MEX: '\\bmexic', ANT: '^(?=.*\\bant).*(nether|dutch)', ZWE: 'zimbabwe|^(?!.*northern).*rhodesia', LCA: '\\blucia', IND: 'india(?!.*ocea)', LVA: 'latvia', BTN: 'bhutan', VCT: 'vincent', VNM: '^(?!.*republic).*viet.?nam|^(?=.*socialist).*viet.?nam', NOR: 'norway', CZE: '^(?=.*rep).*czech|czechia|bohemia', ATF: 'french.?southern|\\bfr.*\\bso.*\\ban.*\\b\\bt', ATG: 'antigua', FJI: 'fiji', HND: '^(?!.*brit).*honduras', MUS: 'mauritius', DOM: 'dominican', LUX: '^(?!.*belg).*luxem', ISR: 'israel', YUG: 'yugoslavia', FSM: 'micronesia', PER: 'peru', REU: 'r(e|é)union', IDN: 'indonesia', VUT: 'vanuatu|new.?hebrides', MKD: 'macedonia|^f\\.?y\\.?r\\.?o\\.?m\\.?$', COD: '\\bdem.*congo|congo.*\\bdem|congo.*\\bdr|\\bdr.*congo|\\bd\\.?r\\.?c|\\bd\\.?r\\.?o\\.?c|\\br\\.?d\\.?c|belgian.?congo|congo.?free.?state|kinshasa|zaire|l\\w{1,2}opoldville', COG: '^(?!.*\\bdem)(?!.*\\bdr)(?!.*kinshasa)(?!.*zaire)(?!.*belg)(?!.*l\\w{1,2}opoldville)(?!.*free).*\\bcongo', ISL: 'iceland', GLP: 'guadeloupe', ETH: 'ethiopia|abyssinia', COM: 'comoro', COL: 'colombia', NGA: 'nigeria', TLS: '^(?=.*leste).*timor|^(?=.*east).*timor', TWN: 'taiwan|taipei|formosa', PRT: 'portugal', MDA: 'moldov|b(a|e)ssarabia', GGY: 'guernsey', MDG: 'madagascar|malagasy', ATA: 'antarctica', ECU: 'ecuador', SEN: 'senegal', ESH: 'sahara', MDV: 'maldive', ASM: '^(?=.*americ).*samoa', SPM: 'miquelon', CUW: '^(?!.*bonaire).*\\bcura(c|ç)ao', FRA: '^(?!.*\\bdep)(?!.*martinique).*france|french.?republic|\\bgaul', LTU: 'lithuania', RWA: 'rwanda', ZMB: 'zambia|northern.?rhodesia', GMB: 'gambia', WLF: 'futuna|wallis', JEY: 'jersey', FRO: 'faroe|faeroe', GTM: 'guatemala', DNK: 'denmark', IMN: '^(?=.*isle).*\\bman', MAF: '^(?=.*collectivity).*martin|^(?=.*france).*martin(?!ique)|^(?=.*french).*martin(?!ique)', AUS: 'australia', AUT: '^(?!.*hungary).*austria|\\baust.*\\bemp', SJM: 'svalbard', VEN: 'venezuela', PLW: 'palau', KEN: 'kenya|british.?east.?africa|east.?africa.?prot', TUR: 'turkey', ALB: 'albania', OMN: '\\boman|trucial', TUV: 'tuvalu', ALA: '\\b(a|å)land', BRN: 'brunei', TUN: 'tunisia', RUS: '\\brussia|soviet.?union|u\\.?s\\.?s\\.?r|socialist.?republics', BRB: 'barbados', BRA: 'brazil', CIV: 'ivoire|ivory', SRB: '^(?!.*monte).*serbia', GNQ: 'guine.*eq|eq.*guine|^(?=.*span).*guinea', USA: '^(?!.*islands).*united.?states|^u\\.?s\\.?a\\.?$|^u\\.?s\\.?$', QAT: 'qatar', WSM: '^(?!.*amer).*samoa', AZE: 'azerbaijan', GNB: 'bissau|^(?=.*portu).*guinea', SWZ: 'swaziland', TON: 'tonga', CAN: 'canada', UKR: 'ukrain', KOR: '^(?!.*democrat)(?!.*people)(?!.*north).*\\bkorea|\\br\\.?o\\.?k\\b', AIA: 'anguill?a', CAF: '\\bcen.*\\baf|^c\\.?a\\.?r\\.?$', CHE: 'switz|swiss', CYP: 'cyprus', BIH: 'herzegovina|bosnia', SGP: 'singapore', SGS: 'south.?georgia|sandwich', SOM: 'somali', UZB: 'uzbek', CMR: 'cameroon', POL: 'poland', EAZ: 'zanz', KWT: 'kuwait', ERI: 'eritrea', GAB: 'gabon', CYM: 'cayman', ARE: 'emirates|^u\\.?a\\.?e\\.?$|united.?arab.?em', EST: 'estonia', MWI: 'malawi|nyasa', ESP: 'spain', IRQ: '\\biraq|mesopotamia', SLV: 'el.?salvador', MLI: '\\bmali\\b', YMD: '^(?=.*peo).*yemen|^(?!.*rep)(?=.*dem).*yemen|^(?=.*south).*yemen|^(?=.*aden).*yemen|^(?=.*\\bp\\.?d\\.?r).*yemen', IRL: 'ireland', IRN: '\\biran|persia', ABW: '^(?!.*bonaire).*\\baruba', SLE: 'sierra', PAN: 'panama', SDN: '^(?!.*\\bs(?!u)).*sudan', SLB: 'solomon', NZL: 'new.?zealand', MCO: 'monaco', ITA: 'italy', JPN: 'japan', KGZ: 'kyrgyz|kirghiz', UGA: 'uganda', NCL: 'new.?caledonia', PNG: 'papua|\\bp.*\\bn.*\\bguin.*|^p\\.?n\\.?g\\.?$|new.?guinea', ARG: 'argentin', SWE: 'sweden', BHS: 'bahamas', BHR: 'bahrain', ARM: 'armenia', NRU: 'nauru', CUB: '\\bcuba' }; },{}],334:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var params = module.exports = {}; // projection names to d3 function name params.projNames = { // d3.geo.projection 'equirectangular': 'equirectangular', 'mercator': 'mercator', 'orthographic': 'orthographic', 'natural earth': 'naturalEarth', 'kavrayskiy7': 'kavrayskiy7', 'miller': 'miller', 'robinson': 'robinson', 'eckert4': 'eckert4', 'azimuthal equal area': 'azimuthalEqualArea', 'azimuthal equidistant': 'azimuthalEquidistant', 'conic equal area': 'conicEqualArea', 'conic conformal': 'conicConformal', 'conic equidistant': 'conicEquidistant', 'gnomonic': 'gnomonic', 'stereographic': 'stereographic', 'mollweide': 'mollweide', 'hammer': 'hammer', 'transverse mercator': 'transverseMercator', 'albers usa': 'albersUsa' }; // name of the axes params.axesNames = ['lonaxis', 'lataxis']; // max longitudinal angular span (EXPERIMENTAL) params.lonaxisSpan = { 'orthographic': 180, 'azimuthal equal area': 360, 'azimuthal equidistant': 360, 'conic conformal': 180, 'gnomonic': 160, 'stereographic': 180, 'transverse mercator': 180, '*': 360 }; // max latitudinal angular span (EXPERIMENTAL) params.lataxisSpan = { 'conic conformal': 150, 'stereographic': 179.5, '*': 180 }; // defaults for each scope params.scopeDefaults = { world: { lonaxisRange: [-180, 180], lataxisRange: [-90, 90], projType: 'equirectangular', projRotate: [0, 0, 0] }, usa: { lonaxisRange: [-180, -50], lataxisRange: [15, 80], projType: 'albers usa' }, europe: { lonaxisRange: [-30, 60], lataxisRange: [30, 80], projType: 'conic conformal', projRotate: [15, 0, 0], projParallels: [0, 60] }, asia: { lonaxisRange: [22, 160], lataxisRange: [-15, 55], projType: 'mercator', projRotate: [0, 0, 0] }, africa: { lonaxisRange: [-30, 60], lataxisRange: [-40, 40], projType: 'mercator', projRotate: [0, 0, 0] }, 'north america': { lonaxisRange: [-180, -45], lataxisRange: [5, 85], projType: 'conic conformal', projRotate: [-100, 0, 0], projParallels: [29.5, 45.5] }, 'south america': { lonaxisRange: [-100, -30], lataxisRange: [-60, 15], projType: 'mercator', projRotate: [0, 0, 0] } }; // angular pad to avoid rounding error around clip angles params.clipPad = 1e-3; // map projection precision params.precision = 0.1; // default land and water fill colors params.landColor = '#F0DC82'; params.waterColor = '#3399FF'; // locationmode to layer name params.locationmodeToLayer = { 'ISO-3': 'countries', 'USA-states': 'subunits', 'country names': 'countries' }; // SVG element for a sphere (use to frame maps) params.sphereSVG = {type: 'Sphere'}; // N.B. base layer names must be the same as in the topojson files // base layer with a fill color params.fillLayers = ['ocean', 'land', 'lakes']; // base layer with a only a line color params.lineLayers = ['subunits', 'countries', 'coastlines', 'rivers', 'frame']; // all base layers - in order params.baseLayers = [ 'ocean', 'land', 'lakes', 'subunits', 'countries', 'coastlines', 'rivers', 'lataxis', 'lonaxis', 'frame' ]; params.layerNameToAdjective = { ocean: 'ocean', land: 'land', lakes: 'lake', subunits: 'subunit', countries: 'country', coastlines: 'coastline', rivers: 'river', frame: 'frame' }; // base layers drawn over choropleth params.baseLayersOverChoropleth = ['rivers', 'lakes']; },{}],335:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { solid: [1], dot: [1, 1], dash: [4, 1], longdash: [8, 1], dashdot: [4, 1, 1, 1], longdashdot: [8, 1, 1, 1] }; },{}],336:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { solid: [[], 0], dot: [[0.5, 1], 200], dash: [[0.5, 1], 50], longdash: [[0.5, 1], 10], dashdot: [[0.5, 0.625, 0.875, 1], 50], longdashdot: [[0.5, 0.7, 0.8, 1], 10] }; },{}],337:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { circle: '●', 'circle-open': '○', square: '■', 'square-open': '□', diamond: '◆', 'diamond-open': '◇', cross: '+', x: '❌' }; },{}],338:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; exports.xmlns = 'http://www.w3.org/2000/xmlns/'; exports.svg = 'http://www.w3.org/2000/svg'; exports.xlink = 'http://www.w3.org/1999/xlink'; // the 'old' d3 quirk got fix in v3.5.7 // https://github.com/mbostock/d3/commit/a6f66e9dd37f764403fc7c1f26be09ab4af24fed exports.svgAttrs = { xmlns: exports.svg, 'xmlns:xlink': exports.xlink }; },{}],339:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /* * Export the plotly.js API methods. */ var Plotly = require('./plotly'); // package version injected by `npm run preprocess` exports.version = '1.6.3'; // plot api exports.plot = Plotly.plot; exports.newPlot = Plotly.newPlot; exports.restyle = Plotly.restyle; exports.relayout = Plotly.relayout; exports.redraw = Plotly.redraw; exports.extendTraces = Plotly.extendTraces; exports.prependTraces = Plotly.prependTraces; exports.addTraces = Plotly.addTraces; exports.deleteTraces = Plotly.deleteTraces; exports.moveTraces = Plotly.moveTraces; exports.setPlotConfig = require('./plot_api/set_plot_config'); exports.register = Plotly.register; // plot icons exports.Icons = require('../build/ploticon'); // unofficial 'beta' plot methods, use at your own risk exports.Plots = Plotly.Plots; exports.Fx = Plotly.Fx; exports.Snapshot = Plotly.Snapshot; exports.PlotSchema = Plotly.PlotSchema; exports.Queue = Plotly.Queue; // export d3 used in the bundle exports.d3 = require('d3'); },{"../build/ploticon":2,"./plot_api/set_plot_config":365,"./plotly":366,"d3":70}],340:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /* global MathJax:false */ /** * Check and configure MathJax */ if(typeof MathJax !== 'undefined') { exports.MathJax = true; MathJax.Hub.Config({ messageStyle: 'none', skipStartupTypeset: true, displayAlign: 'left', tex2jax: { inlineMath: [['$','$'],['\\(','\\)']] } }); MathJax.Hub.Configured(); } else { exports.MathJax = false; } },{}],341:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; // similar to Lib.mergeArray, but using inside a loop module.exports = function arrayToCalcItem(traceAttr, calcItem, calcAttr, i) { if(Array.isArray(traceAttr)) calcItem[calcAttr] = traceAttr[i]; }; },{}],342:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var tinycolor = require('tinycolor2'); var nestedProperty = require('./nested_property'); var getColorscale = require('../components/colorscale/get_scale'); var colorscaleNames = Object.keys(require('../components/colorscale/scales')); exports.valObjects = { data_array: { // You can use *dflt=[] to force said array to exist though. coerceFunction: function(v, propOut, dflt) { if(Array.isArray(v)) propOut.set(v); else if(dflt!==undefined) propOut.set(dflt); } }, enumerated: { coerceFunction: function(v, propOut, dflt, opts) { if(opts.coerceNumber) v = +v; if(opts.values.indexOf(v)===-1) propOut.set(dflt); else propOut.set(v); } }, 'boolean': { coerceFunction: function(v, propOut, dflt) { if(v===true || v===false) propOut.set(v); else propOut.set(dflt); } }, number: { coerceFunction: function(v, propOut, dflt, opts) { if(!isNumeric(v) || (opts.min!==undefined && vopts.max)) { propOut.set(dflt); } else propOut.set(+v); } }, integer: { coerceFunction: function(v, propOut, dflt, opts) { if(v%1 || !isNumeric(v) || (opts.min!==undefined && vopts.max)) { propOut.set(dflt); } else propOut.set(+v); } }, string: { // TODO 'values shouldn't be in there (edge case: 'dash' in Scatter) coerceFunction: function(v, propOut, dflt, opts) { if(opts.strict===true && typeof v !== 'string') { propOut.set(dflt); return; } var s = String(v); if(v===undefined || (opts.noBlank===true && !s)) { propOut.set(dflt); } else propOut.set(s); } }, color: { coerceFunction: function(v, propOut, dflt) { if(tinycolor(v).isValid()) propOut.set(v); else propOut.set(dflt); } }, colorscale: { coerceFunction: function(v, propOut, dflt) { propOut.set(getColorscale(v, dflt)); } }, angle: { coerceFunction: function(v, propOut, dflt) { if(v==='auto') propOut.set('auto'); else if(!isNumeric(v)) propOut.set(dflt); else { if(Math.abs(v)>180) v -= Math.round(v/360)*360; propOut.set(+v); } } }, axisid: { coerceFunction: function(v, propOut, dflt) { if(typeof v === 'string' && v.charAt(0)===dflt) { var axnum = Number(v.substr(1)); if(axnum%1 === 0 && axnum>1) { propOut.set(v); return; } } propOut.set(dflt); } }, sceneid: { coerceFunction: function(v, propOut, dflt) { if(typeof v === 'string' && v.substr(0,5)===dflt) { var scenenum = Number(v.substr(5)); if(scenenum%1 === 0 && scenenum>1) { propOut.set(v); return; } } propOut.set(dflt); } }, geoid: { coerceFunction: function(v, propOut, dflt) { if(typeof v === 'string' && v.substr(0,3)===dflt) { var geonum = Number(v.substr(3)); if(geonum%1 === 0 && geonum>1) { propOut.set(v); return; } } propOut.set(dflt); } }, flaglist: { coerceFunction: function(v, propOut, dflt, opts) { if(typeof v !== 'string') { propOut.set(dflt); return; } if(opts.extras.indexOf(v)!==-1) { propOut.set(v); return; } var vParts = v.split('+'), i = 0; while(i3 digits, though javascript dates truncate to milliseconds * returns false if it doesn't find a date * * 2-digit to 4-digit year conversion, where to cut off? * from http://support.microsoft.com/kb/244664: * 1930-2029 (the most retro of all...) * but in my mac chrome from eg. d=new Date(Date.parse('8/19/50')): * 1950-2049 * by Java, from http://stackoverflow.com/questions/2024273/: * now-80 - now+20 * or FileMaker Pro, from * http://www.filemaker.com/12help/html/add_view_data.4.21.html: * now-70 - now+30 * but python strptime etc, via * http://docs.python.org/py3k/library/time.html: * 1969-2068 (super forward-looking, but static, not sliding!) * * lets go with now-70 to now+30, and if anyone runs into this problem * they can learn the hard way not to use 2-digit years, as no choice we * make now will cover all possibilities. mostly this will all be taken * care of in initial parsing, should only be an issue for hand-entered data * currently (2012) this range is: * 1942-2041 */ exports.dateTime2ms = function(s) { // first check if s is a date object try { if(s.getTime) return +s; } catch(e) { return false; } var y, m, d, h; // split date and time parts var datetime = String(s).split(' '); if(datetime.length > 2) return false; var p = datetime[0].split('-'); // date part if(p.length > 3 || (p.length !== 3 && datetime[1])) return false; // year if(p[0].length === 4) y = Number(p[0]); else if(p[0].length === 2) { var yNow = new Date().getFullYear(); y = ((Number(p[0]) - yNow + 70)%100 + 200)%100 + yNow - 70; } else return false; if(!isNumeric(y)) return false; if(p.length === 1) return new Date(y,0,1).getTime(); // year only // month m = Number(p[1]) - 1; // new Date() uses zero-based months if(p[1].length > 2 || !(m >= 0 && m <= 11)) return false; if(p.length === 2) return new Date(y, m, 1).getTime(); // year-month // day d = Number(p[2]); if(p[2].length > 2 || !(d >= 1 && d <= 31)) return false; // now save the date part d = new Date(y, m, d).getTime(); if(!datetime[1]) return d; // year-month-day p = datetime[1].split(':'); if(p.length > 3) return false; // hour h = Number(p[0]); if(p[0].length > 2 || !(h >= 0 && h <= 23)) return false; d += 3600000*h; if(p.length === 1) return d; // minute m = Number(p[1]); if(p[1].length > 2 || !(m >= 0 && m <= 59)) return false; d += 60000*m; if(p.length === 2) return d; // second s = Number(p[2]); if(!(s >= 0 && s < 60)) return false; return d+s*1000; }; // is string s a date? (see above) exports.isDateTime = function(s) { return (exports.dateTime2ms(s) !== false); }; // pad a number with zeroes, to given # of digits before the decimal point function lpad(val, digits) { return String(val + Math.pow(10, digits)).substr(1); } /** * Turn ms into string of the form YYYY-mm-dd HH:MM:SS.sss * Crop any trailing zeros in time, but always leave full date * (we could choose to crop '-01' from date too)... * Optional range r is the data range that applies, also in ms. * If rng is big, the later parts of time will be omitted */ exports.ms2DateTime = function(ms, r) { if(typeof(d3)==='undefined') { console.log('d3 is not defined'); return; } if(!r) r=0; var d = new Date(ms), s = d3.time.format('%Y-%m-%d')(d); if(r<7776000000) { // <90 days: add hours s+=' '+lpad(d.getHours(),2); if(r<432000000) { // <5 days: add minutes s+=':'+lpad(d.getMinutes(),2); if(r<10800000) { // <3 hours: add seconds s+=':'+lpad(d.getSeconds(),2); if(r<300000) { // <5 minutes: add ms s+='.'+lpad(d.getMilliseconds(),3); } } } // strip trailing zeros return s.replace(/([:\s]00)*\.?[0]*$/,''); } return s; }; /** * parseDate: forgiving attempt to turn any date string * into a javascript date object * * first collate all the date formats we want to support, precompiled * to d3 format objects see below for the string cleaning that happens * before this separate out 2-digit (y) and 4-digit-year (Y) formats, * formats with month names (b), and formats with am/pm (I) or no time (D) * (also includes hour only, as the test is really for a colon) so we can * cut down the number of tests we need to run for any given string * (right now all are between 15 and 32 tests) */ // TODO: this is way out of date vs. the server-side version var timeFormats = { // 24 hour H: ['%H:%M:%S~%L', '%H:%M:%S', '%H:%M'], // with am/pm I: ['%I:%M:%S~%L%p', '%I:%M:%S%p', '%I:%M%p'], // no colon, ie only date or date with hour (could also support eg 12h34m?) D: ['%H', '%I%p', '%Hh'] }; var dateFormats = { Y: [ '%Y~%m~%d', '%Y%m%d', '%y%m%d', // YYMMDD, has 6 digits together so will match Y, not y '%m~%d~%Y', // MM/DD/YYYY has first precedence '%d~%m~%Y' // then DD/MM/YYYY ], Yb: [ '%b~%d~%Y', // eg nov 21 2013 '%d~%b~%Y', // eg 21 nov 2013 '%Y~%d~%b', // eg 2013 21 nov (or 2013 q3, after replacement) '%Y~%b~%d' // eg 2013 nov 21 ], /** * the two-digit year cases have so many potential ambiguities * it's not even funny, but we'll try them anyway. */ y: [ '%m~%d~%y', '%d~%m~%y', '%y~%m~%d' ], yb: [ '%b~%d~%y', '%d~%b~%y', '%y~%d~%b', '%y~%b~%d' ] }; // use utc formatter since we're ignoring timezone info var formatter = d3.time.format.utc; /** * ISO8601 and YYYYMMDDHHMMSS are the only ones where date and time * are not separated by a space, so they get inserted specially here. * Also a couple formats with no day (so time makes no sense) */ var dateTimeFormats = { Y: { H: ['%Y~%m~%dT%H:%M:%S', '%Y~%m~%dT%H:%M:%S~%L'].map(formatter), I: [], D: ['%Y%m%d%H%M%S', '%Y~%m', '%m~%Y'].map(formatter) }, Yb: {H: [], I: [], D: ['%Y~%b', '%b~%Y'].map(formatter)}, y: {H: [], I: [], D: []}, yb: {H: [], I: [], D: []} }; // all others get inserted in all possible combinations from dateFormats and timeFormats ['Y', 'Yb', 'y', 'yb'].forEach(function(dateType) { dateFormats[dateType].forEach(function(dateFormat) { // just a date (don't do just a time) dateTimeFormats[dateType].D.push(formatter(dateFormat)); ['H', 'I', 'D'].forEach(function(timeType) { timeFormats[timeType].forEach(function(timeFormat) { var a = dateTimeFormats[dateType][timeType]; // 'date time', then 'time date' a.push(formatter(dateFormat+'~'+timeFormat)); a.push(formatter(timeFormat+'~'+dateFormat)); }); }); }); }); // precompiled regexps for performance var matchword = /[a-z]*/g, shortenword = function(m) { return m.substr(0,3); }, weekdaymatch = /(mon|tue|wed|thu|fri|sat|sun|the|of|st|nd|rd|th)/g, separatormatch = /[\s,\/\-\.\(\)]+/g, ampmmatch = /~?([ap])~?m(~|$)/, replaceampm = function(m,ap) { return ap+'m '; }, match4Y = /\d\d\d\d/, matchMonthName = /(^|~)[a-z]{3}/, matchAMPM = /[ap]m/, matchcolon = /:/, matchquarter = /q([1-4])/, quarters = ['31~mar','30~jun','30~sep','31~dec'], replacequarter = function(m,n) { return quarters[n-1]; }, matchTZ = / ?([+\-]\d\d:?\d\d|Z)$/; function getDateType(v) { var dateType; dateType = (match4Y.test(v) ? 'Y' : 'y'); dateType = dateType + (matchMonthName.test(v) ? 'b' : ''); return dateType; } function getTimeType(v) { var timeType; timeType = matchcolon.test(v) ? (matchAMPM.test(v) ? 'I' : 'H') : 'D'; return timeType; } exports.parseDate = function(v) { // is it already a date? just return it if(v.getTime) return v; /** * otherwise, if it's not a string, return nothing * the case of numbers that just have years will get * dealt with elsewhere. */ if(typeof v !== 'string') return false; // first clean up the string a bit to reduce the number of formats we have to test v = v.toLowerCase() /** * cut all words down to 3 characters - this will result in * some spurious matches, ie whenever the first three characters * of a word match a month or weekday but that seems more likely * to fix typos than to make dates where they shouldn't be... * and then we can omit the long form of months from our testing */ .replace(matchword, shortenword) /** * remove weekday names, as they get overridden anyway if they're * inconsistent also removes a few more words * (ie "tuesday the 26th of november") * TODO: language support? * for months too, but these seem to be built into d3 */ .replace(weekdaymatch, '') /** * collapse all separators one ~ at a time, except : which seems * pretty consistent for the time part use ~ instead of space or * something since d3 can eat a space as padding on 1-digit numbers */ .replace(separatormatch, '~') // in case of a.m. or p.m. (also take off any space before am/pm) .replace(ampmmatch, replaceampm) // turn quarters Q1-4 into dates (quarter ends) .replace(matchquarter, replacequarter) .trim() // also try to ignore timezone info, at least for now .replace(matchTZ, ''); // now test against the various formats that might match var out = null, dateType = getDateType(v), timeType = getTimeType(v), formatList, len; formatList = dateTimeFormats[dateType][timeType]; len = formatList.length; for(var i = 0; i < len; i++) { out = formatList[i].parse(v); if(out) break; } // If not an instance of Date at this point, just return it. if(!(out instanceof Date)) return false; // parse() method interprets arguments with local time zone. var tzoff = out.getTimezoneOffset(); // In general (default) this is not what we want, so force into UTC: out.setTime(out.getTime() + tzoff * 60 * 1000); return out; }; },{"d3":70,"fast-isnumeric":74}],344:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /* global $:false */ var EventEmitter = require('events').EventEmitter; var Events = { init: function(plotObj) { /* * If we have already instantiated an emitter for this plot * return early. */ if(plotObj._ev instanceof EventEmitter) return plotObj; var ev = new EventEmitter(); /* * Assign to plot._ev while we still live in a land * where plot is a DOM element with stuff attached to it. * In the future we can make plot the event emitter itself. */ plotObj._ev = ev; /* * Assign bound methods from the ev to the plot object. These methods * will reference the 'this' of plot._ev even though they are methods * of plot. This will keep the event machinery away from the plot object * which currently is often a DOM element but presents an API that will * continue to function when plot becomes an emitter. Not all EventEmitter * methods have been bound to `plot` as some do not currently add value to * the Plotly event API. */ plotObj.on = ev.on.bind(ev); plotObj.once = ev.once.bind(ev); plotObj.removeListener = ev.removeListener.bind(ev); plotObj.removeAllListeners = ev.removeAllListeners.bind(ev); /* * We must wrap emit to continue to support JQuery events. The idea * is to check to see if the user is using JQuery events, if they are * we emit JQuery events to trigger user handlers as well as the EventEmitter * events. */ plotObj.emit = function(event, data) { if(typeof $ !== 'undefined') { $(plotObj).trigger(event, data); } ev.emit(event, data); }; return plotObj; }, /* * This function behaves like jQueries triggerHandler. It calls * all handlers for a particular event and returns the return value * of the LAST handler. This function also triggers jQuery's * triggerHandler for backwards compatibility. */ triggerHandler: function(plotObj, event, data) { var jQueryHandlerValue; var nodeEventHandlerValue; /* * If Jquery exists run all its handlers for this event and * collect the return value of the LAST handler function */ if(typeof $ !== 'undefined') { jQueryHandlerValue = $(plotObj).triggerHandler(event, data); } /* * Now run all the node style event handlers */ var ev = plotObj._ev; if(!ev) return jQueryHandlerValue; var handlers = ev._events[event]; if(!handlers) return jQueryHandlerValue; /* * handlers can be function or an array of functions */ if(typeof handlers === 'function') handlers = [handlers]; var lastHandler = handlers.pop(); /* * Call all the handlers except the last one. */ for(var i = 0; i < handlers.length; i++) { handlers[i](data); } /* * Now call the final handler and collect its value */ nodeEventHandlerValue = lastHandler(data); /* * Return either the jquery handler value if it exists or the * nodeEventHandler value. Jquery event value superceeds nodejs * events for backwards compatability reasons. */ return jQueryHandlerValue !== undefined ? jQueryHandlerValue : nodeEventHandlerValue; } }; module.exports = Events; },{"events":54}],345:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isPlainObject = require('./is_plain_object.js'); var isArray = Array.isArray; exports.extendFlat = function() { return _extend(arguments, false, false); }; exports.extendDeep = function() { return _extend(arguments, true, false); }; exports.extendDeepAll = function() { return _extend(arguments, true, true); }; /* * Inspired by https://github.com/justmoon/node-extend/blob/master/index.js * All credit to the jQuery authors for perfecting this amazing utility. * * API difference with jQuery version: * - No optional boolean (true -> deep extend) first argument, * use `extendFlat` for first-level only extend and * use `extendDeep` for a deep extend. * * Other differences with jQuery version: * - Uses a modern (and faster) isPlainObject routine. * - Expected to work with object {} and array [] arguments only. * - Does not check for circular structure. * FYI: jQuery only does a check across one level. * Warning: this might result in infinite loops. * */ function _extend(inputs, isDeep, keepAllKeys) { var target = inputs[0], length = inputs.length; var input, key, src, copy, copyIsArray, clone; for(var i = 1; i < length; i++) { input = inputs[i]; for(key in input) { src = target[key]; copy = input[key]; // recurse if we're merging plain objects or arrays if(isDeep && copy && (isPlainObject(copy) || (copyIsArray = isArray(copy)))) { if(copyIsArray) { copyIsArray = false; clone = src && isArray(src) ? src : []; } else { clone = src && isPlainObject(src) ? src : {}; } // never move original objects, clone them target[key] = _extend([clone, copy], isDeep, keepAllKeys); } // don't bring in undefined values, except for extendDeepAll else if(typeof copy !== 'undefined' || keepAllKeys) { target[key] = copy; } } } return target; } },{"./is_plain_object.js":350}],346:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var locationUtils = module.exports = {}; var Plotly = require('../plotly'); // an hash object iso3 to regex string var countryNameData = require('../constants/country-name_to_iso3'); // make list of all country iso3 ids from at runtime var countryIds = Object.keys(countryNameData); var locationmodeToIdFinder = { 'ISO-3': Plotly.Lib.identity, 'USA-states': Plotly.Lib.identity, 'country names': countryNameToISO3 }; locationUtils.locationToFeature = function(locationmode, location, features) { var locationId = getLocationId(locationmode, location); var feature; for(var i = 0; i < features.length; i++) { feature = features[i]; if(feature.id === locationId) return feature; } console.warn([ 'location with id', locationId, 'does not have a matching topojson feature at this resolution.' ].join(' ')); }; function getLocationId(locationmode, location) { var idFinder = locationmodeToIdFinder[locationmode]; return idFinder(location); } function countryNameToISO3(countryName) { var iso3, regex; for(var i = 0; i < countryIds.length; i++) { iso3 = countryIds[i]; regex = new RegExp(countryNameData[iso3]); if(regex.test(countryName.toLowerCase())) return iso3; } console.warn('unrecognized country name: ' + countryName + '.'); } },{"../constants/country-name_to_iso3":333,"../plotly":366}],347:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../plotly'); var tinycolor = require('tinycolor2'); var isNumeric = require('fast-isnumeric'); var str2RgbaArray = require('./str2rgbarray'); var colorDflt = require('../components/color/attributes').defaultLine; var opacityDflt = 1; function calculateColor(colorIn, opacityIn) { var colorOut = str2RgbaArray(colorIn); colorOut[3] *= opacityIn; return colorOut; } function validateColor(colorIn) { return tinycolor(colorIn).isValid() ? colorIn : colorDflt; } function validateOpacity(opacityIn) { return isNumeric(opacityIn) ? opacityIn : opacityDflt; } function formatColor(containerIn, opacityIn, len) { var colorIn = containerIn.color, isArrayColorIn = Array.isArray(colorIn), isArrayOpacityIn = Array.isArray(opacityIn), colorOut = []; var sclFunc, getColor, getOpacity, colori, opacityi; if(containerIn.colorscale !== undefined) { sclFunc = Plotly.Colorscale.makeScaleFunction( containerIn.colorscale, containerIn.cmin, containerIn.cmax ); } else sclFunc = validateColor; if(isArrayColorIn) { getColor = function(c, i) { return c[i]===undefined ? colorDflt : sclFunc(c[i]); }; } else getColor = validateColor; if(isArrayOpacityIn) { getOpacity = function(o, i) { return o[i]===undefined ? opacityDflt : validateOpacity(o[i]); }; } else getOpacity = validateOpacity; if(isArrayColorIn || isArrayOpacityIn) { for(var i = 0; i < len; i++) { colori = getColor(colorIn, i); opacityi = getOpacity(opacityIn, i); colorOut[i] = calculateColor(colori, opacityi); } } else colorOut = calculateColor(colorIn, opacityIn); return colorOut; } module.exports = formatColor; },{"../components/color/attributes":298,"../plotly":366,"./str2rgbarray":359,"fast-isnumeric":74,"tinycolor2":229}],348:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var toSuperScript = require('superscript-text'); var ENTITIES = { 'mu': 'μ', 'amp': '&', 'lt': '<', 'gt': '>' }; function fixSuperScript(x) { var idx = 0; while((idx = x.indexOf('', idx)) >= 0) { var nidx = x.indexOf('', idx); if(nidx < idx) break; x = x.slice(0, idx) + toSuperScript(x.slice(idx+5, nidx)) + x.slice(nidx+6); } return x; } function fixBR(x) { return x.replace(/\/g, '\n'); } function stripTags(x) { return x.replace(/\<.*\>/g, ''); } function fixEntities(x) { var idx = 0; while((idx = x.indexOf('&', idx)) >= 0) { var nidx = x.indexOf(';', idx); if(nidx < idx) { idx += 1; continue; } var entity = ENTITIES[x.slice(idx+1, nidx)]; if(entity) { x = x.slice(0, idx) + entity + x.slice(nidx+1); } else { x = x.slice(0, idx) + x.slice(nidx+1); } } return x; } function convertHTMLToUnicode(html) { return '' + fixEntities( stripTags( fixSuperScript( fixBR( html)))); } module.exports = convertHTMLToUnicode; },{"superscript-text":218}],349:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var lib = module.exports = {}; lib.nestedProperty = require('./nested_property'); lib.isPlainObject = require('./is_plain_object'); var coerceModule = require('./coerce'); lib.valObjects = coerceModule.valObjects; lib.coerce = coerceModule.coerce; lib.coerce2 = coerceModule.coerce2; lib.coerceFont = coerceModule.coerceFont; var datesModule = require('./dates'); lib.dateTime2ms = datesModule.dateTime2ms; lib.isDateTime = datesModule.isDateTime; lib.ms2DateTime = datesModule.ms2DateTime; lib.parseDate = datesModule.parseDate; var searchModule = require('./search'); lib.findBin = searchModule.findBin; lib.sorterAsc = searchModule.sorterAsc; lib.sorterDes = searchModule.sorterDes; lib.distinctVals = searchModule.distinctVals; lib.roundUp = searchModule.roundUp; var statsModule = require('./stats'); lib.aggNums = statsModule.aggNums; lib.len = statsModule.len; lib.mean = statsModule.mean; lib.variance = statsModule.variance; lib.stdev = statsModule.stdev; lib.interp = statsModule.interp; var matrixModule = require('./matrix'); lib.init2dArray = matrixModule.init2dArray; lib.transposeRagged = matrixModule.transposeRagged; lib.dot = matrixModule.dot; lib.translationMatrix = matrixModule.translationMatrix; lib.rotationMatrix = matrixModule.rotationMatrix; lib.rotationXYMatrix = matrixModule.rotationXYMatrix; lib.apply2DTransform = matrixModule.apply2DTransform; lib.apply2DTransform2 = matrixModule.apply2DTransform2; var extendModule = require('./extend'); lib.extendFlat = extendModule.extendFlat; lib.extendDeep = extendModule.extendDeep; lib.extendDeepAll = extendModule.extendDeepAll; lib.notifier = require('./notifier'); /** * swap x and y of the same attribute in container cont * specify attr with a ? in place of x/y * you can also swap other things than x/y by providing part1 and part2 */ lib.swapAttrs = function(cont, attrList, part1, part2) { if(!part1) part1 = 'x'; if(!part2) part2 = 'y'; for(var i = 0; i < attrList.length; i++) { var attr = attrList[i], xp = lib.nestedProperty(cont, attr.replace('?', part1)), yp = lib.nestedProperty(cont, attr.replace('?', part2)), temp = xp.get(); xp.set(yp.get()); yp.set(temp); } }; /** * to prevent event bubbling, in particular text selection during drag. * see http://stackoverflow.com/questions/5429827/ * how-can-i-prevent-text-element-selection-with-cursor-drag * for maximum effect use: * return pauseEvent(e); */ lib.pauseEvent = function(e) { if(e.stopPropagation) e.stopPropagation(); if(e.preventDefault) e.preventDefault(); e.cancelBubble = true; return false; }; /** * ------------------------------------------ * debugging tools * ------------------------------------------ */ // set VERBOSE to true to get a lot more logging and tracing lib.VERBOSE = false; // first markTime call will return time from page load lib.TIMER = new Date().getTime(); // console.log that only runs if VERBOSE is on lib.log = function() { if(lib.VERBOSE) console.log.apply(console, arguments); }; /** * markTime - for debugging, mark the number of milliseconds * since the previous call to markTime and log arbitrary info too */ lib.markTime = function(v) { if(!lib.VERBOSE) return; var t2 = new Date().getTime(); console.log(v, t2 - lib.TIMER, '(msec)'); if(lib.VERBOSE === 'trace') console.trace(); lib.TIMER = t2; }; // constrain - restrict a number v to be between v0 and v1 lib.constrain = function(v, v0, v1) { if(v0 > v1) return Math.max(v1, Math.min(v0, v)); return Math.max(v0, Math.min(v1, v)); }; /** * do two bounding boxes from getBoundingClientRect, * ie {left,right,top,bottom,width,height}, overlap? * takes optional padding pixels */ lib.bBoxIntersect = function(a, b, pad) { pad = pad || 0; return (a.left <= b.right + pad && b.left <= a.right + pad && a.top <= b.bottom + pad && b.top <= a.bottom + pad); }; // minor convenience/performance booster for d3... lib.identity = function(d) { return d; }; // random string generator lib.randstr = function randstr(existing, bits, base) { /* * Include number of bits, the base of the string you want * and an optional array of existing strings to avoid. */ if(!base) base = 16; if(bits === undefined) bits = 24; if(bits <= 0) return '0'; var digits = Math.log(Math.pow(2, bits)) / Math.log(base), res = '', i, b, x; for(i = 2; digits === Infinity; i *= 2) { digits = Math.log(Math.pow(2, bits / i)) / Math.log(base) * i; } var rem = digits - Math.floor(digits); for(i = 0; i < Math.floor(digits); i++) { x = Math.floor(Math.random() * base).toString(base); res = x + res; } if(rem) { b = Math.pow(base, rem); x = Math.floor(Math.random() * b).toString(base); res = x + res; } var parsed = parseInt(res, base); if((existing && (existing.indexOf(res) > -1)) || (parsed !== Infinity && parsed >= Math.pow(2, bits))) { return randstr(existing, bits, base); } else return res; }; lib.OptionControl = function(opt, optname) { /* * An environment to contain all option setters and * getters that collectively modify opts. * * You can call up opts from any function in new object * as this.optname || this.opt * * See FitOpts for example of usage */ if(!opt) opt = {}; if(!optname) optname = 'opt'; var self = {}; self.optionList = []; self._newoption = function(optObj) { optObj[optname] = opt; self[optObj.name] = optObj; self.optionList.push(optObj); }; self['_'+optname] = opt; return self; }; /** * lib.smooth: smooth arrayIn by convolving with * a hann window with given full width at half max * bounce the ends in, so the output has the same length as the input */ lib.smooth = function(arrayIn, FWHM) { FWHM = Math.round(FWHM) || 0; // only makes sense for integers if(FWHM < 2) return arrayIn; var alen = arrayIn.length, alen2 = 2 * alen, wlen = 2 * FWHM - 1, w = new Array(wlen), arrayOut = new Array(alen), i, j, k, v; // first make the window array for(i = 0; i < wlen; i++) { w[i] = (1 - Math.cos(Math.PI * (i + 1) / FWHM)) / (2 * FWHM); } // now do the convolution for(i = 0; i < alen; i++) { v = 0; for(j = 0; j < wlen; j++) { k = i + j + 1 - FWHM; // multibounce if(k < -alen) k -= alen2 * Math.round(k / alen2); else if(k >= alen2) k -= alen2 * Math.floor(k / alen2); // single bounce if(k < 0) k = - 1 - k; else if(k >= alen) k = alen2 - 1 - k; v += arrayIn[k] * w[j]; } arrayOut[i] = v; } return arrayOut; }; // helpers for promises /** * promiseError: log errors properly inside promises * use: * .then(undefined,Plotly.Lib.promiseError) (for IE compatibility) * or .catch(Plotly.Lib.promiseError) * TODO: I guess we need another step to send this error to Sentry? */ lib.promiseError = function(err) { console.log(err, err.stack); }; /** * syncOrAsync: run a sequence of functions synchronously * as long as its returns are not promises (ie have no .then) * includes one argument arg to send to all functions... * this is mainly just to prevent us having to make wrapper functions * when the only purpose of the wrapper is to reference gd / td * and a final step to be executed at the end * TODO: if there's an error and everything is sync, * this doesn't happen yet because we want to make sure * that it gets reported */ lib.syncOrAsync = function(sequence, arg, finalStep) { var ret, fni; function continueAsync() { lib.markTime('async done ' + fni.name); return lib.syncOrAsync(sequence, arg, finalStep); } while(sequence.length) { fni = sequence.splice(0, 1)[0]; ret = fni(arg); // lib.markTime('done calling '+fni.name) if(ret && ret.then) { return ret.then(continueAsync) .then(undefined, lib.promiseError); } lib.markTime('sync done ' + fni.name); } return finalStep && finalStep(arg); }; /** * Helper to strip trailing slash, from * http://stackoverflow.com/questions/6680825/return-string-without-trailing-slash */ lib.stripTrailingSlash = function(str) { if(str.substr(-1) === '/') return str.substr(0, str.length - 1); return str; }; lib.noneOrAll = function(containerIn, containerOut, attrList) { /** * some attributes come together, so if you have one of them * in the input, you should copy the default values of the others * to the input as well. */ if(!containerIn) return; var hasAny = false, hasAll = true, i, val; for(i = 0; i < attrList.length; i++) { val = containerIn[attrList[i]]; if(val !== undefined && val !== null) hasAny = true; else hasAll = false; } if(hasAny && !hasAll) { for(i = 0; i < attrList.length; i++) { containerIn[attrList[i]] = containerOut[attrList[i]]; } } }; lib.mergeArray = function(traceAttr, cd, cdAttr) { if(Array.isArray(traceAttr)) { var imax = Math.min(traceAttr.length, cd.length); for(var i=0; i or 1 elements * because extend-like algorithms are hella slow * obj2 is assumed to already be clean of these things (including no arrays) */ lib.minExtend = function(obj1, obj2) { var objOut = {}; if(typeof obj2 !== 'object') obj2 = {}; var arrayLen = 3, keys = Object.keys(obj1), i, k, v; for(i = 0; i < keys.length; i++) { k = keys[i]; v = obj1[k]; if(k.charAt(0)==='_' || typeof v === 'function') continue; else if(k==='module') objOut[k] = v; else if(Array.isArray(v)) objOut[k] = v.slice(0,arrayLen); else if(v && (typeof v === 'object')) objOut[k] = lib.minExtend(obj1[k], obj2[k]); else objOut[k] = v; } keys = Object.keys(obj2); for(i = 0; i < keys.length; i++) { k = keys[i]; v = obj2[k]; if(typeof v !== 'object' || !(k in objOut) || typeof objOut[k] !== 'object') { objOut[k] = v; } } return objOut; }; lib.titleCase = function(s) { return s.charAt(0).toUpperCase() + s.substr(1); }; lib.containsAny = function(s, fragments) { for(var i = 0; i < fragments.length; i++) { if(s.indexOf(fragments[i])!== -1) return true; } return false; }; // get the parent Plotly plot of any element. Whoo jquery-free tree climbing! lib.getPlotDiv = function(el) { for(; el && el.removeAttribute; el = el.parentNode) { if(lib.isPlotDiv(el)) return el; } }; lib.isPlotDiv = function(el) { var el3 = d3.select(el); return el3.size() && el3.classed('js-plotly-plot'); }; lib.removeElement = function(el) { var elParent = el && el.parentNode; if(elParent) elParent.removeChild(el); }; /** * for dynamically adding style rules * makes one stylesheet that contains all rules added * by all calls to this function */ lib.addStyleRule = function(selector, styleString) { if(!lib.styleSheet) { var style = document.createElement('style'); // WebKit hack :( style.appendChild(document.createTextNode('')); document.head.appendChild(style); lib.styleSheet = style.sheet; } var styleSheet = lib.styleSheet; if(styleSheet.insertRule) { styleSheet.insertRule(selector+'{'+styleString+'}',0); } else if(styleSheet.addRule) { styleSheet.addRule(selector,styleString,0); } else console.warn('addStyleRule failed'); }; lib.isIE = function() { return typeof window.navigator.msSaveBlob !== 'undefined'; }; },{"./coerce":342,"./dates":343,"./extend":345,"./is_plain_object":350,"./matrix":351,"./nested_property":352,"./notifier":353,"./search":356,"./stats":358,"d3":70}],350:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; // more info: http://stackoverflow.com/questions/18531624/isplainobject-thing module.exports = function isPlainObject(obj) { return ( Object.prototype.toString.call(obj) === '[object Object]' && Object.getPrototypeOf(obj) === Object.prototype ); }; },{}],351:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; exports.init2dArray = function(rowLength, colLength) { var array = new Array(rowLength); for(var i = 0; i < rowLength; i++) array[i] = new Array(colLength); return array; }; /** * transpose a (possibly ragged) 2d array z. inspired by * http://stackoverflow.com/questions/17428587/ * transposing-a-2d-array-in-javascript */ exports.transposeRagged = function(z) { var maxlen = 0, zlen = z.length, i, j; // Maximum row length: for(i = 0; i < zlen; i++) maxlen = Math.max(maxlen, z[i].length); var t = new Array(maxlen); for(i = 0; i < maxlen; i++) { t[i] = new Array(zlen); for(j = 0; j < zlen; j++) t[i][j] = z[j][i]; } return t; }; // our own dot function so that we don't need to include numeric exports.dot = function(x, y) { if(!(x.length && y.length) || x.length !== y.length) return null; var len = x.length, out, i; if(x[0].length) { // mat-vec or mat-mat out = new Array(len); for(i = 0; i < len; i++) out[i] = exports.dot(x[i], y); } else if(y[0].length) { // vec-mat var yTranspose = exports.transposeRagged(y); out = new Array(yTranspose.length); for(i = 0; i < yTranspose.length; i++) out[i] = exports.dot(x, yTranspose[i]); } else { // vec-vec out = 0; for(i = 0; i < len; i++) out += x[i] * y[i]; } return out; }; // translate by (x,y) exports.translationMatrix = function(x, y) { return [[1, 0, x], [0, 1, y], [0, 0, 1]]; }; // rotate by alpha around (0,0) exports.rotationMatrix = function(alpha) { var a = alpha*Math.PI/180; return [[Math.cos(a), -Math.sin(a), 0], [Math.sin(a), Math.cos(a), 0], [0, 0, 1]]; }; // rotate by alpha around (x,y) exports.rotationXYMatrix = function(a, x, y) { return exports.dot( exports.dot(exports.translationMatrix(x, y), exports.rotationMatrix(a)), exports.translationMatrix(-x, -y)); }; // applies a 2D transformation matrix to either x and y params or an [x,y] array exports.apply2DTransform = function(transform) { return function() { var args = arguments; if(args.length === 3) { args = args[0]; }//from map var xy = arguments.length === 1 ? args[0] : [args[0], args[1]]; return exports.dot(transform, [xy[0], xy[1], 1]).slice(0, 2); }; }; // applies a 2D transformation matrix to an [x1,y1,x2,y2] array (to transform a segment) exports.apply2DTransform2 = function(transform) { var at = exports.apply2DTransform(transform); return function(xys) { return at(xys.slice(0, 2)).concat(at(xys.slice(2, 4))); }; }; },{}],352:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); /** * convert a string s (such as 'xaxis.range[0]') * representing a property of nested object into set and get methods * also return the string and object so we don't have to keep track of them * allows [-1] for an array index, to set a property inside all elements * of an array * eg if obj = {arr: [{a: 1}, {a: 2}]} * you can do p = nestedProperty(obj, 'arr[-1].a') * but you cannot set the array itself this way, to do that * just set the whole array. * eg if obj = {arr: [1, 2, 3]} * you can't do nestedProperty(obj, 'arr[-1]').set(5) * but you can do nestedProperty(obj, 'arr').set([5, 5, 5]) */ module.exports = function nestedProperty(container, propStr) { if(isNumeric(propStr)) propStr = String(propStr); else if(typeof propStr !== 'string' || propStr.substr(propStr.length - 4) === '[-1]') { throw 'bad property string'; } var j = 0, propParts = propStr.split('.'), indexed, indices, i; // check for parts of the nesting hierarchy that are numbers (ie array elements) while(j < propParts.length) { // look for non-bracket chars, then any number of [##] blocks indexed = String(propParts[j]).match(/^([^\[\]]*)((\[\-?[0-9]*\])+)$/); if(indexed) { if(indexed[1]) propParts[j] = indexed[1]; // allow propStr to start with bracketed array indices else if(j === 0) propParts.splice(0,1); else throw 'bad property string'; indices = indexed[2] .substr(1,indexed[2].length-2) .split(']['); for(i=0; i= 0; i--) { curCont = containerLevels[i]; remainingKeys = false; if(Array.isArray(curCont)) { for(j = curCont.length - 1; j >= 0; j--) { if(emptyObj(curCont[j])) { if(remainingKeys) curCont[j] = undefined; else curCont.pop(); } else remainingKeys = true; } } else if(typeof curCont === 'object' && curCont !== null) { keys = Object.keys(curCont); remainingKeys = false; for(j = keys.length - 1; j >= 0; j--) { if(emptyObj(curCont[keys[j]]) && !isDataArray(curCont[keys[j]], keys[j])) delete curCont[keys[j]]; else remainingKeys = true; } } if(remainingKeys) return; } } function emptyObj(obj) { if(obj===undefined || obj===null) return true; if(typeof obj !== 'object') return false; // any plain value if(Array.isArray(obj)) return !obj.length; // [] return !Object.keys(obj).length; // {} } function badContainer(container, propStr, propParts) { return { set: function() { throw 'bad container'; }, get: function() {}, astr: propStr, parts: propParts, obj: container }; } },{"fast-isnumeric":74}],353:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var isNumeric = require('fast-isnumeric'); var NOTEDATA = []; /** * notifier * @param {String} text The person's user name * @param {Number} [delay=1000] The delay time in milliseconds * or 'long' which provides 2000 ms delay time. * @return {undefined} this function does not return a value */ module.exports = function(text, displayLength) { if(NOTEDATA.indexOf(text) !== -1) return; NOTEDATA.push(text); var ts = 1000; if(isNumeric(displayLength)) ts = displayLength; else if(displayLength === 'long') ts = 3000; var notifierContainer = d3.select('body') .selectAll('.plotly-notifier') .data([0]); notifierContainer.enter() .append('div') .classed('plotly-notifier', true); var notes = notifierContainer.selectAll('.notifier-note').data(NOTEDATA); function killNote(transition) { transition .duration(700) .style('opacity', 0) .each('end', function(thisText) { var thisIndex = NOTEDATA.indexOf(thisText); if(thisIndex !== -1) NOTEDATA.splice(thisIndex, 1); d3.select(this).remove(); }); } notes.enter().append('div') .classed('notifier-note', true) .style('opacity', 0) .each(function(thisText) { var note = d3.select(this); note.append('button') .classed('notifier-close', true) .html('×') .on('click', function() { note.transition().call(killNote); }); note.append('p').html(thisText); note.transition() .duration(700) .style('opacity', 1) .transition() .delay(ts) .call(killNote); }); }; },{"d3":70,"fast-isnumeric":74}],354:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var dot = require('./matrix').dot; var polygon = module.exports = {}; /** * Turn an array of [x, y] pairs into a polygon object * that can test if points are inside it * * @param ptsIn Array of [x, y] pairs * * @returns polygon Object {xmin, xmax, ymin, ymax, pts, contains} * (x|y)(min|max) are the bounding rect of the polygon * pts is the original array, with the first pair repeated at the end * contains is a function: (pt, omitFirstEdge) * pt is the [x, y] pair to test * omitFirstEdge truthy means points exactly on the first edge don't * count. This is for use adding one polygon to another so we * don't double-count the edge where they meet. * returns boolean: is pt inside the polygon (including on its edges) */ polygon.tester = function tester(ptsIn) { var pts = ptsIn.slice(), xmin = pts[0][0], xmax = xmin, ymin = pts[0][1], ymax = ymin; pts.push(pts[0]); for(var i = 1; i < pts.length; i++) { xmin = Math.min(xmin, pts[i][0]); xmax = Math.max(xmax, pts[i][0]); ymin = Math.min(ymin, pts[i][1]); ymax = Math.max(ymax, pts[i][1]); } // do we have a rectangle? Handle this here, so we can use the same // tester for the rectangular case without sacrificing speed var isRect = false, rectFirstEdgeTest; if(pts.length === 5) { if(pts[0][0] === pts[1][0]) { // vert, horz, vert, horz if(pts[2][0] === pts[3][0] && pts[0][1] === pts[3][1] && pts[1][1] === pts[2][1]) { isRect = true; rectFirstEdgeTest = function(pt) { return pt[0] === pts[0][0]; }; } } else if(pts[0][1] === pts[1][1]) { // horz, vert, horz, vert if(pts[2][1] === pts[3][1] && pts[0][0] === pts[3][0] && pts[1][0] === pts[2][0]) { isRect = true; rectFirstEdgeTest = function(pt) { return pt[1] === pts[0][1]; }; } } } function rectContains(pt, omitFirstEdge) { var x = pt[0], y = pt[1]; if(x < xmin || x > xmax || y < ymin || y > ymax) { // pt is outside the bounding box of polygon return false; } if(omitFirstEdge && rectFirstEdgeTest(pt)) return false; return true; } function contains(pt, omitFirstEdge) { var x = pt[0], y = pt[1]; if(x < xmin || x > xmax || y < ymin || y > ymax) { // pt is outside the bounding box of polygon return false; } var imax = pts.length, x1 = pts[0][0], y1 = pts[0][1], crossings = 0, i, x0, y0, xmini, ycross; for(i = 1; i < imax; i++) { // find all crossings of a vertical line upward from pt with // polygon segments // crossings exactly at xmax don't count, unless the point is // exactly on the segment, then it counts as inside. x0 = x1; y0 = y1; x1 = pts[i][0]; y1 = pts[i][1]; xmini = Math.min(x0, x1); // outside the bounding box of this segment, it's only a crossing // if it's below the box. if(x < xmini || x > Math.max(x0, x1) || y > Math.max(y0, y1)) { continue; } else if(y < Math.min(y0, y1)) { // don't count the left-most point of the segment as a crossing // because we don't want to double-count adjacent crossings // UNLESS the polygon turns past vertical at exactly this x // Note that this is repeated below, but we can't factor it out // because if(x !== xmini) crossings++; } // inside the bounding box, check the actual line intercept else { // vertical segment - we know already that the point is exactly // on the segment, so mark the crossing as exactly at the point. if(x1 === x0) ycross = y; // any other angle else ycross = y0 + (x - x0) * (y1 - y0) / (x1 - x0); // exactly on the edge: counts as inside the polygon, unless it's the // first edge and we're omitting it. if(y === ycross) { if(i === 1 && omitFirstEdge) return false; return true; } if(y <= ycross && x !== xmini) crossings++; } } // if we've gotten this far, odd crossings means inside, even is outside return crossings % 2 === 1; } return { xmin: xmin, xmax: xmax, ymin: ymin, ymax: ymax, pts: pts, contains: isRect ? rectContains : contains, isRect: isRect }; }; /** * Test if a segment of a points array is bent or straight * * @param pts Array of [x, y] pairs * @param start the index of the proposed start of the straight section * @param end the index of the proposed end point * @param tolerance the max distance off the line connecting start and end * before the line counts as bent * @returns boolean: true means this segment is bent, false means straight */ var isBent = polygon.isSegmentBent = function isBent(pts, start, end, tolerance) { var startPt = pts[start], segment = [pts[end][0] - startPt[0], pts[end][1] - startPt[1]], segmentSquared = dot(segment, segment), segmentLen = Math.sqrt(segmentSquared), unitPerp = [-segment[1] / segmentLen, segment[0] / segmentLen], i, part, partParallel; for(i = start + 1; i < end; i++) { part = [pts[i][0] - startPt[0], pts[i][1] - startPt[1]]; partParallel = dot(part, segment); if(partParallel < 0 || partParallel > segmentSquared || Math.abs(dot(part, unitPerp)) > tolerance) return true; } return false; }; /** * Make a filtering polygon, to minimize the number of segments * * @param pts Array of [x, y] pairs (must start with at least 1 pair) * @param tolerance the maximum deviation from straight allowed for * removing points to simplify the polygon * * @returns Object {addPt, raw, filtered} * addPt is a function(pt: [x, y] pair) to add a raw point and * continue filtering * raw is all the input points * filtered is the resulting filtered Array of [x, y] pairs */ polygon.filter = function filter(pts, tolerance) { var ptsFiltered = [pts[0]], doneRawIndex = 0, doneFilteredIndex = 0; function addPt(pt) { pts.push(pt); var prevFilterLen = ptsFiltered.length, iLast = doneRawIndex; ptsFiltered.splice(doneFilteredIndex + 1); for(var i = iLast + 1; i < pts.length; i++) { if(i === pts.length - 1 || isBent(pts, iLast, i + 1, tolerance)) { ptsFiltered.push(pts[i]); if(ptsFiltered.length < prevFilterLen - 2) { doneRawIndex = i; doneFilteredIndex = ptsFiltered.length - 1; } iLast = i; } } } if(pts.length > 1) { var lastPt = pts.pop(); addPt(lastPt); } return { addPt: addPt, raw: pts, filtered: ptsFiltered }; }; },{"./matrix":351}],355:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../plotly'); /** * Copy arg array *without* removing `undefined` values from objects. * * @param gd * @param args * @returns {Array} */ function copyArgArray(gd, args) { var copy = []; var arg; for(var i = 0; i < args.length; i++) { arg = args[i]; if(arg === gd) copy[i] = arg; else if(typeof arg === 'object') { copy[i] = Array.isArray(arg) ? Plotly.Lib.extendDeep([], arg) : Plotly.Lib.extendDeepAll({}, arg); } else copy[i] = arg; } return copy; } // ----------------------------------------------------- // Undo/Redo queue for plots // ----------------------------------------------------- var queue = {}; // TODO: disable/enable undo and redo buttons appropriately /** * Add an item to the undoQueue for a graphDiv * * @param gd * @param undoFunc Function undo this operation * @param undoArgs Args to supply undoFunc with * @param redoFunc Function to redo this operation * @param redoArgs Args to supply redoFunc with */ queue.add = function(gd, undoFunc, undoArgs, redoFunc, redoArgs) { var queueObj, queueIndex; // make sure we have the queue and our position in it gd.undoQueue = gd.undoQueue || {index: 0, queue: [], sequence: false}; queueIndex = gd.undoQueue.index; // if we're already playing an undo or redo, or if this is an auto operation // (like pane resize... any others?) then we don't save this to the undo queue if(gd.autoplay) { if(!gd.undoQueue.inSequence) gd.autoplay = false; return; } // if we're not in a sequence or are just starting, we need a new queue item if(!gd.undoQueue.sequence || gd.undoQueue.beginSequence) { queueObj = {undo: {calls: [], args: []}, redo: {calls: [], args: []}}; gd.undoQueue.queue.splice(queueIndex, gd.undoQueue.queue.length - queueIndex, queueObj); gd.undoQueue.index += 1; } else { queueObj = gd.undoQueue.queue[queueIndex - 1]; } gd.undoQueue.beginSequence = false; // we unshift to handle calls for undo in a forward for loop later queueObj.undo.calls.unshift(undoFunc); queueObj.undo.args.unshift(undoArgs); queueObj.redo.calls.push(redoFunc); queueObj.redo.args.push(redoArgs); }; /** * Begin a sequence of undoQueue changes * * @param gd */ queue.startSequence = function(gd) { gd.undoQueue = gd.undoQueue || {index: 0, queue: [], sequence: false}; gd.undoQueue.sequence = true; gd.undoQueue.beginSequence = true; }; /** * Stop a sequence of undoQueue changes * * Call this *after* you're sure your undo chain has ended * * @param gd */ queue.stopSequence = function(gd) { gd.undoQueue = gd.undoQueue || {index: 0, queue: [], sequence: false}; gd.undoQueue.sequence = false; gd.undoQueue.beginSequence = false; }; /** * Move one step back in the undo queue, and undo the object there. * * @param gd */ queue.undo = function undo(gd) { var queueObj, i; if(gd.framework && gd.framework.isPolar) { gd.framework.undo(); return; } if(gd.undoQueue === undefined || isNaN(gd.undoQueue.index) || gd.undoQueue.index <= 0) { return; } // index is pointing to next *forward* queueObj, point to the one we're undoing gd.undoQueue.index--; // get the queueObj for instructions on how to undo queueObj = gd.undoQueue.queue[gd.undoQueue.index]; // this sequence keeps things from adding to the queue during undo/redo gd.undoQueue.inSequence = true; for(i = 0; i < queueObj.undo.calls.length; i++) { queue.plotDo(gd, queueObj.undo.calls[i], queueObj.undo.args[i]); } gd.undoQueue.inSequence = false; gd.autoplay = false; }; /** * Redo the current object in the undo, then move forward in the queue. * * @param gd */ queue.redo = function redo(gd) { var queueObj, i; if(gd.framework && gd.framework.isPolar) { gd.framework.redo(); return; } if(gd.undoQueue === undefined || isNaN(gd.undoQueue.index) || gd.undoQueue.index >= gd.undoQueue.queue.length) { return; } // get the queueObj for instructions on how to undo queueObj = gd.undoQueue.queue[gd.undoQueue.index]; // this sequence keeps things from adding to the queue during undo/redo gd.undoQueue.inSequence = true; for(i = 0; i < queueObj.redo.calls.length; i++) { queue.plotDo(gd, queueObj.redo.calls[i], queueObj.redo.args[i]); } gd.undoQueue.inSequence = false; gd.autoplay = false; // index is pointing to the thing we just redid, move it gd.undoQueue.index++; }; /** * Called by undo/redo to make the actual changes. * * Not meant to be called publically, but included for mocking out in tests. * * @param gd * @param func * @param args */ queue.plotDo = function(gd, func, args) { gd.autoplay = true; // this *won't* copy gd and it preserves `undefined` properties! args = copyArgArray(gd, args); // call the supplied function func.apply(null, args); }; module.exports = queue; },{"../plotly":366}],356:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); /** * findBin - find the bin for val - note that it can return outside the * bin range any pos. or neg. integer for linear bins, or -1 or * bins.length-1 for explicit. * bins is either an object {start,size,end} or an array length #bins+1 * bins can be either increasing or decreasing but must be monotonic * for linear bins, we can just calculate. For listed bins, run a binary * search linelow (truthy) says the bin boundary should be attributed to * the lower bin rather than the default upper bin */ exports.findBin = function(val, bins, linelow) { if(isNumeric(bins.start)) { return linelow ? Math.ceil((val - bins.start) / bins.size) - 1 : Math.floor((val - bins.start) / bins.size); } else { var n1 = 0, n2 = bins.length, c = 0, n, test; if(bins[bins.length - 1] >= bins[0]) { test = linelow ? lessThan : lessOrEqual; } else { test = linelow ? greaterOrEqual : greaterThan; } // c is just to avoid infinite loops if there's an error while(n1 < n2 && c++ < 100) { n = Math.floor((n1 + n2) / 2); if(test(bins[n], val)) n1 = n + 1; else n2 = n; } if(c > 90) console.log('Long binary search...'); return n1 - 1; } }; function lessThan(a, b) { return a < b; } function lessOrEqual(a, b) { return a <= b; } function greaterThan(a, b) { return a > b; } function greaterOrEqual(a, b) { return a >= b; } exports.sorterAsc = function(a, b) { return a - b; }; exports.sorterDes = function(a, b) { return b - a; }; /** * find distinct values in an array, lumping together ones that appear to * just be off by a rounding error * return the distinct values and the minimum difference between any two */ exports.distinctVals = function(valsIn) { var vals = valsIn.slice(); // otherwise we sort the original array... vals.sort(exports.sorterAsc); var l = vals.length - 1, minDiff = (vals[l] - vals[0]) || 1, errDiff = minDiff / (l || 1) / 10000, v2 = [vals[0]]; for(var i = 0; i < l; i++) { // make sure values aren't just off by a rounding error if(vals[i + 1] > vals[i] + errDiff) { minDiff = Math.min(minDiff, vals[i + 1] - vals[i]); v2.push(vals[i + 1]); } } return {vals: v2, minDiff: minDiff}; }; /** * return the smallest element from (sorted) array arrayIn that's bigger than val, * or (reverse) the largest element smaller than val * used to find the best tick given the minimum (non-rounded) tick * particularly useful for date/time where things are not powers of 10 * binary search is probably overkill here... */ exports.roundUp = function(val, arrayIn, reverse) { var low = 0, high = arrayIn.length - 1, mid, c = 0, dlow = reverse ? 0 : 1, dhigh = reverse ? 1 : 0, rounded = reverse ? Math.ceil : Math.floor; // c is just to avoid infinite loops if there's an error while(low < high && c++ < 100) { mid = rounded((low + high) / 2); if(arrayIn[mid] <= val) low = mid + dlow; else high = mid - dhigh; } return arrayIn[low]; }; },{"fast-isnumeric":74}],357:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../plotly'); var noop = function() {}; /** * Prints a no webgl error message into the scene container * @param {scene instance} scene * * Expects 'scene' to have property 'container' * */ module.exports = function showWebGlMsg(scene) { for(var prop in scene) { if(typeof scene[prop] === 'function') scene[prop] = noop; } scene.destroy = function() { scene.container.parentNode.removeChild(scene.container); }; var div = document.createElement('div'); div.textContent = 'Webgl is not supported by your browser - visit http://get.webgl.org for more info'; div.style.cursor = 'pointer'; div.style.fontSize = '24px'; div.style.color = Plotly.Color.defaults[0]; scene.container.appendChild(div); scene.container.style.background = '#FFFFFF'; scene.container.onclick = function() { window.open('http://get.webgl.org'); }; // return before setting up camera and onrender methods return false; }; },{"../plotly":366}],358:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); /** * aggNums() returns the result of an aggregate function applied to an array of * values, where non-numerical values have been tossed out. * * @param {function} f - aggregation function (e.g., Math.min) * @param {Number} v - initial value (continuing from previous calls) * if there's no continuing value, use null for selector-type * functions (max,min), or 0 for summations * @param {Array} a - array to aggregate (may be nested, we will recurse, * but all elements must have the same dimension) * @param {Number} len - maximum length of a to aggregate * @return {Number} - result of f applied to a starting from v */ exports.aggNums = function(f, v, a, len) { var i, b; if(!len) len = a.length; if(!isNumeric(v)) v = false; if(Array.isArray(a[0])) { b = new Array(len); for(i = 0; i < len; i++) b[i] = exports.aggNums(f, v, a[i]); a = b; } for(i = 0; i < len; i++) { if(!isNumeric(v)) v = a[i]; else if(isNumeric(a[i])) v = f(+v, +a[i]); } return v; }; /** * mean & std dev functions using aggNums, so it handles non-numerics nicely * even need to use aggNums instead of .length, to toss out non-numerics */ exports.len = function(data) { return exports.aggNums(function(a) { return a + 1; }, 0, data); }; exports.mean = function(data, len) { if(!len) len = exports.len(data); return exports.aggNums(function(a, b) { return a + b; }, 0, data) / len; }; exports.variance = function(data, len, mean) { if(!len) len = exports.len(data); if(!isNumeric(mean)) mean = exports.mean(data, len); return exports.aggNums(function(a, b) { return a + Math.pow(b - mean, 2); }, 0, data)/len; }; exports.stdev = function(data, len, mean) { return Math.sqrt(exports.variance(data, len, mean)); }; /** * interp() computes a percentile (quantile) for a given distribution. * We interpolate the distribution (to compute quantiles, we follow method #10 here: * http://www.amstat.org/publications/jse/v14n3/langford.html). * Typically the index or rank (n * arr.length) may be non-integer. * For reference: ends are clipped to the extreme values in the array; * For box plots: index you get is half a point too high (see * http://en.wikipedia.org/wiki/Percentile#Nearest_rank) but note that this definition * indexes from 1 rather than 0, so we subtract 1/2 (instead of add). * * @param {Array} arr - This array contains the values that make up the distribution. * @param {Number} n - Between 0 and 1, n = p/100 is such that we compute the p^th percentile. * For example, the 50th percentile (or median) corresponds to n = 0.5 * @return {Number} - percentile */ exports.interp = function(arr, n) { if(!isNumeric(n)) throw 'n should be a finite number'; n = n * arr.length - 0.5; if(n < 0) return arr[0]; if(n > arr.length - 1) return arr[arr.length - 1]; var frac = n % 1; return frac * arr[Math.ceil(n)] + (1 - frac) * arr[Math.floor(n)]; }; },{"fast-isnumeric":74}],359:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var tinycolor = require('tinycolor2'); var arrtools = require('arraytools'); function str2RgbaArray(color) { color = tinycolor(color); return arrtools.str2RgbaArray(color.toRgbString()); } module.exports = str2RgbaArray; },{"arraytools":48,"tinycolor2":229}],360:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /* global MathJax:false */ var Plotly = require('../plotly'); var d3 = require('d3'); var xmlnsNamespaces = require('../constants/xmlns_namespaces'); var util = module.exports = {}; // Append SVG d3.selection.prototype.appendSVG = function(_svgString) { var skeleton = [ '', _svgString, '' ].join(''); var dom = new DOMParser().parseFromString(skeleton, 'application/xml'), childNode = dom.documentElement.firstChild; while(childNode) { this.node().appendChild(this.node().ownerDocument.importNode(childNode, true)); childNode = childNode.nextSibling; } if(dom.querySelector('parsererror')) { console.log(dom.querySelector('parsererror div').textContent); return null; } return d3.select(this.node().lastChild); }; // Text utilities util.html_entity_decode = function(s) { var hiddenDiv = d3.select('body').append('div').style({display: 'none'}).html(''); var replaced = s.replace(/(&[^;]*;)/gi, function(d) { if(d==='<') { return '<'; } // special handling for brackets if(d==='&rt;') { return '>'; } return hiddenDiv.html(d).text(); // everything else, let the browser decode it to unicode }); hiddenDiv.remove(); return replaced; }; util.xml_entity_encode = function(str) { return str.replace(/&(?!\w+;|\#[0-9]+;| \#x[0-9A-F]+;)/g,'&'); }; // text converter function getSize(_selection, _dimension) { return _selection.node().getBoundingClientRect()[_dimension]; } util.convertToTspans = function(_context, _callback) { var str = _context.text(); var converted = convertToSVG(str); var that = _context; // Until we get tex integrated more fully (so it can be used along with non-tex) // allow some elements to prohibit it by attaching 'data-notex' to the original var tex = (!that.attr('data-notex')) && converted.match(/([^$]*)([$]+[^$]*[$]+)([^$]*)/); var result = str; var parent = d3.select(that.node().parentNode); if(parent.empty()) return; var svgClass = (that.attr('class')) ? that.attr('class').split(' ')[0] : 'text'; svgClass += '-math'; parent.selectAll('svg.' + svgClass).remove(); parent.selectAll('g.' + svgClass + '-group').remove(); _context.style({visibility: null}); for(var up = _context.node(); up && up.removeAttribute; up = up.parentNode) { up.removeAttribute('data-bb'); } function showText() { if(!parent.empty()) { svgClass = that.attr('class') + '-math'; parent.select('svg.' + svgClass).remove(); } _context.text('') .style({ visibility: 'visible', 'white-space': 'pre' }); result = _context.appendSVG(converted); if(!result) _context.text(str); if(_context.select('a').size()) { // at least in Chrome, pointer-events does not seem // to be honored in children of elements // so if we have an anchor, we have to make the // whole element respond _context.style('pointer-events', 'all'); } if(_callback) _callback.call(that); } if(tex) { var td = Plotly.Lib.getPlotDiv(that.node()); ((td && td._promises)||[]).push(new Promise(function(resolve) { that.style({visibility: 'hidden'}); var config = {fontSize: parseInt(that.style('font-size'), 10)}; texToSVG(tex[2], config, function(_svgEl, _glyphDefs, _svgBBox) { parent.selectAll('svg.' + svgClass).remove(); parent.selectAll('g.' + svgClass + '-group').remove(); var newSvg = _svgEl && _svgEl.select('svg'); if(!newSvg || !newSvg.node()) { showText(); resolve(); return; } var mathjaxGroup = parent.append('g') .classed(svgClass + '-group', true) .attr({'pointer-events': 'none'}); mathjaxGroup.node().appendChild(newSvg.node()); // stitch the glyph defs if(_glyphDefs && _glyphDefs.node()) { newSvg.node().insertBefore(_glyphDefs.node().cloneNode(true), newSvg.node().firstChild); } newSvg.attr({ 'class': svgClass, height: _svgBBox.height, preserveAspectRatio: 'xMinYMin meet' }) .style({overflow: 'visible', 'pointer-events': 'none'}); var fill = that.style('fill') || 'black'; newSvg.select('g').attr({fill: fill, stroke: fill}); var newSvgW = getSize(newSvg, 'width'), newSvgH = getSize(newSvg, 'height'), newX = +that.attr('x') - newSvgW * {start: 0, middle: 0.5, end: 1}[that.attr('text-anchor') || 'start'], // font baseline is about 1/4 fontSize below centerline textHeight = parseInt(that.style('font-size'), 10) || getSize(that, 'height'), dy = -textHeight/4; if(svgClass[0] === 'y') { mathjaxGroup.attr({ transform: 'rotate(' + [-90, +that.attr('x'), +that.attr('y')] + ') translate(' + [-newSvgW / 2, dy - newSvgH / 2] + ')' }); newSvg.attr({x: +that.attr('x'), y: +that.attr('y')}); } else if(svgClass[0] === 'l') { newSvg.attr({x: that.attr('x'), y: dy - (newSvgH / 2)}); } else if(svgClass[0] === 'a') { newSvg.attr({x: 0, y: dy}); } else { newSvg.attr({x: newX, y: (+that.attr('y') + dy - newSvgH / 2)}); } if(_callback) _callback.call(that, mathjaxGroup); resolve(mathjaxGroup); }); })); } else showText(); return _context; }; // MathJax function cleanEscapesForTex(s) { return s.replace(/(<|<|<)/g, '\\lt ') .replace(/(>|>|>)/g, '\\gt '); } function texToSVG(_texString, _config, _callback) { var randomID = 'math-output-' + Plotly.Lib.randstr([],64); var tmpDiv = d3.select('body').append('div') .attr({id: randomID}) .style({visibility: 'hidden', position: 'absolute'}) .style({'font-size': _config.fontSize + 'px'}) .text(cleanEscapesForTex(_texString)); MathJax.Hub.Queue(['Typeset', MathJax.Hub, tmpDiv.node()], function() { var glyphDefs = d3.select('body').select('#MathJax_SVG_glyphs'); if(tmpDiv.select('.MathJax_SVG').empty() || !tmpDiv.select('svg').node()) { console.log('There was an error in the tex syntax.', _texString); _callback(); } else { var svgBBox = tmpDiv.select('svg').node().getBoundingClientRect(); _callback(tmpDiv.select('.MathJax_SVG'), glyphDefs, svgBBox); } tmpDiv.remove(); }); } var TAG_STYLES = { // would like to use baseline-shift but FF doesn't support it yet // so we need to use dy along with the uber hacky shift-back-to // baseline below sup: 'font-size:70%" dy="-0.6em', sub: 'font-size:70%" dy="0.3em', b: 'font-weight:bold', i: 'font-style:italic', a: '', span: '', br: '', em: 'font-style:italic;font-weight:bold' }; var PROTOCOLS = ['http:', 'https:', 'mailto:']; var STRIP_TAGS = new RegExp(']*)?/?>', 'g'); util.plainText = function(_str) { // strip out our pseudo-html so we have a readable // version to put into text fields return (_str||'').replace(STRIP_TAGS, ' '); }; function convertToSVG(_str) { var htmlEntitiesDecoded = Plotly.util.html_entity_decode(_str); var result = htmlEntitiesDecoded .split(/(<[^<>]*>)/).map(function(d) { var match = d.match(/<(\/?)([^ >]*)\s*(.*)>/i), tag = match && match[2].toLowerCase(), style = TAG_STYLES[tag]; if(style !== undefined) { var close = match[1], extra = match[3], /** * extraStyle: any random extra css (that's supported by svg) * use this like to change font in the middle * * at one point we supported but as this isn't even * valid HTML anymore and we dropped it accidentally for many months, we will not * resurrect it. */ extraStyle = extra.match(/^style\s*=\s*"([^"]+)"\s*/i); // anchor and br are the only ones that don't turn into a tspan if(tag === 'a') { if(close) return ''; else if(extra.substr(0,4).toLowerCase() !== 'href') return ''; else { var dummyAnchor = document.createElement('a'); dummyAnchor.href = extra.substr(4).replace(/["'=]/g, ''); if(PROTOCOLS.indexOf(dummyAnchor.protocol) === -1) return ''; return ''; } } else if(tag === 'br') return '
'; else if(close) { // closing tag // sub/sup: extra tspan with zero-width space to get back to the right baseline if(tag === 'sup') return ''; if(tag === 'sub') return ''; else return ''; } else { var tspanStart = ''; } } else { return Plotly.util.xml_entity_encode(d).replace(/'); index > 0; index = result.indexOf('
', index+1)) { indices.push(index); } var count = 0; indices.forEach(function(d) { var brIndex = d + count; var search = result.slice(0, brIndex); var previousOpenTag = ''; for(var i2=search.length-1; i2>=0; i2--) { var isTag = search[i2].match(/<(\/?).*>/i); if(isTag && search[i2] !== '
') { if(!isTag[1]) previousOpenTag = search[i2]; break; } } if(previousOpenTag) { result.splice(brIndex+1, 0, previousOpenTag); result.splice(brIndex, 0, ''); count += 2; } }); var joined = result.join(''); var splitted = joined.split(/
/gi); if(splitted.length > 1) { result = splitted.map(function(d, i) { // TODO: figure out max font size of this line and alter dy // this requires either: // 1) bringing the base font size into convertToTspans, or // 2) only allowing relative percentage font sizes. // I think #2 is the way to go return ''+ d +''; }); } return result.join(''); } function alignHTMLWith(_base, container, options) { var alignH = options.horizontalAlign, alignV = options.verticalAlign || 'top', bRect = _base.node().getBoundingClientRect(), cRect = container.node().getBoundingClientRect(), thisRect, getTop, getLeft; if(alignV === 'bottom') { getTop = function() { return bRect.bottom - thisRect.height; }; } else if(alignV === 'middle') { getTop = function() { return bRect.top + (bRect.height - thisRect.height) / 2; }; } else { // default: top getTop = function() { return bRect.top; }; } if(alignH === 'right') { getLeft = function() { return bRect.right - thisRect.width; }; } else if(alignH === 'center') { getLeft = function() { return bRect.left + (bRect.width - thisRect.width) / 2; }; } else { // default: left getLeft = function() { return bRect.left; }; } return function() { thisRect = this.node().getBoundingClientRect(); this.style({ top: (getTop() - cRect.top) + 'px', left: (getLeft() - cRect.left) + 'px', 'z-index': 1000 }); return this; }; } // Editable title util.makeEditable = function(context, _delegate, options) { if(!options) options = {}; var that = this; var dispatch = d3.dispatch('edit', 'input', 'cancel'); var textSelection = d3.select(this.node()) .style({'pointer-events': 'all'}); var handlerElement = _delegate || textSelection; if(_delegate) textSelection.style({'pointer-events': 'none'}); function handleClick() { appendEditable(); that.style({opacity: 0}); // also hide any mathjax svg var svgClass = handlerElement.attr('class'), mathjaxClass; if(svgClass) mathjaxClass = '.' + svgClass.split(' ')[0] + '-math-group'; else mathjaxClass = '[class*=-math-group]'; if(mathjaxClass) { d3.select(that.node().parentNode).select(mathjaxClass).style({opacity: 0}); } } function selectElementContents(_el) { var el = _el.node(); var range = document.createRange(); range.selectNodeContents(el); var sel = window.getSelection(); sel.removeAllRanges(); sel.addRange(range); el.focus(); } function appendEditable() { var plotDiv = d3.select(Plotly.Lib.getPlotDiv(that.node())), container = plotDiv.select('.svg-container'), div = container.append('div'); div.classed('plugin-editable editable', true) .style({ position: 'absolute', 'font-family': that.style('font-family') || 'Arial', 'font-size': that.style('font-size') || 12, color: options.fill || that.style('fill') || 'black', opacity: 1, 'background-color': options.background || 'transparent', outline: '#ffffff33 1px solid', margin: [-parseFloat(that.style('font-size'))/8+1, 0, 0, -1].join('px ') + 'px', padding: '0', 'box-sizing': 'border-box' }) .attr({contenteditable: true}) .text(options.text || that.attr('data-unformatted')) .call(alignHTMLWith(that, container, options)) .on('blur', function() { that.text(this.textContent) .style({opacity: 1}); var svgClass = d3.select(this).attr('class'), mathjaxClass; if(svgClass) mathjaxClass = '.' + svgClass.split(' ')[0] + '-math-group'; else mathjaxClass = '[class*=-math-group]'; if(mathjaxClass) { d3.select(that.node().parentNode).select(mathjaxClass).style({opacity: 0}); } var text = this.textContent; d3.select(this).transition().duration(0).remove(); d3.select(document).on('mouseup', null); dispatch.edit.call(that, text); }) .on('focus', function() { var context = this; d3.select(document).on('mouseup', function() { if(d3.event.target === context) return false; if(document.activeElement === div.node()) div.node().blur(); }); }) .on('keyup', function() { if(d3.event.which === 27) { that.style({opacity: 1}); d3.select(this) .style({opacity: 0}) .on('blur', function() { return false; }) .transition().remove(); dispatch.cancel.call(that, this.textContent); } else { dispatch.input.call(that, this.textContent); d3.select(this).call(alignHTMLWith(that, container, options)); } }) .on('keydown', function() { if(d3.event.which === 13) this.blur(); }) .call(selectElementContents); } if(options.immediate) handleClick(); else handlerElement.on('click', handleClick); return d3.rebind(this, dispatch, 'on'); }; },{"../constants/xmlns_namespaces":338,"../plotly":366,"d3":70}],361:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var topojsonUtils = module.exports = {}; var locationmodeToLayer = require('../constants/geo_constants').locationmodeToLayer, topojsonFeature = require('topojson').feature; topojsonUtils.getTopojsonName = function(geoLayout) { return [ geoLayout.scope.replace(/ /g, '-'), '_', geoLayout.resolution.toString(), 'm' ].join(''); }; topojsonUtils.getTopojsonPath = function(topojsonURL, topojsonName) { return topojsonURL + topojsonName + '.json'; }; topojsonUtils.getTopojsonFeatures = function(trace, topojson) { var layer = locationmodeToLayer[trace.locationmode], obj = topojson.objects[layer]; return topojsonFeature(topojson, obj).features; }; },{"../constants/geo_constants":334,"topojson":230}],362:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var m4FromQuat = require('gl-mat4/fromQuat'); var isNumeric = require('fast-isnumeric'); var Plotly = require('../plotly'); var Lib = require('../lib'); var Events = require('../lib/events'); var Queue = require('../lib/queue'); var Plots = require('../plots/plots'); var Fx = require('../plots/cartesian/graph_interact'); var Color = require('../components/color'); var Drawing = require('../components/drawing'); var ErrorBars = require('../components/errorbars'); var Legend = require('../components/legend'); var Shapes = require('../components/shapes'); var Titles = require('../components/titles'); var manageModeBar = require('../components/modebar/manage'); var xmlnsNamespaces = require('../constants/xmlns_namespaces'); /** * Main plot-creation function * * Note: will call makePlotFramework if necessary to create the framework * * @param {string id or DOM element} gd * the id or DOM element of the graph container div * @param {array of objects} data * array of traces, containing the data and display information for each trace * @param {object} layout * object describing the overall display of the plot, * all the stuff that doesn't pertain to any individual trace * @param {object} config * configuration options (see ./plot_config.js for more info) * */ Plotly.plot = function(gd, data, layout, config) { Lib.markTime('in plot'); gd = getGraphDiv(gd); // Events.init is idempotent and bails early if gd has already been init'd Events.init(gd); var okToPlot = Events.triggerHandler(gd, 'plotly_beforeplot', [data, layout, config]); if(okToPlot === false) return Promise.reject(); // if there's no data or layout, and this isn't yet a plotly plot // container, log a warning to help plotly.js users debug if(!data && !layout && !Lib.isPlotDiv(gd)) { console.log('Warning: calling Plotly.plot as if redrawing ' + 'but this container doesn\'t yet have a plot.', gd); } // transfer configuration options to gd until we move over to // a more OO like model setPlotContext(gd, config); if(!layout) layout = {}; // hook class for plots main container (in case of plotly.js // this won't be #embedded-graph or .js-tab-contents) d3.select(gd).classed('js-plotly-plot', true); // off-screen getBoundingClientRect testing space, // in #js-plotly-tester (and stored as gd._tester) // so we can share cached text across tabs Drawing.makeTester(gd); // collect promises for any async actions during plotting // any part of the plotting code can push to gd._promises, then // before we move to the next step, we check that they're all // complete, and empty out the promise list again. gd._promises = []; var graphWasEmpty = ((gd.data || []).length === 0 && Array.isArray(data)); // if there is already data on the graph, append the new data // if you only want to redraw, pass a non-array for data if(Array.isArray(data)) { cleanData(data, gd.data); if(graphWasEmpty) gd.data = data; else gd.data.push.apply(gd.data, data); // for routines outside graph_obj that want a clean tab // (rather than appending to an existing one) gd.empty // is used to determine whether to make a new tab gd.empty = false; } if(!gd.layout || graphWasEmpty) gd.layout = cleanLayout(layout); // if the user is trying to drag the axes, allow new data and layout // to come in but don't allow a replot. if(gd._dragging) { // signal to drag handler that after everything else is done // we need to replot, because something has changed gd._replotPending = true; return Promise.reject(); } else { // we're going ahead with a replot now gd._replotPending = false; } Plots.supplyDefaults(gd); // Polar plots if(data && data[0] && data[0].r) return plotPolar(gd, data, layout); // so we don't try to re-call Plotly.plot from inside // legend and colorbar, if margins changed gd._replotting = true; var hasData = gd._fullData.length > 0; var subplots = Plotly.Axes.getSubplots(gd).join(''), oldSubplots = Object.keys(gd._fullLayout._plots || {}).join(''), hasSameSubplots = (oldSubplots === subplots); // Make or remake the framework (ie container and axes) if we need to // note: if they container already exists and has data, // the new layout gets ignored (as it should) // but if there's no data there yet, it's just a placeholder... // then it should destroy and remake the plot if(hasData) { if(gd.framework !== makePlotFramework || graphWasEmpty || !hasSameSubplots) { gd.framework = makePlotFramework; makePlotFramework(gd); } } else if(!hasSameSubplots) { gd.framework = makePlotFramework; makePlotFramework(gd); } else if(graphWasEmpty) makePlotFramework(gd); var fullLayout = gd._fullLayout; // prepare the data and find the autorange // generate calcdata, if we need to // to force redoing calcdata, just delete it before calling Plotly.plot var recalc = !gd.calcdata || gd.calcdata.length!==(gd.data||[]).length; if(recalc) { doCalcdata(gd); if(gd._context.doubleClick!==false || gd._context.displayModeBar!==false) { Plotly.Axes.saveRangeInitial(gd); } } // in case it has changed, attach fullData traces to calcdata for(var i = 0; i < gd.calcdata.length; i++) { gd.calcdata[i][0].trace = gd._fullData[i]; } /* * start async-friendly code - now we're actually drawing things */ var oldmargins = JSON.stringify(fullLayout._size); // draw anything that can affect margins. // currently this is legend and colorbars function marginPushers() { var calcdata = gd.calcdata; var i, cd, trace; Legend.draw(gd); for(i = 0; i < calcdata.length; i++) { cd = calcdata[i]; trace = cd[0].trace; if(trace.visible !== true || !trace._module.colorbar) { Plots.autoMargin(gd, 'cb'+trace.uid); } else trace._module.colorbar(gd, cd); } Plots.doAutoMargin(gd); return Plots.previousPromises(gd); } function marginPushersAgain() { // in case the margins changed, draw margin pushers again var seq = JSON.stringify(fullLayout._size)===oldmargins ? [] : [marginPushers, layoutStyles]; return Lib.syncOrAsync(seq.concat(Fx.init),gd); } function positionAndAutorange() { if(!recalc) return; var subplots = Plots.getSubplotIds(fullLayout, 'cartesian'), modules = gd._modules; // position and range calculations for traces that // depend on each other ie bars (stacked or grouped) // and boxes (grouped) push each other out of the way var subplotInfo, _module; for(var i = 0; i < subplots.length; i++) { subplotInfo = fullLayout._plots[subplots[i]]; for(var j = 0; j < modules.length; j++) { _module = modules[j]; if(_module.setPositions) _module.setPositions(gd, subplotInfo); } } Lib.markTime('done with bar/box adjustments'); // calc and autorange for errorbars ErrorBars.calc(gd); Lib.markTime('done ErrorBars.calc'); // TODO: autosize extra for text markers return Lib.syncOrAsync([ Shapes.calcAutorange, Plotly.Annotations.calcAutorange, doAutoRange ], gd); } function doAutoRange() { var axList = Plotly.Axes.list(gd, '', true); for(var i = 0; i < axList.length; i++) { Plotly.Axes.doAutoRange(axList[i]); } } function drawAxes() { // draw ticks, titles, and calculate axis scaling (._b, ._m) return Plotly.Axes.doTicks(gd, 'redraw'); } // Now plot the data function drawData() { var calcdata = gd.calcdata; // in case of traces that were heatmaps or contour maps // previously, remove them and their colorbars explicitly for(var i = 0; i < calcdata.length; i++) { var trace = calcdata[i][0].trace, isVisible = (trace.visible === true), uid = trace.uid; if(!isVisible || !Plots.traceIs(trace, '2dMap')) { fullLayout._paper.selectAll( '.hm' + uid + ',.contour' + uid + ',#clip' + uid ).remove(); } if(!isVisible || !trace._module.colorbar) { fullLayout._infolayer.selectAll('.cb' + uid).remove(); } } var plotRegistry = Plots.subplotsRegistry; if(fullLayout._hasGL3D) plotRegistry.gl3d.plot(gd); if(fullLayout._hasGeo) plotRegistry.geo.plot(gd); if(fullLayout._hasGL2D) plotRegistry.gl2d.plot(gd); if(fullLayout._hasCartesian || fullLayout._hasPie) { plotRegistry.cartesian.plot(gd); } // clean up old scenes that no longer have associated data // will this be a performance hit? // styling separate from drawing Plots.style(gd); Lib.markTime('done Plots.style'); // show annotations and shapes Shapes.drawAll(gd); Plotly.Annotations.drawAll(gd); // source links Plots.addLinks(gd); // Mark the first render as complete gd._replotting = false; return Plots.previousPromises(gd); } // An initial paint must be completed before these components can be // correctly sized and the whole plot re-margined. gd._replotting must // be set to false before these will work properly. function finalDraw() { Shapes.drawAll(gd); Plotly.Annotations.drawAll(gd); Legend.draw(gd); } function cleanUp() { // now we're REALLY TRULY done plotting... // so mark it as done and let other procedures call a replot Lib.markTime('done plot'); gd.emit('plotly_afterplot'); } var donePlotting = Lib.syncOrAsync([ Plots.previousPromises, marginPushers, layoutStyles, marginPushersAgain, positionAndAutorange, drawAxes, drawData, finalDraw ], gd, cleanUp); // even if everything we did was synchronous, return a promise // so that the caller doesn't care which route we took return (donePlotting && donePlotting.then) ? donePlotting : Promise.resolve(gd); }; // Get the container div: we store all variables for this plot as // properties of this div // some callers send this in by DOM element, others by id (string) function getGraphDiv(gd) { var gdElement; if(typeof gd === 'string') { gdElement = document.getElementById(gd); if(gdElement === null) { throw new Error('No DOM element with id \'' + gd + '\' exists on the page.'); } return gdElement; } else if(gd===null || gd===undefined) { throw new Error('DOM element provided is null or undefined'); } return gd; // otherwise assume that gd is a DOM element } function opaqueSetBackground(gd, bgColor) { gd._fullLayout._paperdiv.style('background', 'white'); Plotly.defaultConfig.setBackground(gd, bgColor); } function setPlotContext(gd, config) { if(!gd._context) gd._context = Lib.extendFlat({}, Plotly.defaultConfig); var context = gd._context; if(config) { Object.keys(config).forEach(function(key) { if(key in context) { if(key === 'setBackground' && config[key] === 'opaque') { context[key] = opaqueSetBackground; } else context[key] = config[key]; } }); // map plot3dPixelRatio to plotGlPixelRatio for backward compatibility if(config.plot3dPixelRatio && !context.plotGlPixelRatio) { context.plotGlPixelRatio = context.plot3dPixelRatio; } } //staticPlot forces a bunch of others: if(context.staticPlot) { context.editable = false; context.autosizable = false; context.scrollZoom = false; context.doubleClick = false; context.showTips = false; context.showLink = false; context.displayModeBar = false; } } function plotPolar(gd, data, layout) { // build or reuse the container skeleton var plotContainer = d3.select(gd).selectAll('.plot-container') .data([0]); plotContainer.enter() .insert('div', ':first-child') .classed('plot-container plotly', true); var paperDiv = plotContainer.selectAll('.svg-container') .data([0]); paperDiv.enter().append('div') .classed('svg-container',true) .style('position','relative'); // empty it everytime for now paperDiv.html(''); // fulfill gd requirements if(data) gd.data = data; if(layout) gd.layout = layout; Plotly.micropolar.manager.fillLayout(gd); if(gd._fullLayout.autosize === 'initial' && gd._context.autosizable) { plotAutoSize(gd,{}); gd._fullLayout.autosize = layout.autosize = true; } // resize canvas paperDiv.style({ width: gd._fullLayout.width + 'px', height: gd._fullLayout.height + 'px' }); // instantiate framework gd.framework = Plotly.micropolar.manager.framework(gd); // plot gd.framework({data: gd.data, layout: gd.layout}, paperDiv.node()); // set undo point gd.framework.setUndoPoint(); // get the resulting svg for extending it var polarPlotSVG = gd.framework.svg(); // editable title var opacity = 1; var txt = gd._fullLayout.title; if(txt === '' || !txt) opacity = 0; var placeholderText = 'Click to enter title'; var titleLayout = function() { this.call(Plotly.util.convertToTspans); //TODO: html/mathjax //TODO: center title }; var title = polarPlotSVG.select('.title-group text') .call(titleLayout); if(gd._context.editable) { title.attr({'data-unformatted': txt}); if(!txt || txt === placeholderText) { opacity = 0.2; title.attr({'data-unformatted': placeholderText}) .text(placeholderText) .style({opacity: opacity}) .on('mouseover.opacity',function() { d3.select(this).transition().duration(100) .style('opacity',1); }) .on('mouseout.opacity',function() { d3.select(this).transition().duration(1000) .style('opacity',0); }); } var setContenteditable = function() { this.call(Plotly.util.makeEditable) .on('edit', function(text) { gd.framework({layout: {title: text}}); this.attr({'data-unformatted': text}) .text(text) .call(titleLayout); this.call(setContenteditable); }) .on('cancel', function() { var txt = this.attr('data-unformatted'); this.text(txt).call(titleLayout); }); }; title.call(setContenteditable); } gd._context.setBackground(gd, gd._fullLayout.paper_bgcolor); Plots.addLinks(gd); return Promise.resolve(); } function cleanLayout(layout) { // make a few changes to the layout right away // before it gets used for anything // backward compatibility and cleanup of nonstandard options var i, j; if(!layout) layout = {}; // cannot have (x|y)axis1, numbering goes axis, axis2, axis3... if(layout.xaxis1) { if(!layout.xaxis) layout.xaxis = layout.xaxis1; delete layout.xaxis1; } if(layout.yaxis1) { if(!layout.yaxis) layout.yaxis = layout.yaxis1; delete layout.yaxis1; } var axList = Plotly.Axes.list({_fullLayout: layout}); for(i = 0; i < axList.length; i++) { var ax = axList[i]; if(ax.anchor && ax.anchor !== 'free') { ax.anchor = Plotly.Axes.cleanId(ax.anchor); } if(ax.overlaying) ax.overlaying = Plotly.Axes.cleanId(ax.overlaying); // old method of axis type - isdate and islog (before category existed) if(!ax.type) { if(ax.isdate) ax.type='date'; else if(ax.islog) ax.type='log'; else if(ax.isdate===false && ax.islog===false) ax.type='linear'; } if(ax.autorange==='withzero' || ax.autorange==='tozero') { ax.autorange = true; ax.rangemode = 'tozero'; } delete ax.islog; delete ax.isdate; delete ax.categories; // replaced by _categories // prune empty domain arrays made before the new nestedProperty if(emptyContainer(ax, 'domain')) delete ax.domain; // autotick -> tickmode if(ax.autotick !== undefined) { if(ax.tickmode === undefined) { ax.tickmode = ax.autotick ? 'auto' : 'linear'; } delete ax.autotick; } } if(layout.annotations !== undefined && !Array.isArray(layout.annotations)) { console.log('annotations must be an array'); delete layout.annotations; } var annotationsLen = (layout.annotations || []).length; for(i = 0; i < annotationsLen; i++) { var ann = layout.annotations[i]; if(ann.ref) { if(ann.ref==='paper') { ann.xref = 'paper'; ann.yref = 'paper'; } else if(ann.ref==='data') { ann.xref = 'x'; ann.yref = 'y'; } delete ann.ref; } cleanAxRef(ann, 'xref'); cleanAxRef(ann, 'yref'); } if(layout.shapes !== undefined && !Array.isArray(layout.shapes)) { console.log('shapes must be an array'); delete layout.shapes; } var shapesLen = (layout.shapes||[]).length; for(i = 0; i < shapesLen; i++) { var shape = layout.shapes[i]; cleanAxRef(shape, 'xref'); cleanAxRef(shape, 'yref'); } var legend = layout.legend; if(legend) { // check for old-style legend positioning (x or y is +/- 100) if(legend.x > 3) { legend.x = 1.02; legend.xanchor = 'left'; } else if(legend.x < -2) { legend.x = -0.02; legend.xanchor = 'right'; } if(legend.y > 3) { legend.y = 1.02; legend.yanchor = 'bottom'; } else if(legend.y < -2) { legend.y = -0.02; legend.yanchor = 'top'; } } /* * Moved from rotate -> orbit for dragmode */ if(layout.dragmode === 'rotate') layout.dragmode = 'orbit'; // cannot have scene1, numbering goes scene, scene2, scene3... if(layout.scene1) { if(!layout.scene) layout.scene = layout.scene1; delete layout.scene1; } /* * Clean up Scene layouts */ var sceneIds = Plots.getSubplotIds(layout, 'gl3d'); for(i = 0; i < sceneIds.length; i++) { var scene = layout[sceneIds[i]]; // clean old Camera coords var cameraposition = scene.cameraposition; if(Array.isArray(cameraposition) && cameraposition[0].length === 4) { var rotation = cameraposition[0], center = cameraposition[1], radius = cameraposition[2], mat = m4FromQuat([], rotation), eye = []; for(j = 0; j < 3; ++j) { eye[j] = center[i] + radius * mat[2 + 4 * j]; } scene.camera = { eye: {x: eye[0], y: eye[1], z: eye[2]}, center: {x: center[0], y: center[1], z: center[2]}, up: {x: mat[1], y: mat[5], z: mat[9]} }; delete scene.cameraposition; } } // sanitize rgb(fractions) and rgba(fractions) that old tinycolor // supported, but new tinycolor does not because they're not valid css Lib.markTime('finished rest of cleanLayout, starting color'); Color.clean(layout); Lib.markTime('finished cleanLayout color.clean'); return layout; } function cleanAxRef(container, attr) { var valIn = container[attr], axLetter = attr.charAt(0); if(valIn && valIn !== 'paper') { container[attr] = Plotly.Axes.cleanId(valIn, axLetter); } } function cleanData(data, existingData) { // make a few changes to the data right away // before it gets used for anything /* * Enforce unique IDs */ var suids = [], // seen uids --- so we can weed out incoming repeats uids = data.concat(Array.isArray(existingData) ? existingData : []) .filter(function(trace) { return 'uid' in trace; }) .map(function(trace) { return trace.uid; }); for(var tracei = 0; tracei < data.length; tracei++) { var trace = data[tracei]; // assign uids to each trace and detect collisions. if(!('uid' in trace) || suids.indexOf(trace.uid) !== -1) { var newUid, i; for(i=0; i<100; i++) { newUid = Lib.randstr(uids); if(suids.indexOf(newUid)===-1) break; } trace.uid = Lib.randstr(uids); uids.push(trace.uid); } // keep track of already seen uids, so that if there are // doubles we force the trace with a repeat uid to // acquire a new one suids.push(trace.uid); // BACKWARD COMPATIBILITY FIXES // use xbins to bin data in x, and ybins to bin data in y if(trace.type==='histogramy' && 'xbins' in trace && !('ybins' in trace)) { trace.ybins = trace.xbins; delete trace.xbins; } // error_y.opacity is obsolete - merge into color if(trace.error_y && 'opacity' in trace.error_y) { var dc = Color.defaults, yeColor = trace.error_y.color || (Plots.traceIs(trace, 'bar') ? Color.defaultLine : dc[tracei % dc.length]); trace.error_y.color = Color.addOpacity( Color.rgb(yeColor), Color.opacity(yeColor) * trace.error_y.opacity); delete trace.error_y.opacity; } // convert bardir to orientation, and put the data into // the axes it's eventually going to be used with if('bardir' in trace) { if(trace.bardir==='h' && (Plots.traceIs(trace, 'bar') || trace.type.substr(0,9)==='histogram')) { trace.orientation = 'h'; swapXYData(trace); } delete trace.bardir; } // now we have only one 1D histogram type, and whether // it uses x or y data depends on trace.orientation if(trace.type==='histogramy') swapXYData(trace); if(trace.type==='histogramx' || trace.type==='histogramy') { trace.type = 'histogram'; } // scl->scale, reversescl->reversescale if('scl' in trace) { trace.colorscale = trace.scl; delete trace.scl; } if('reversescl' in trace) { trace.reversescale = trace.reversescl; delete trace.reversescl; } // axis ids x1 -> x, y1-> y if(trace.xaxis) trace.xaxis = Plotly.Axes.cleanId(trace.xaxis, 'x'); if(trace.yaxis) trace.yaxis = Plotly.Axes.cleanId(trace.yaxis, 'y'); // scene ids scene1 -> scene if(Plots.traceIs(trace, 'gl3d') && trace.scene) { trace.scene = Plots.subplotsRegistry.gl3d.cleanId(trace.scene); } if(!Plots.traceIs(trace, 'pie')) { if(Array.isArray(trace.textposition)) { trace.textposition = trace.textposition.map(cleanTextPosition); } else if(trace.textposition) { trace.textposition = cleanTextPosition(trace.textposition); } } // fix typo in colorscale definition if(Plots.traceIs(trace, '2dMap')) { if(trace.colorscale === 'YIGnBu') trace.colorscale = 'YlGnBu'; if(trace.colorscale === 'YIOrRd') trace.colorscale = 'YlOrRd'; } if(Plots.traceIs(trace, 'markerColorscale') && trace.marker) { var cont = trace.marker; if(cont.colorscale === 'YIGnBu') cont.colorscale = 'YlGnBu'; if(cont.colorscale === 'YIOrRd') cont.colorscale = 'YlOrRd'; } // prune empty containers made before the new nestedProperty if(emptyContainer(trace, 'line')) delete trace.line; if('marker' in trace) { if(emptyContainer(trace.marker, 'line')) delete trace.marker.line; if(emptyContainer(trace, 'marker')) delete trace.marker; } // sanitize rgb(fractions) and rgba(fractions) that old tinycolor // supported, but new tinycolor does not because they're not valid css Lib.markTime('finished rest of cleanData, starting color'); Color.clean(trace); Lib.markTime('finished cleanData color.clean'); } } // textposition - support partial attributes (ie just 'top') // and incorrect use of middle / center etc. function cleanTextPosition(textposition) { var posY = 'middle', posX = 'center'; if(textposition.indexOf('top')!==-1) posY = 'top'; else if(textposition.indexOf('bottom')!==-1) posY = 'bottom'; if(textposition.indexOf('left')!==-1) posX = 'left'; else if(textposition.indexOf('right')!==-1) posX = 'right'; return posY + ' ' + posX; } function emptyContainer(outer, innerStr) { return (innerStr in outer) && (typeof outer[innerStr] === 'object') && (Object.keys(outer[innerStr]).length === 0); } // convenience function to force a full redraw, mostly for use by plotly.js Plotly.redraw = function(gd) { gd = getGraphDiv(gd); if(!Lib.isPlotDiv(gd)) { console.log('This element is not a Plotly Plot', gd); return; } gd.calcdata = undefined; return Plotly.plot(gd).then(function() { gd.emit('plotly_redraw'); return gd; }); }; /** * Convenience function to make idempotent plot option obvious to users. * * @param gd * @param {Object[]} data * @param {Object} layout * @param {Object} config */ Plotly.newPlot = function(gd, data, layout, config) { gd = getGraphDiv(gd); Plots.purge(gd); return Plotly.plot(gd, data, layout, config); }; function doCalcdata(gd) { var axList = Plotly.Axes.list(gd), fullData = gd._fullData, fullLayout = gd._fullLayout; var i, trace, module, cd; var calcdata = gd.calcdata = new Array(fullData.length); // extra helper variables // firstscatter: fill-to-next on the first trace goes to zero gd.firstscatter = true; // how many box plots do we have (in case they're grouped) gd.numboxes = 0; // for calculating avg luminosity of heatmaps gd._hmpixcount = 0; gd._hmlumcount = 0; // for sharing colors across pies (and for legend) fullLayout._piecolormap = {}; fullLayout._piedefaultcolorcount = 0; // delete category list, if there is one, so we start over // to be filled in later by ax.d2c for(i = 0; i < axList.length; i++) { axList[i]._categories = []; } for(i = 0; i < fullData.length; i++) { trace = fullData[i]; module = trace._module; cd = []; if(module && trace.visible === true) { if(module.calc) cd = module.calc(gd, trace); } // make sure there is a first point // this ensures there is a calcdata item for every trace, // even if cartesian logic doesn't handle it if(!Array.isArray(cd) || !cd[0]) cd = [{x: false, y: false}]; // add the trace-wide properties to the first point, // per point properties to every point // t is the holder for trace-wide properties if(!cd[0].t) cd[0].t = {}; cd[0].trace = trace; Lib.markTime('done with calcdata for '+i); calcdata[i] = cd; } } /** * Wrap negative indicies to their positive counterparts. * * @param {Number[]} indices An array of indices * @param {Number} maxIndex The maximum index allowable (arr.length - 1) */ function positivifyIndices(indices, maxIndex) { var parentLength = maxIndex + 1, positiveIndices = [], i, index; for(i = 0; i < indices.length; i++) { index = indices[i]; if(index < 0) { positiveIndices.push(parentLength + index); } else { positiveIndices.push(index); } } return positiveIndices; } /** * Ensures that an index array for manipulating gd.data is valid. * * Intended for use with addTraces, deleteTraces, and moveTraces. * * @param gd * @param indices * @param arrayName */ function assertIndexArray(gd, indices, arrayName) { var i, index; for(i = 0; i < indices.length; i++) { index = indices[i]; // validate that indices are indeed integers if(index !== parseInt(index, 10)) { throw new Error('all values in ' + arrayName + ' must be integers'); } // check that all indices are in bounds for given gd.data array length if(index >= gd.data.length || index < -gd.data.length) { throw new Error(arrayName + ' must be valid indices for gd.data.'); } // check that indices aren't repeated if(indices.indexOf(index, i + 1) > -1 || index >= 0 && indices.indexOf(-gd.data.length + index) > -1 || index < 0 && indices.indexOf(gd.data.length + index) > -1) { throw new Error('each index in ' + arrayName + ' must be unique.'); } } } /** * Private function used by Plotly.moveTraces to check input args * * @param gd * @param currentIndices * @param newIndices */ function checkMoveTracesArgs(gd, currentIndices, newIndices) { // check that gd has attribute 'data' and 'data' is array if(!Array.isArray(gd.data)) { throw new Error('gd.data must be an array.'); } // validate currentIndices array if(typeof currentIndices === 'undefined') { throw new Error('currentIndices is a required argument.'); } else if(!Array.isArray(currentIndices)) { currentIndices = [currentIndices]; } assertIndexArray(gd, currentIndices, 'currentIndices'); // validate newIndices array if it exists if(typeof newIndices !== 'undefined' && !Array.isArray(newIndices)) { newIndices = [newIndices]; } if(typeof newIndices !== 'undefined') { assertIndexArray(gd, newIndices, 'newIndices'); } // check currentIndices and newIndices are the same length if newIdices exists if(typeof newIndices !== 'undefined' && currentIndices.length !== newIndices.length) { throw new Error('current and new indices must be of equal length.'); } } /** * A private function to reduce the type checking clutter in addTraces. * * @param gd * @param traces * @param newIndices */ function checkAddTracesArgs(gd, traces, newIndices) { var i, value; // check that gd has attribute 'data' and 'data' is array if(!Array.isArray(gd.data)) { throw new Error('gd.data must be an array.'); } // make sure traces exists if(typeof traces === 'undefined') { throw new Error('traces must be defined.'); } // make sure traces is an array if(!Array.isArray(traces)) { traces = [traces]; } // make sure each value in traces is an object for(i = 0; i < traces.length; i++) { value = traces[i]; if(typeof value !== 'object' || (Array.isArray(value) || value === null)) { throw new Error('all values in traces array must be non-array objects'); } } // make sure we have an index for each trace if(typeof newIndices !== 'undefined' && !Array.isArray(newIndices)) { newIndices = [newIndices]; } if(typeof newIndices !== 'undefined' && newIndices.length !== traces.length) { throw new Error( 'if indices is specified, traces.length must equal indices.length' ); } } /** * A private function to reduce the type checking clutter in spliceTraces. * Get all update Properties from gd.data. Validate inputs and outputs. * Used by prependTrace and extendTraces * * @param gd * @param update * @param indices * @param maxPoints */ function assertExtendTracesArgs(gd, update, indices, maxPoints) { var maxPointsIsObject = Lib.isPlainObject(maxPoints); if(!Array.isArray(gd.data)) { throw new Error('gd.data must be an array'); } if(!Lib.isPlainObject(update)) { throw new Error('update must be a key:value object'); } if(typeof indices === 'undefined') { throw new Error('indices must be an integer or array of integers'); } assertIndexArray(gd, indices, 'indices'); for(var key in update) { /* * Verify that the attribute to be updated contains as many trace updates * as indices. Failure must result in throw and no-op */ if(!Array.isArray(update[key]) || update[key].length !== indices.length) { throw new Error('attribute ' + key + ' must be an array of length equal to indices array length'); } /* * if maxPoints is an object it must match keys and array lengths of 'update' 1:1 */ if(maxPointsIsObject && (!(key in maxPoints) || !Array.isArray(maxPoints[key]) || maxPoints[key].length !== update[key].length)) { throw new Error('when maxPoints is set as a key:value object it must contain a 1:1 ' + 'corrispondence with the keys and number of traces in the update object'); } } } /** * A private function to reduce the type checking clutter in spliceTraces. * * @param {Object|HTMLDivElement} gd * @param {Object} update * @param {Number[]} indices * @param {Number||Object} maxPoints * @return {Object[]} */ function getExtendProperties(gd, update, indices, maxPoints) { var maxPointsIsObject = Lib.isPlainObject(maxPoints), updateProps = []; var trace, target, prop, insert, maxp; // allow scalar index to represent a single trace position if(!Array.isArray(indices)) indices = [indices]; // negative indices are wrapped around to their positive value. Equivalent to python indexing. indices = positivifyIndices(indices, gd.data.length - 1); // loop through all update keys and traces and harvest validated data. for(var key in update) { for(var j = 0; j < indices.length; j++) { /* * Choose the trace indexed by the indices map argument and get the prop setter-getter * instance that references the key and value for this particular trace. */ trace = gd.data[indices[j]]; prop = Lib.nestedProperty(trace, key); /* * Target is the existing gd.data.trace.dataArray value like "x" or "marker.size" * Target must exist as an Array to allow the extend operation to be performed. */ target = prop.get(); insert = update[key][j]; if(!Array.isArray(insert)) { throw new Error('attribute: ' + key + ' index: ' + j + ' must be an array'); } if(!Array.isArray(target)) { throw new Error('cannot extend missing or non-array attribute: ' + key); } /* * maxPoints may be an object map or a scalar. If object select the key:value, else * Use the scalar maxPoints for all key and trace combinations. */ maxp = maxPointsIsObject ? maxPoints[key][j] : maxPoints; // could have chosen null here, -1 just tells us to not take a window if(!isNumeric(maxp)) maxp = -1; /* * Wrap the nestedProperty in an object containing required data * for lengthening and windowing this particular trace - key combination. * Flooring maxp mirrors the behaviour of floats in the Array.slice JSnative function. */ updateProps.push({ prop: prop, target: target, insert: insert, maxp: Math.floor(maxp) }); } } // all target and insertion data now validated return updateProps; } /** * A private function to key Extend and Prepend traces DRY * * @param {Object|HTMLDivElement} gd * @param {Object} update * @param {Number[]} indices * @param {Number||Object} maxPoints * @param {Function} lengthenArray * @param {Function} spliceArray * @return {Object} */ function spliceTraces(gd, update, indices, maxPoints, lengthenArray, spliceArray) { assertExtendTracesArgs(gd, update, indices, maxPoints); var updateProps = getExtendProperties(gd, update, indices, maxPoints), remainder = [], undoUpdate = {}, undoPoints = {}; var target, prop, maxp; for(var i = 0; i < updateProps.length; i++) { /* * prop is the object returned by Lib.nestedProperties */ prop = updateProps[i].prop; maxp = updateProps[i].maxp; target = lengthenArray(updateProps[i].target, updateProps[i].insert); /* * If maxp is set within post-extension trace.length, splice to maxp length. * Otherwise skip function call as splice op will have no effect anyway. */ if(maxp >= 0 && maxp < target.length) remainder = spliceArray(target, maxp); /* * to reverse this operation we need the size of the original trace as the reverse * operation will need to window out any lengthening operation performed in this pass. */ maxp = updateProps[i].target.length; /* * Magic happens here! update gd.data.trace[key] with new array data. */ prop.set(target); if(!Array.isArray(undoUpdate[prop.astr])) undoUpdate[prop.astr] = []; if(!Array.isArray(undoPoints[prop.astr])) undoPoints[prop.astr] = []; /* * build the inverse update object for the undo operation */ undoUpdate[prop.astr].push(remainder); /* * build the matching maxPoints undo object containing original trace lengths. */ undoPoints[prop.astr].push(maxp); } return {update: undoUpdate, maxPoints: undoPoints}; } /** * extend && prepend traces at indices with update arrays, window trace lengths to maxPoints * * Extend and Prepend have identical APIs. Prepend inserts an array at the head while Extend * inserts an array off the tail. Prepend truncates the tail of the array - counting maxPoints * from the head, whereas Extend truncates the head of the array, counting backward maxPoints * from the tail. * * If maxPoints is undefined, nonNumeric, negative or greater than extended trace length no * truncation / windowing will be performed. If its zero, well the whole trace is truncated. * * @param {Object|HTMLDivElement} gd The graph div * @param {Object} update The key:array map of target attributes to extend * @param {Number|Number[]} indices The locations of traces to be extended * @param {Number|Object} [maxPoints] Number of points for trace window after lengthening. * */ Plotly.extendTraces = function extendTraces(gd, update, indices, maxPoints) { gd = getGraphDiv(gd); var undo = spliceTraces(gd, update, indices, maxPoints, /* * The Lengthen operation extends trace from end with insert */ function(target, insert) { return target.concat(insert); }, /* * Window the trace keeping maxPoints, counting back from the end */ function(target, maxPoints) { return target.splice(0, target.length - maxPoints); }); var promise = Plotly.redraw(gd); var undoArgs = [gd, undo.update, indices, undo.maxPoints]; if(Queue) { Queue.add(gd, Plotly.prependTraces, undoArgs, extendTraces, arguments); } return promise; }; Plotly.prependTraces = function prependTraces(gd, update, indices, maxPoints) { gd = getGraphDiv(gd); var undo = spliceTraces(gd, update, indices, maxPoints, /* * The Lengthen operation extends trace by appending insert to start */ function(target, insert) { return insert.concat(target); }, /* * Window the trace keeping maxPoints, counting forward from the start */ function(target, maxPoints) { return target.splice(maxPoints, target.length); }); var promise = Plotly.redraw(gd); var undoArgs = [gd, undo.update, indices, undo.maxPoints]; if(Queue) { Queue.add(gd, Plotly.extendTraces, undoArgs, prependTraces, arguments); } return promise; }; /** * Add data traces to an existing graph div. * * @param {Object|HTMLDivElement} gd The graph div * @param {Object[]} gd.data The array of traces we're adding to * @param {Object[]|Object} traces The object or array of objects to add * @param {Number[]|Number} [newIndices=[gd.data.length]] Locations to add traces * */ Plotly.addTraces = function addTraces(gd, traces, newIndices) { gd = getGraphDiv(gd); var currentIndices = [], undoFunc = Plotly.deleteTraces, redoFunc = addTraces, undoArgs = [gd, currentIndices], redoArgs = [gd, traces], // no newIndices here i, promise; // all validation is done elsewhere to remove clutter here checkAddTracesArgs(gd, traces, newIndices); // make sure traces is an array if(!Array.isArray(traces)) { traces = [traces]; } cleanData(traces, gd.data); // add the traces to gd.data (no redrawing yet!) for(i = 0; i < traces.length; i += 1) { gd.data.push(traces[i]); } // to continue, we need to call moveTraces which requires currentIndices for(i = 0; i < traces.length; i++) { currentIndices.push(-traces.length + i); } // if the user didn't define newIndices, they just want the traces appended // i.e., we can simply redraw and be done if(typeof newIndices === 'undefined') { promise = Plotly.redraw(gd); if(Queue) Queue.add(gd, undoFunc, undoArgs, redoFunc, redoArgs); return promise; } // make sure indices is property defined if(!Array.isArray(newIndices)) { newIndices = [newIndices]; } try { // this is redundant, but necessary to not catch later possible errors! checkMoveTracesArgs(gd, currentIndices, newIndices); } catch(error) { // something went wrong, reset gd to be safe and rethrow error gd.data.splice(gd.data.length - traces.length, traces.length); throw error; } // if we're here, the user has defined specific places to place the new traces // this requires some extra work that moveTraces will do if(Queue) Queue.startSequence(gd); if(Queue) Queue.add(gd, undoFunc, undoArgs, redoFunc, redoArgs); promise = Plotly.moveTraces(gd, currentIndices, newIndices); if(Queue) Queue.stopSequence(gd); return promise; }; /** * Delete traces at `indices` from gd.data array. * * @param {Object|HTMLDivElement} gd The graph div * @param {Object[]} gd.data The array of traces we're removing from * @param {Number|Number[]} indices The indices */ Plotly.deleteTraces = function deleteTraces(gd, indices) { gd = getGraphDiv(gd); var traces = [], undoFunc = Plotly.addTraces, redoFunc = deleteTraces, undoArgs = [gd, traces, indices], redoArgs = [gd, indices], i, deletedTrace; // make sure indices are defined if(typeof indices === 'undefined') { throw new Error('indices must be an integer or array of integers.'); } else if(!Array.isArray(indices)) { indices = [indices]; } assertIndexArray(gd, indices, 'indices'); // convert negative indices to positive indices indices = positivifyIndices(indices, gd.data.length - 1); // we want descending here so that splicing later doesn't affect indexing indices.sort(Lib.sorterDes); for(i = 0; i < indices.length; i += 1) { deletedTrace = gd.data.splice(indices[i], 1)[0]; traces.push(deletedTrace); } var promise = Plotly.redraw(gd); if(Queue) Queue.add(gd, undoFunc, undoArgs, redoFunc, redoArgs); return promise; }; /** * Move traces at currentIndices array to locations in newIndices array. * * If newIndices is omitted, currentIndices will be moved to the end. E.g., * these are equivalent: * * Plotly.moveTraces(gd, [1, 2, 3], [-3, -2, -1]) * Plotly.moveTraces(gd, [1, 2, 3]) * * @param {Object|HTMLDivElement} gd The graph div * @param {Object[]} gd.data The array of traces we're removing from * @param {Number|Number[]} currentIndices The locations of traces to be moved * @param {Number|Number[]} [newIndices] The locations to move traces to * * Example calls: * * // move trace i to location x * Plotly.moveTraces(gd, i, x) * * // move trace i to end of array * Plotly.moveTraces(gd, i) * * // move traces i, j, k to end of array (i != j != k) * Plotly.moveTraces(gd, [i, j, k]) * * // move traces [i, j, k] to [x, y, z] (i != j != k) (x != y != z) * Plotly.moveTraces(gd, [i, j, k], [x, y, z]) * * // reorder all traces (assume there are 5--a, b, c, d, e) * Plotly.moveTraces(gd, [b, d, e, a, c]) // same as 'move to end' */ Plotly.moveTraces = function moveTraces(gd, currentIndices, newIndices) { gd = getGraphDiv(gd); var newData = [], movingTraceMap = [], undoFunc = moveTraces, redoFunc = moveTraces, undoArgs = [gd, newIndices, currentIndices], redoArgs = [gd, currentIndices, newIndices], i; // to reduce complexity here, check args elsewhere // this throws errors where appropriate checkMoveTracesArgs(gd, currentIndices, newIndices); // make sure currentIndices is an array currentIndices = Array.isArray(currentIndices) ? currentIndices : [currentIndices]; // if undefined, define newIndices to point to the end of gd.data array if(typeof newIndices === 'undefined') { newIndices = []; for(i = 0; i < currentIndices.length; i++) { newIndices.push(-currentIndices.length + i); } } // make sure newIndices is an array if it's user-defined newIndices = Array.isArray(newIndices) ? newIndices : [newIndices]; // convert negative indices to positive indices (they're the same length) currentIndices = positivifyIndices(currentIndices, gd.data.length - 1); newIndices = positivifyIndices(newIndices, gd.data.length - 1); // at this point, we've coerced the index arrays into predictable forms // get the traces that aren't being moved around for(i = 0; i < gd.data.length; i++) { // if index isn't in currentIndices, include it in ignored! if(currentIndices.indexOf(i) === -1) { newData.push(gd.data[i]); } } // get a mapping of indices to moving traces for(i = 0; i < currentIndices.length; i++) { movingTraceMap.push({newIndex: newIndices[i], trace: gd.data[currentIndices[i]]}); } // reorder this mapping by newIndex, ascending movingTraceMap.sort(function(a, b) { return a.newIndex - b.newIndex; }); // now, add the moving traces back in, in order! for(i = 0; i < movingTraceMap.length; i += 1) { newData.splice(movingTraceMap[i].newIndex, 0, movingTraceMap[i].trace); } gd.data = newData; var promise = Plotly.redraw(gd); if(Queue) Queue.add(gd, undoFunc, undoArgs, redoFunc, redoArgs); return promise; }; // ----------------------------------------------------- // restyle and relayout: these two control all redrawing // for data (restyle) and everything else (relayout) // ----------------------------------------------------- // restyle: change styling of an existing plot // can be called two ways: // // restyle(gd, astr, val [,traces]) // gd - graph div (string id or dom element) // astr - attribute string (like 'marker.symbol') // val - value to give this attribute // traces - integer or array of integers for the traces // to alter (all if omitted) // // restyle(gd, aobj [,traces]) // aobj - {astr1:val1, astr2:val2...} allows setting // multiple attributes simultaneously // // val (or val1, val2... in the object form) can be an array, // to apply different values to each trace. // If the array is too short, it will wrap around (useful for // style files that want to specify cyclical default values). Plotly.restyle = function restyle(gd, astr, val, traces) { gd = getGraphDiv(gd); var i, fullLayout = gd._fullLayout, aobj = {}; if(typeof astr === 'string') aobj[astr] = val; else if(Lib.isPlainObject(astr)) { aobj = astr; if(traces===undefined) traces = val; // the 3-arg form } else { console.log('restyle fail',astr,val,traces); return Promise.reject(); } if(Object.keys(aobj).length) gd.changed = true; if(isNumeric(traces)) traces=[traces]; else if(!Array.isArray(traces) || !traces.length) { traces=gd._fullData.map(function(v,i) { return i; }); } // recalcAttrs attributes need a full regeneration of calcdata // as well as a replot, because the right objects may not exist, // or autorange may need recalculating // in principle we generally shouldn't need to redo ALL traces... that's // harder though. var recalcAttrs = [ 'mode','visible','type','orientation','fill', 'histfunc','histnorm','text', 'x', 'y', 'z', 'xtype','x0','dx','ytype','y0','dy','xaxis','yaxis', 'line.width', 'connectgaps', 'transpose', 'zsmooth', 'showscale', 'marker.showscale', 'zauto', 'marker.cauto', 'autocolorscale', 'marker.autocolorscale', 'colorscale', 'marker.colorscale', 'reversescale', 'marker.reversescale', 'autobinx','nbinsx','xbins','xbins.start','xbins.end','xbins.size', 'autobiny','nbinsy','ybins','ybins.start','ybins.end','ybins.size', 'autocontour','ncontours','contours','contours.coloring', 'error_y','error_y.visible','error_y.value','error_y.type', 'error_y.traceref','error_y.array','error_y.symmetric', 'error_y.arrayminus','error_y.valueminus','error_y.tracerefminus', 'error_x','error_x.visible','error_x.value','error_x.type', 'error_x.traceref','error_x.array','error_x.symmetric', 'error_x.arrayminus','error_x.valueminus','error_x.tracerefminus', 'swapxy','swapxyaxes','orientationaxes', 'marker.colors', 'values', 'labels', 'label0', 'dlabel', 'sort', 'textinfo', 'textposition', 'textfont.size', 'textfont.family', 'textfont.color', 'insidetextfont.size', 'insidetextfont.family', 'insidetextfont.color', 'outsidetextfont.size', 'outsidetextfont.family', 'outsidetextfont.color', 'hole', 'scalegroup', 'domain', 'domain.x', 'domain.y', 'domain.x[0]', 'domain.x[1]', 'domain.y[0]', 'domain.y[1]', 'tilt', 'tiltaxis', 'depth', 'direction', 'rotation', 'pull' ]; for(i = 0; i < traces.length; i++) { if(Plots.traceIs(gd._fullData[traces[i]], 'box')) { recalcAttrs.push('name'); break; } } // autorangeAttrs attributes need a full redo of calcdata // only if an axis is autoranged, // because .calc() is where the autorange gets determined // TODO: could we break this out as well? var autorangeAttrs = [ 'marker', 'marker.size', 'textfont', 'boxpoints','jitter','pointpos','whiskerwidth','boxmean' ]; // replotAttrs attributes need a replot (because different // objects need to be made) but not a recalc var replotAttrs = [ 'zmin', 'zmax', 'zauto', 'marker.cmin', 'marker.cmax', 'marker.cauto', 'contours.start','contours.end','contours.size', 'contours.showlines', 'line','line.smoothing','line.shape', 'error_y.width','error_x.width','error_x.copy_ystyle', 'marker.maxdisplayed' ]; // these ones show up in restyle because they make more sense // in the style box, but they're graph-wide attributes, so set // in gd.layout also axis scales and range show up here because // we may need to undo them. These all trigger a recalc // var layoutAttrs = [ // 'barmode', 'barnorm','bargap', 'bargroupgap', // 'boxmode', 'boxgap', 'boxgroupgap', // '?axis.autorange', '?axis.range', '?axis.rangemode' // ]; // these ones may alter the axis type // (at least if the first trace is involved) var axtypeAttrs = [ 'type','x','y','x0','y0','orientation','xaxis','yaxis' ]; // flags for which kind of update we need to do var docalc = false, docalcAutorange = false, doplot = false, dolayout = false, dostyle = false, docolorbars = false; // copies of the change (and previous values of anything affected) // for the undo / redo queue var redoit = {}, undoit = {}, axlist, flagAxForDelete = {}; // for now, if we detect gl or geo stuff, just re-do the plot if(fullLayout._hasGL3D || fullLayout._hasGeo || fullLayout._hasGL2D) { doplot = true; } // make a new empty vals array for undoit function a0() { return traces.map(function() { return undefined; }); } // for autoranging multiple axes function addToAxlist(axid) { var axName = Plotly.Axes.id2name(axid); if(axlist.indexOf(axName)===-1) { axlist.push(axName); } } function autorangeAttr(axName) { return 'LAYOUT' + axName + '.autorange'; } function rangeAttr(axName) { return 'LAYOUT' + axName + '.range'; } // for attrs that interact (like scales & autoscales), save the // old vals before making the change // val=undefined will not set a value, just record what the value was. // val=null will delete the attribute // attr can be an array to set several at once (all to the same val) function doextra(attr,val,i) { if(Array.isArray(attr)) { attr.forEach(function(a) { doextra(a,val,i); }); return; } // quit if explicitly setting this elsewhere if(attr in aobj) return; var extraparam; if(attr.substr(0, 6) === 'LAYOUT') { extraparam = Lib.nestedProperty(gd.layout, attr.replace('LAYOUT', '')); } else { extraparam = Lib.nestedProperty(gd.data[traces[i]], attr); } if(!(attr in undoit)) { undoit[attr] = a0(); } if(undoit[attr][i]===undefined) { undoit[attr][i]=extraparam.get(); } if(val!==undefined) { extraparam.set(val); } } var zscl = ['zmin', 'zmax'], xbins = ['xbins.start', 'xbins.end', 'xbins.size'], ybins = ['ybins.start', 'ybins.end', 'ybins.size'], contourAttrs = ['contours.start', 'contours.end', 'contours.size']; // now make the changes to gd.data (and occasionally gd.layout) // and figure out what kind of graphics update we need to do for(var ai in aobj) { var vi = aobj[ai], cont, contFull, param, oldVal, newVal; redoit[ai] = vi; if(ai.substr(0,6)==='LAYOUT') { param = Lib.nestedProperty(gd.layout, ai.replace('LAYOUT', '')); undoit[ai] = [param.get()]; // since we're allowing val to be an array, allow it here too, // even though that's meaningless param.set(Array.isArray(vi) ? vi[0] : vi); // ironically, the layout attrs in restyle only require replot, // not relayout docalc = true; continue; } // set attribute in gd.data undoit[ai] = a0(); for(i=0; i ax.range[0]) ? [1, 2] : [2, 1]; } } // handle axis reversal explicitly, as there's no 'reverse' flag if(pleaf ==='reverse') { if(parentIn.range) parentIn.range.reverse(); else { doextra(ptrunk+'.autorange', true); parentIn.range = [1, 0]; } if(parentFull.autorange) docalc = true; else doplot = true; } // send annotation and shape mods one-by-one through Annotations.draw(), // don't set via nestedProperty // that's because add and remove are special else if(p.parts[0] === 'annotations' || p.parts[0] === 'shapes') { var objNum = p.parts[1], objType = p.parts[0], objList = layout[objType] || [], objModule = Plotly[Lib.titleCase(objType)], obji = objList[objNum] || {}; // if p.parts is just an annotation number, and val is either // 'add' or an entire annotation to add, the undo is 'remove' // if val is 'remove' then undo is the whole annotation object if(p.parts.length === 2) { if(aobj[ai] === 'add' || Lib.isPlainObject(aobj[ai])) { undoit[ai] = 'remove'; } else if(aobj[ai] === 'remove') { if(objNum === -1) { undoit[objType] = objList; delete undoit[ai]; } else undoit[ai] = obji; } else console.log('???', aobj); } if((refAutorange(obji, 'x') || refAutorange(obji, 'y')) && !Lib.containsAny(ai, ['color', 'opacity', 'align', 'dash'])) { docalc = true; } // TODO: combine all edits to a given annotation / shape into one call // as it is we get separate calls for x and y (or ax and ay) on move objModule.draw(gd, objNum, p.parts.slice(2).join('.'), aobj[ai]); delete aobj[ai]; } // alter gd.layout else { // check whether we can short-circuit a full redraw // 3d or geo at this point just needs to redraw. if(p.parts[0].indexOf('scene') === 0) doplot = true; else if(p.parts[0].indexOf('geo') === 0) doplot = true; else if(fullLayout._hasGL2D && (ai.indexOf('axis') !== -1 || p.parts[0] === 'plot_bgcolor') ) doplot = true; else if(ai === 'hiddenlabels') docalc = true; else if(p.parts[0].indexOf('legend')!==-1) dolegend = true; else if(ai.indexOf('title')!==-1) doticks = true; else if(p.parts[0].indexOf('bgcolor')!==-1) dolayoutstyle = true; else if(p.parts.length>1 && Lib.containsAny(p.parts[1], ['tick', 'exponent', 'grid', 'zeroline'])) { doticks = true; } else if(ai.indexOf('.linewidth')!==-1 && ai.indexOf('axis')!==-1) { doticks = dolayoutstyle = true; } else if(p.parts.length>1 && p.parts[1].indexOf('line')!==-1) { dolayoutstyle = true; } else if(p.parts.length>1 && p.parts[1]==='mirror') { doticks = dolayoutstyle = true; } else if(ai==='margin.pad') { doticks = dolayoutstyle = true; } else if(p.parts[0]==='margin' || p.parts[1]==='autorange' || p.parts[1]==='rangemode' || p.parts[1]==='type' || p.parts[1]==='domain' || ai.match(/^(bar|box|font)/)) { docalc = true; } /* * hovermode and dragmode don't need any redrawing, since they just * affect reaction to user input. everything else, assume full replot. * height, width, autosize get dealt with below. Except for the case of * of subplots - scenes - which require scene.updateFx to be called. */ else if(['hovermode', 'dragmode'].indexOf(ai) !== -1) domodebar = true; else if(['hovermode','dragmode','height', 'width','autosize'].indexOf(ai)===-1) { doplot = true; } p.set(vi); } } // now all attribute mods are done, as are // redo and undo so we can save them if(Queue) { Queue.add(gd, relayout, [gd, undoit], relayout, [gd, redoit]); } // calculate autosizing - if size hasn't changed, // will remove h&w so we don't need to redraw if(aobj.autosize) aobj = plotAutoSize(gd,aobj); if(aobj.height || aobj.width || aobj.autosize) docalc = true; // redraw // first check if there's still anything to do var ak = Object.keys(aobj), seq = [Plots.previousPromises]; if(doplot || docalc) { seq.push(function layoutReplot() { // force plot() to redo the layout gd.layout = undefined; // force it to redo calcdata? if(docalc) gd.calcdata = undefined; // replot with the modified layout return Plotly.plot(gd, '', layout); }); } else if(ak.length) { // if we didn't need to redraw entirely, just do the needed parts Plots.supplyDefaults(gd); fullLayout = gd._fullLayout; if(dolegend) { seq.push(function doLegend() { Legend.draw(gd); return Plots.previousPromises(gd); }); } if(dolayoutstyle) seq.push(layoutStyles); if(doticks) { seq.push(function() { Plotly.Axes.doTicks(gd,'redraw'); Titles.draw(gd, 'gtitle'); return Plots.previousPromises(gd); }); } // this is decoupled enough it doesn't need async regardless if(domodebar) { var subplotIds; manageModeBar(gd); subplotIds = Plots.getSubplotIds(fullLayout, 'gl3d'); for(i = 0; i < subplotIds.length; i++) { scene = fullLayout[subplotIds[i]]._scene; scene.updateFx(fullLayout.dragmode, fullLayout.hovermode); } subplotIds = Plots.getSubplotIds(fullLayout, 'gl2d'); for(i = 0; i < subplotIds.length; i++) { scene = fullLayout._plots[subplotIds[i]]._scene2d; scene.updateFx(fullLayout); } subplotIds = Plots.getSubplotIds(fullLayout, 'geo'); for(i = 0; i < subplotIds.length; i++) { var geo = fullLayout[subplotIds[i]]._geo; geo.updateFx(fullLayout.hovermode); } } } var plotDone = Lib.syncOrAsync(seq, gd); if(!plotDone || !plotDone.then) plotDone = Promise.resolve(gd); return plotDone.then(function() { gd.emit('plotly_relayout', Lib.extendDeep({}, redoit)); return gd; }); }; /** * Reduce all reserved margin objects to a single required margin reservation. * * @param {Object} margins * @returns {{left: number, right: number, bottom: number, top: number}} */ function calculateReservedMargins(margins) { var resultingMargin = {left: 0, right: 0, bottom: 0, top: 0}, marginName; if(margins) { for(marginName in margins) { if(margins.hasOwnProperty(marginName)) { resultingMargin.left += margins[marginName].left || 0; resultingMargin.right += margins[marginName].right || 0; resultingMargin.bottom += margins[marginName].bottom || 0; resultingMargin.top += margins[marginName].top || 0; } } } return resultingMargin; } function plotAutoSize(gd, aobj) { var fullLayout = gd._fullLayout, context = gd._context, computedStyle; var newHeight, newWidth; gd.emit('plotly_autosize'); // embedded in an iframe - just take the full iframe size // if we get to this point, with no aspect ratio restrictions if(gd._context.fillFrame) { newWidth = window.innerWidth; newHeight = window.innerHeight; // somehow we get a few extra px height sometimes... // just hide it document.body.style.overflow = 'hidden'; } else if(isNumeric(context.frameMargins) && context.frameMargins > 0) { var reservedMargins = calculateReservedMargins(gd._boundingBoxMargins), reservedWidth = reservedMargins.left + reservedMargins.right, reservedHeight = reservedMargins.bottom + reservedMargins.top, gdBB = fullLayout._container.node().getBoundingClientRect(), factor = 1 - 2*context.frameMargins; newWidth = Math.round(factor * (gdBB.width - reservedWidth)); newHeight = Math.round(factor * (gdBB.height - reservedHeight)); } else { // plotly.js - let the developers do what they want, either // provide height and width for the container div, // specify size in layout, or take the defaults, // but don't enforce any ratio restrictions computedStyle = window.getComputedStyle(gd); newHeight = parseFloat(computedStyle.height) || fullLayout.height; newWidth = parseFloat(computedStyle.width) || fullLayout.width; } if(Math.abs(fullLayout.width - newWidth) > 1 || Math.abs(fullLayout.height - newHeight) > 1) { fullLayout.height = gd.layout.height = newHeight; fullLayout.width = gd.layout.width = newWidth; } // if there's no size change, update layout but // delete the autosize attr so we don't redraw // but can't call layoutStyles for initial autosize else if(fullLayout.autosize !== 'initial') { delete(aobj.autosize); fullLayout.autosize = gd.layout.autosize = true; } Plots.sanitizeMargins(fullLayout); return aobj; } // ------------------------------------------------------- // makePlotFramework: Create the plot container and axes // ------------------------------------------------------- function makePlotFramework(gd) { var gd3 = d3.select(gd), fullLayout = gd._fullLayout; // TODO - find a better place for 3D to initialize axes if(fullLayout._hasGL3D) Plots.subplotsRegistry.gl3d.initAxes(gd); // Plot container fullLayout._container = gd3.selectAll('.plot-container').data([0]); fullLayout._container.enter().insert('div', ':first-child') .classed('plot-container', true) .classed('plotly', true); // Make the svg container fullLayout._paperdiv = fullLayout._container.selectAll('.svg-container').data([0]); fullLayout._paperdiv.enter().append('div') .classed('svg-container',true) .style('position','relative'); // Initial autosize if(fullLayout.autosize === 'initial') { plotAutoSize(gd, {}); fullLayout.autosize = true; gd.layout.autosize = true; } // Make the graph containers // start fresh each time we get here, so we know the order comes out // right, rather than enter/exit which can muck up the order // TODO: sort out all the ordering so we don't have to // explicitly delete anything fullLayout._glcontainer = fullLayout._paperdiv.selectAll('.gl-container') .data([0]); fullLayout._glcontainer.enter().append('div') .classed('gl-container', true); fullLayout._geocontainer = fullLayout._paperdiv.selectAll('.geo-container') .data([0]); fullLayout._geocontainer.enter().append('div') .classed('geo-container', true); fullLayout._paperdiv.selectAll('.main-svg').remove(); fullLayout._paper = fullLayout._paperdiv.insert('svg', ':first-child') .classed('main-svg', true); fullLayout._toppaper = fullLayout._paperdiv.append('svg') .classed('main-svg', true); if(!fullLayout._uid) { var otherUids = []; d3.selectAll('defs').each(function() { if(this.id) otherUids.push(this.id.split('-')[1]); }); fullLayout._uid = Lib.randstr(otherUids); } fullLayout._paperdiv.selectAll('.main-svg') .attr(xmlnsNamespaces.svgAttrs); fullLayout._defs = fullLayout._paper.append('defs') .attr('id', 'defs-' + fullLayout._uid); fullLayout._draggers = fullLayout._paper.append('g') .classed('draglayer', true); var subplots = Plotly.Axes.getSubplots(gd); if(subplots.join('') !== Object.keys(gd._fullLayout._plots || {}).join('')) { makeSubplots(gd, subplots); } if(fullLayout._hasCartesian) makeCartesianPlotFramwork(gd, subplots); // single shape and pie layers for the whole plot fullLayout._shapelayer = fullLayout._paper.append('g').classed('shapelayer', true); fullLayout._pielayer = fullLayout._paper.append('g').classed('pielayer', true); // fill in image server scrape-svg fullLayout._glimages = fullLayout._paper.append('g').classed('glimages', true); fullLayout._geoimages = fullLayout._paper.append('g').classed('geoimages', true); // lastly info (legend, annotations) and hover layers go on top // these are in a different svg element normally, but get collapsed into a single // svg when exporting (after inserting 3D) fullLayout._infolayer = fullLayout._toppaper.append('g').classed('infolayer', true); fullLayout._hoverlayer = fullLayout._toppaper.append('g').classed('hoverlayer', true); gd.emit('plotly_framework'); // position and style the containers, make main title var frameWorkDone = Lib.syncOrAsync([ layoutStyles, function goAxes() { return Plotly.Axes.doTicks(gd,'redraw'); }, Fx.init ], gd); if(frameWorkDone && frameWorkDone.then) { gd._promises.push(frameWorkDone); } return frameWorkDone; } // create '_plots' object grouping x/y axes into subplots // to be better manage subplots function makeSubplots(gd, subplots) { var _plots = gd._fullLayout._plots = {}; var subplot, plotinfo; function getAxisFunc(subplot, axLetter) { return function() { return Plotly.Axes.getFromId(gd, subplot, axLetter); }; } for(var i = 0; i < subplots.length; i++) { subplot = subplots[i]; plotinfo = _plots[subplot] = {}; plotinfo.id = subplot; // references to the axis objects controlling this subplot plotinfo.x = getAxisFunc(subplot, 'x'); plotinfo.y = getAxisFunc(subplot, 'y'); // TODO investigate why replacing calls to .x and .y // for .xaxis and .yaxis makes the `pseudo_html` // test image fail plotinfo.xaxis = plotinfo.x(); plotinfo.yaxis = plotinfo.y(); } } function makeCartesianPlotFramwork(gd, subplots) { var fullLayout = gd._fullLayout; // Layers to keep plot types in the right order. // from back to front: // 1. heatmaps, 2D histos and contour maps // 2. bars / 1D histos // 3. errorbars for bars and scatter // 4. scatter // 5. box plots function plotLayers(svg) { svg.append('g').classed('imagelayer', true); svg.append('g').classed('maplayer', true); svg.append('g').classed('barlayer', true); svg.append('g').classed('errorlayer', true); svg.append('g').classed('boxlayer', true); svg.append('g').classed('scatterlayer', true); } // create all the layers in order, so we know they'll stay in order var overlays = []; fullLayout._paper.selectAll('g.subplot').data(subplots) .enter().append('g') .classed('subplot', true) .each(function(subplot) { var plotinfo = fullLayout._plots[subplot], plotgroup = plotinfo.plotgroup = d3.select(this).classed(subplot, true), xa = plotinfo.xaxis, ya = plotinfo.yaxis; // references to any subplots overlaid on this one plotinfo.overlays = []; // is this subplot overlaid on another? // ax.overlaying is the id of another axis of the same // dimension that this one overlays to be an overlaid subplot, // the main plot must exist make sure we're not trying to // overlay on an axis that's already overlaying another var xa2 = Plotly.Axes.getFromId(gd, xa.overlaying) || xa; if(xa2 !== xa && xa2.overlaying) { xa2 = xa; xa.overlaying = false; } var ya2 = Plotly.Axes.getFromId(gd, ya.overlaying) || ya; if(ya2 !== ya && ya2.overlaying) { ya2 = ya; ya.overlaying = false; } var mainplot = xa2._id+ya2._id; if(mainplot!==subplot && subplots.indexOf(mainplot)!==-1) { plotinfo.mainplot = mainplot; overlays.push(plotinfo); // for now force overlays to overlay completely... so they // can drag together correctly and share backgrounds. // Later perhaps we make separate axis domain and // tick/line domain or something, so they can still share // the (possibly larger) dragger and background but don't // have to both be drawn over that whole domain xa.domain = xa2.domain.slice(); ya.domain = ya2.domain.slice(); } else { // main subplot - make the components of // the plot and containers for overlays plotinfo.bg = plotgroup.append('rect') .style('stroke-width', 0); plotinfo.gridlayer = plotgroup.append('g'); plotinfo.overgrid = plotgroup.append('g'); plotinfo.zerolinelayer = plotgroup.append('g'); plotinfo.overzero = plotgroup.append('g'); plotinfo.plot = plotgroup.append('svg').call(plotLayers); plotinfo.overplot = plotgroup.append('g'); plotinfo.xlines = plotgroup.append('path'); plotinfo.ylines = plotgroup.append('path'); plotinfo.overlines = plotgroup.append('g'); plotinfo.xaxislayer = plotgroup.append('g'); plotinfo.yaxislayer = plotgroup.append('g'); plotinfo.overaxes = plotgroup.append('g'); // make separate drag layers for each subplot, // but append them to paper rather than the plot groups, // so they end up on top of the rest } plotinfo.draglayer = fullLayout._draggers.append('g'); }); // now make the components of overlaid subplots // overlays don't have backgrounds, and append all // their other components to the corresponding // extra groups of their main Plots. overlays.forEach(function(plotinfo) { var mainplot = fullLayout._plots[plotinfo.mainplot]; mainplot.overlays.push(plotinfo); plotinfo.gridlayer = mainplot.overgrid.append('g'); plotinfo.zerolinelayer = mainplot.overzero.append('g'); plotinfo.plot = mainplot.overplot.append('svg').call(plotLayers); plotinfo.xlines = mainplot.overlines.append('path'); plotinfo.ylines = mainplot.overlines.append('path'); plotinfo.xaxislayer = mainplot.overaxes.append('g'); plotinfo.yaxislayer = mainplot.overaxes.append('g'); }); // common attributes for all subplots, overlays or not subplots.forEach(function(subplot) { var plotinfo = fullLayout._plots[subplot]; plotinfo.plot .attr('preserveAspectRatio', 'none') .style('fill', 'none'); plotinfo.xlines .style('fill', 'none') .classed('crisp', true); plotinfo.ylines .style('fill', 'none') .classed('crisp', true); }); } // layoutStyles: styling for plot layout elements function layoutStyles(gd) { return Lib.syncOrAsync([Plots.doAutoMargin, lsInner], gd); } function lsInner(gd) { var fullLayout = gd._fullLayout, gs = fullLayout._size, axList = Plotly.Axes.list(gd), i; // clear axis line positions, to be set in the subplot loop below for(i = 0; i < axList.length; i++) axList[i]._linepositions = {}; fullLayout._paperdiv .style({ width: fullLayout.width + 'px', height: fullLayout.height + 'px' }) .selectAll('.main-svg') .call(Drawing.setSize, fullLayout.width, fullLayout.height); gd._context.setBackground(gd, fullLayout.paper_bgcolor); var freefinished = []; fullLayout._paper.selectAll('g.subplot').each(function(subplot) { var plotinfo = fullLayout._plots[subplot], xa = Plotly.Axes.getFromId(gd, subplot, 'x'), ya = Plotly.Axes.getFromId(gd, subplot, 'y'); xa.setScale(); // this may already be done... not sure ya.setScale(); if(plotinfo.bg) { plotinfo.bg .call(Drawing.setRect, xa._offset-gs.p, ya._offset-gs.p, xa._length+2*gs.p, ya._length+2*gs.p) .call(Color.fill, fullLayout.plot_bgcolor); } plotinfo.plot .call(Drawing.setRect, xa._offset, ya._offset, xa._length, ya._length); var xlw = Drawing.crispRound(gd, xa.linewidth, 1), ylw = Drawing.crispRound(gd, ya.linewidth, 1), xp = gs.p+ylw, xpathPrefix = 'M'+(-xp)+',', xpathSuffix = 'h'+(xa._length+2*xp), showfreex = xa.anchor==='free' && freefinished.indexOf(xa._id)===-1, freeposx = gs.h*(1-(xa.position||0))+((xlw/2)%1), showbottom = (xa.anchor===ya._id && (xa.mirror||xa.side!=='top')) || xa.mirror==='all' || xa.mirror==='allticks' || (xa.mirrors && xa.mirrors[ya._id+'bottom']), bottompos = ya._length+gs.p+xlw/2, showtop = (xa.anchor===ya._id && (xa.mirror||xa.side==='top')) || xa.mirror==='all' || xa.mirror==='allticks' || (xa.mirrors && xa.mirrors[ya._id+'top']), toppos = -gs.p-xlw/2, // shorten y axis lines so they don't overlap x axis lines yp = gs.p, // except where there's no x line // TODO: this gets more complicated with multiple x and y axes ypbottom = showbottom ? 0 : xlw, yptop = showtop ? 0 : xlw, ypathSuffix = ','+(-yp-yptop)+ 'v'+(ya._length+2*yp+yptop+ypbottom), showfreey = ya.anchor==='free' && freefinished.indexOf(ya._id)===-1, freeposy = gs.w*(ya.position||0)+((ylw/2)%1), showleft = (ya.anchor===xa._id && (ya.mirror||ya.side!=='right')) || ya.mirror==='all' || ya.mirror==='allticks' || (ya.mirrors && ya.mirrors[xa._id+'left']), leftpos = -gs.p-ylw/2, showright = (ya.anchor===xa._id && (ya.mirror||ya.side==='right')) || ya.mirror==='all' || ya.mirror==='allticks' || (ya.mirrors && ya.mirrors[xa._id+'right']), rightpos = xa._length+gs.p+ylw/2; // save axis line positions for ticks, draggers, etc to reference // each subplot gets an entry: // [left or bottom, right or top, free, main] // main is the position at which to draw labels and draggers, if any xa._linepositions[subplot] = [ showbottom ? bottompos : undefined, showtop ? toppos : undefined, showfreex ? freeposx : undefined ]; if(xa.anchor===ya._id) { xa._linepositions[subplot][3] = xa.side==='top' ? toppos : bottompos; } else if(showfreex) { xa._linepositions[subplot][3] = freeposx; } ya._linepositions[subplot] = [ showleft ? leftpos : undefined, showright ? rightpos : undefined, showfreey ? freeposy : undefined ]; if(ya.anchor===xa._id) { ya._linepositions[subplot][3] = ya.side==='right' ? rightpos : leftpos; } else if(showfreey) { ya._linepositions[subplot][3] = freeposy; } // translate all the extra stuff to have the // same origin as the plot area or axes var origin = 'translate('+xa._offset+','+ya._offset+')', originx = origin, originy = origin; if(showfreex) { originx = 'translate('+xa._offset+','+gs.t+')'; toppos += ya._offset - gs.t; bottompos += ya._offset - gs.t; } if(showfreey) { originy = 'translate('+gs.l+','+ya._offset+')'; leftpos += xa._offset - gs.l; rightpos += xa._offset - gs.l; } plotinfo.xlines .attr('transform', originx) .attr('d',( (showbottom ? (xpathPrefix+bottompos+xpathSuffix) : '') + (showtop ? (xpathPrefix+toppos+xpathSuffix) : '') + (showfreex ? (xpathPrefix+freeposx+xpathSuffix) : '')) || // so it doesn't barf with no lines shown 'M0,0') .style('stroke-width',xlw+'px') .call(Color.stroke, xa.showline ? xa.linecolor : 'rgba(0,0,0,0)'); plotinfo.ylines .attr('transform', originy) .attr('d',( (showleft ? ('M'+leftpos+ypathSuffix) : '') + (showright ? ('M'+rightpos+ypathSuffix) : '') + (showfreey ? ('M'+freeposy+ypathSuffix) : '')) || 'M0,0') .attr('stroke-width',ylw+'px') .call(Color.stroke,ya.showline ? ya.linecolor : 'rgba(0,0,0,0)'); plotinfo.xaxislayer.attr('transform',originx); plotinfo.yaxislayer.attr('transform',originy); plotinfo.gridlayer.attr('transform',origin); plotinfo.zerolinelayer.attr('transform',origin); plotinfo.draglayer.attr('transform',origin); // mark free axes as displayed, so we don't draw them again if(showfreex) { freefinished.push(xa._id); } if(showfreey) { freefinished.push(ya._id); } }); Plotly.Axes.makeClipPaths(gd); Titles.draw(gd, 'gtitle'); manageModeBar(gd); return gd._promises.length && Promise.all(gd._promises); } },{"../components/color":299,"../components/drawing":317,"../components/errorbars":323,"../components/legend":326,"../components/modebar/manage":329,"../components/shapes":331,"../components/titles":332,"../constants/xmlns_namespaces":338,"../lib":349,"../lib/events":344,"../lib/queue":355,"../plotly":366,"../plots/cartesian/graph_interact":374,"../plots/plots":413,"d3":70,"fast-isnumeric":74,"gl-mat4/fromQuat":91}],363:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /** * This will be transfered over to gd and overridden by * config args to Plotly.plot. * * The defaults are the appropriate settings for plotly.js, * so we get the right experience without any config argument. */ module.exports = { // no interactivity, for export or image generation staticPlot: false, // we can edit titles, move annotations, etc editable: false, // plot will respect layout.autosize=true and infer its container size autosizable: false, // if we DO autosize, do we fill the container or the screen? fillFrame: false, // if we DO autosize, set the frame margins in percents of plot size frameMargins: 0, // mousewheel or two-finger scroll zooms the plot scrollZoom: false, // double click interaction (false, 'reset', 'autosize' or 'reset+autosize') doubleClick: 'reset+autosize', // new users see some hints about interactivity showTips: true, // link to open this plot in plotly showLink: false, // if we show a link, does it contain data or just link to a plotly file? sendData: true, // text appearing in the sendData link linkText: 'Edit chart', // false or function adding source(s) to linkText showSources: false, // display the mode bar (true, false, or 'hover') displayModeBar: 'hover', // remove mode bar button by name // (see ./components/modebar/buttons.js for the list of names) modeBarButtonsToRemove: [], // add mode bar button using config objects // (see ./components/modebar/buttons.js for list of arguments) modeBarButtonsToAdd: [], // fully custom mode bar buttons as nested array, // where the outer arrays represents button groups, and // the inner arrays have buttons config objects or names of default buttons // (see ./components/modebar/buttons.js for more info) modeBarButtons: false, // add the plotly logo on the end of the mode bar displaylogo: true, // increase the pixel ratio for Gl plot images plotGlPixelRatio: 2, // function to add the background color to a different container // or 'opaque' to ensure there's white behind it setBackground: defaultSetBackground, // URL to topojson files used in geo charts topojsonURL: 'https://cdn.plot.ly/' }; // where and how the background gets set can be overridden by context // so we define the default (plotlyjs) behavior here function defaultSetBackground(gd, bgColor) { try { gd._fullLayout._paper.style('background', bgColor); } catch(e) { console.log(e); } } },{}],364:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../plotly'); var Plots = require('../plots/plots'); var Lib = require('../lib'); var extendFlat = Lib.extendFlat; var extendDeep = Lib.extendDeep; var extendDeepAll = Lib.extendDeepAll; var NESTED_MODULE = '_nestedModules', COMPOSED_MODULE = '_composedModules', IS_SUBPLOT_OBJ = '_isSubplotObj', IS_LINKED_TO_ARRAY = '_isLinkedToArray', DEPRECATED = '_deprecated'; // list of underscore attributes to keep in schema as is var UNDERSCORE_ATTRS = [IS_SUBPLOT_OBJ, IS_LINKED_TO_ARRAY, DEPRECATED]; var plotSchema = { traces: {}, layout: {}, defs: {} }; // FIXME polar attribute are not part of Plotly yet var polarAreaAttrs = require('../plots/polar/area_attributes'), polarAxisAttrs = require('../plots/polar/axis_attributes'); var PlotSchema = module.exports = {}; PlotSchema.get = function() { Plots.allTypes .concat('area') // FIXME polar 'area' attributes .forEach(getTraceAttributes); getLayoutAttributes(); getDefs(); return plotSchema; }; PlotSchema.crawl = function(attrs, callback) { Object.keys(attrs).forEach(function(attrName) { var attr = attrs[attrName]; if(UNDERSCORE_ATTRS.indexOf(attrName) !== -1) return; callback(attr, attrName, attrs); if(PlotSchema.isValObject(attr)) return; if(Lib.isPlainObject(attr)) PlotSchema.crawl(attr, callback); }); }; PlotSchema.isValObject = function(obj) { return obj && obj.valType !== undefined; }; function getTraceAttributes(type) { var globalAttributes = Plots.attributes, _module = getModule({type: type}), meta = getMeta(type), subplotRegistry = getSubplotRegistry(type); var attributes = {}, layoutAttributes = {}; // make 'type' the first attribute in the object attributes.type = null; // global attributes (same for all trace types) extendDeep(attributes, globalAttributes); // module attributes (+ nested + composed) attributes = coupleAttrs( _module.attributes, attributes, 'attributes', type ); // subplot attributes if(subplotRegistry.attributes !== undefined) { extendDeep(attributes, subplotRegistry.attributes); } // 'type' gets overwritten by globalAttributes; reset it here attributes.type = type; attributes = removeUnderscoreAttrs(attributes); mergeValTypeAndRole(attributes); plotSchema.traces[type] = extendFlat({}, meta, { attributes: attributes } ); // trace-specific layout attributes if(_module.layoutAttributes !== undefined) { layoutAttributes = coupleAttrs( _module.layoutAttributes, layoutAttributes, 'layoutAttributes', type ); mergeValTypeAndRole(layoutAttributes); plotSchema.traces[type].layoutAttributes = layoutAttributes; } } function getLayoutAttributes() { var globalLayoutAttributes = Plots.layoutAttributes, layoutAttributes = {}; // layout module attributes (+ nested + composed) layoutAttributes = coupleAttrs( globalLayoutAttributes, layoutAttributes, 'layoutAttributes', '*' ); // FIXME polar layout attributes layoutAttributes = assignPolarLayoutAttrs(layoutAttributes); // add IS_SUBPLOT_OBJ attribute layoutAttributes = handleSubplotObjs(layoutAttributes); layoutAttributes = removeUnderscoreAttrs(layoutAttributes); mergeValTypeAndRole(layoutAttributes); // generate IS_LINKED_TO_ARRAY structure layoutAttributes = handleLinkedToArray(layoutAttributes); plotSchema.layout = { layoutAttributes: layoutAttributes }; } function getDefs() { plotSchema.defs = { valObjects: Lib.valObjects, metaKeys: UNDERSCORE_ATTRS.concat(['description', 'role']) }; } function coupleAttrs(attrsIn, attrsOut, whichAttrs, type) { var nestedModule, nestedAttrs, nestedReference, composedModule, composedAttrs; Object.keys(attrsIn).forEach(function(k) { if(k === NESTED_MODULE) { Object.keys(attrsIn[k]).forEach(function(kk) { nestedModule = getModule({module: attrsIn[k][kk]}); if(nestedModule === undefined) return; nestedAttrs = nestedModule[whichAttrs]; nestedReference = coupleAttrs( nestedAttrs, {}, whichAttrs, type ); Lib.nestedProperty(attrsOut, kk) .set(extendDeep({}, nestedReference)); }); return; } if(k === COMPOSED_MODULE) { Object.keys(attrsIn[k]).forEach(function(kk) { if(kk !== type) return; composedModule = getModule({module: attrsIn[k][kk]}); if(composedModule === undefined) return; composedAttrs = composedModule[whichAttrs]; composedAttrs = coupleAttrs( composedAttrs, {}, whichAttrs, type ); extendDeepAll(attrsOut, composedAttrs); }); return; } attrsOut[k] = Lib.isPlainObject(attrsIn[k]) ? extendDeepAll({}, attrsIn[k]) : attrsIn[k]; }); return attrsOut; } function mergeValTypeAndRole(attrs) { function makeSrcAttr(attrName) { return { valType: 'string', }; } function callback(attr, attrName, attrs) { if(PlotSchema.isValObject(attr)) { if(attr.valType === 'data_array') { // all 'data_array' attrs have role 'data' attr.role = 'data'; // all 'data_array' attrs have a corresponding 'src' attr attrs[attrName + 'src'] = makeSrcAttr(attrName); } else if(attr.arrayOk === true) { // all 'arrayOk' attrs have a corresponding 'src' attr attrs[attrName + 'src'] = makeSrcAttr(attrName); } } else if(Lib.isPlainObject(attr)) { // all attrs container objects get role 'object' attr.role = 'object'; } } PlotSchema.crawl(attrs, callback); } // helper methods function getModule(arg) { if('type' in arg) { return (arg.type === 'area') ? // FIXME { attributes: polarAreaAttrs } : Plots.getModule({type: arg.type}); } var subplotsRegistry = Plots.subplotsRegistry, _module = arg.module; if(subplotsRegistry[_module]) return subplotsRegistry[_module]; else if('module' in arg) return Plotly[_module]; } function removeUnderscoreAttrs(attributes) { Object.keys(attributes).forEach(function(k) { if(k.charAt(0) === '_' && UNDERSCORE_ATTRS.indexOf(k) === -1) delete attributes[k]; }); return attributes; } function getMeta(type) { if(type === 'area') return {}; // FIXME return Plots.modules[type].meta || {}; } function assignPolarLayoutAttrs(layoutAttributes) { extendFlat(layoutAttributes, { radialaxis: polarAxisAttrs.radialaxis, angularaxis: polarAxisAttrs.angularaxis }); extendFlat(layoutAttributes, polarAxisAttrs.layout); return layoutAttributes; // FIXME } function getSubplotRegistry(traceType) { if(traceType === 'area') return {}; // FIXME var subplotsRegistry = Plots.subplotsRegistry, subplotType = Object.keys(subplotsRegistry).filter(function(subplotType) { return Plots.traceIs({type: traceType}, subplotType); })[0]; if(subplotType === undefined) return {}; return subplotsRegistry[subplotType]; } function handleSubplotObjs(layoutAttributes) { var subplotsRegistry = Plots.subplotsRegistry; Object.keys(layoutAttributes).forEach(function(k) { Object.keys(subplotsRegistry).forEach(function(subplotType) { var subplotRegistry = subplotsRegistry[subplotType], isSubplotObj; if(subplotType === 'cartesian' || subplotType === 'gl2d') { isSubplotObj = ( subplotRegistry.attrRegex.x.test(k) || subplotRegistry.attrRegex.y.test(k) ); } else { isSubplotObj = subplotRegistry.attrRegex.test(k); } if(isSubplotObj) layoutAttributes[k][IS_SUBPLOT_OBJ] = true; }); }); return layoutAttributes; } function handleLinkedToArray(layoutAttributes) { Object.keys(layoutAttributes).forEach(function(k) { var attr = extendDeep({}, layoutAttributes[k]); if(attr[IS_LINKED_TO_ARRAY] !== true) return; var itemName = k.substr(0, k.length-1); // TODO more robust logic delete attr[IS_LINKED_TO_ARRAY]; layoutAttributes[k] = { items: {} }; layoutAttributes[k].items[itemName] = attr; layoutAttributes[k].role = 'object'; }); return layoutAttributes; } },{"../lib":349,"../plotly":366,"../plots/plots":413,"../plots/polar/area_attributes":414,"../plots/polar/axis_attributes":415}],365:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../plotly'); /** * Extends the plot config * * @param {object} configObj partial plot configuration object * to extend the current plot configuration. * */ module.exports = function setPlotConfig(configObj) { return Plotly.Lib.extendFlat(Plotly.defaultConfig, configObj); }; },{"../plotly":366}],366:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /* * Pack internal modules unto an object. * * This object is require'ed in as 'Plotly' in numerous src and test files. * Require'ing 'Plotly' bypasses circular dependencies. * * Future development should move away from this pattern. * */ // promise polyfill require('es6-promise').polyfill(); // lib functions exports.Lib = require('./lib'); exports.util = require('./lib/svg_text_utils'); exports.Queue = require('./lib/queue'); // plot css require('../build/plotcss'); // configuration exports.MathJaxConfig = require('./fonts/mathjax_config'); exports.defaultConfig = require('./plot_api/plot_config'); // plots var Plots = exports.Plots = require('./plots/plots'); exports.Axes = require('./plots/cartesian/axes'); exports.Fx = require('./plots/cartesian/graph_interact'); exports.micropolar = require('./plots/polar/micropolar'); // components exports.Color = require('./components/color'); exports.Drawing = require('./components/drawing'); exports.Colorscale = require('./components/colorscale'); exports.Colorbar = require('./components/colorbar'); exports.ErrorBars = require('./components/errorbars'); exports.Annotations = require('./components/annotations'); exports.Shapes = require('./components/shapes'); exports.Legend = require('./components/legend'); exports.ModeBar = require('./components/modebar'); exports.register = function register(_modules) { if(!_modules) { throw new Error('No argument passed to Plotly.register.'); } else if(_modules && !Array.isArray(_modules)) { _modules = [_modules]; } for(var i = 0; i < _modules.length; i++) { var newModule = _modules[i]; if(newModule && newModule.moduleType !== 'trace') { throw new Error('Invalid module was attempted to be registered!'); } else { Plots.register(newModule, newModule.name, newModule.categories, newModule.meta); if(!Plots.subplotsRegistry[newModule.basePlotModule.name]) { Plots.registerSubplot(newModule.basePlotModule); } } } }; // Scatter is the only trace included by default exports.register(require('./traces/scatter')); // plot api require('./plot_api/plot_api'); exports.PlotSchema = require('./plot_api/plot_schema'); // imaging routines exports.Snapshot = require('./snapshot'); },{"../build/plotcss":1,"./components/annotations":297,"./components/color":299,"./components/colorbar":304,"./components/colorscale":312,"./components/drawing":317,"./components/errorbars":323,"./components/legend":326,"./components/modebar":328,"./components/shapes":331,"./fonts/mathjax_config":340,"./lib":349,"./lib/queue":355,"./lib/svg_text_utils":360,"./plot_api/plot_api":362,"./plot_api/plot_config":363,"./plot_api/plot_schema":364,"./plots/cartesian/axes":369,"./plots/cartesian/graph_interact":374,"./plots/plots":413,"./plots/polar/micropolar":416,"./snapshot":420,"./traces/scatter":511,"es6-promise":73}],367:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { type: { valType: 'enumerated', values: [], // listed dynamically dflt: 'scatter' }, visible: { valType: 'enumerated', values: [true, false, 'legendonly'], dflt: true, }, showlegend: { valType: 'boolean', dflt: true, }, legendgroup: { valType: 'string', dflt: '', }, opacity: { valType: 'number', min: 0, max: 1, dflt: 1, }, name: { valType: 'string', }, uid: { valType: 'string', dflt: '' }, hoverinfo: { valType: 'flaglist', flags: ['x', 'y', 'z', 'text', 'name'], extras: ['all', 'none'], dflt: 'all', }, stream: { token: { valType: 'string', noBlank: true, strict: true, }, maxpoints: { valType: 'number', min: 0, } } }; },{}],368:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { xaxis: { valType: 'axisid', dflt: 'x', }, yaxis: { valType: 'axisid', dflt: 'y', } }; },{}],369:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var isNumeric = require('fast-isnumeric'); var Plotly = require('../../plotly'); var Titles = require('../../components/titles'); var axes = module.exports = {}; axes.layoutAttributes = require('./layout_attributes'); axes.supplyLayoutDefaults = require('./layout_defaults'); axes.setConvert = require('./set_convert'); var axisIds = require('./axis_ids'); axes.id2name = axisIds.id2name; axes.cleanId = axisIds.cleanId; axes.list = axisIds.list; axes.listIds = axisIds.listIds; axes.getFromId = axisIds.getFromId; axes.getFromTrace = axisIds.getFromTrace; // find the list of possible axes to reference with an xref or yref attribute // and coerce it to that list axes.coerceRef = function(containerIn, containerOut, td, axLetter) { var axlist = td._fullLayout._hasGL2D ? [] : axes.listIds(td, axLetter), refAttr = axLetter + 'ref', attrDef = {}; // data-ref annotations are not supported in gl2d yet attrDef[refAttr] = { valType: 'enumerated', values: axlist.concat(['paper']), dflt: axlist[0] || 'paper' }; // xref, yref return Plotly.Lib.coerce(containerIn, containerOut, attrDef, refAttr); }; // empty out types for all axes containing these traces // so we auto-set them again axes.clearTypes = function(gd, traces) { if(!Array.isArray(traces) || !traces.length) { traces = (gd._fullData).map(function(d, i) { return i; }); } traces.forEach(function(tracenum) { var trace = gd.data[tracenum]; delete (axes.getFromId(gd, trace.xaxis) || {}).type; delete (axes.getFromId(gd, trace.yaxis) || {}).type; }); }; // get counteraxis letter for this axis (name or id) // this can also be used as the id for default counter axis axes.counterLetter = function(id) { var axLetter = id.charAt(0); if(axLetter === 'x') return 'y'; if(axLetter === 'y') return 'x'; }; // incorporate a new minimum difference and first tick into // forced axes.minDtick = function(ax,newDiff,newFirst,allow) { // doesn't make sense to do forced min dTick on log or category axes, // and the plot itself may decide to cancel (ie non-grouped bars) if(['log','category'].indexOf(ax.type)!==-1 || !allow) { ax._minDtick = 0; } // null means there's nothing there yet else if(ax._minDtick===null) { ax._minDtick = newDiff; ax._forceTick0 = newFirst; } else if(ax._minDtick) { // existing minDtick is an integer multiple of newDiff // (within rounding err) // and forceTick0 can be shifted to newFirst if((ax._minDtick/newDiff+1e-6)%1 < 2e-6 && (((newFirst-ax._forceTick0)/newDiff%1) + 1.000001) % 1 < 2e-6) { ax._minDtick = newDiff; ax._forceTick0 = newFirst; } // if the converse is true (newDiff is a multiple of minDtick and // newFirst can be shifted to forceTick0) then do nothing - same // forcing stands. Otherwise, cancel forced minimum else if((newDiff/ax._minDtick+1e-6)%1 > 2e-6 || (((newFirst-ax._forceTick0)/ax._minDtick%1) + 1.000001) % 1 > 2e-6) { ax._minDtick = 0; } } }; axes.doAutoRange = function(ax) { if(!ax._length) ax.setScale(); if(ax.autorange && ax._min && ax._max && ax._min.length && ax._max.length) { var minmin = ax._min[0].val, maxmax = ax._max[0].val, i; for(i = 1; i < ax._min.length; i++) { if(minmin !== maxmax) break; minmin = Math.min(minmin, ax._min[i].val); } for(i = 1; i < ax._max.length; i++) { if(minmin !== maxmax) break; maxmax = Math.max(maxmax, ax._max[i].val); } var j,minpt,maxpt,minbest,maxbest,dp,dv, mbest = 0, axReverse = (ax.range && ax.range[1]0 && dp>0 && dv/dp > mbest) { minbest = minpt; maxbest = maxpt; mbest = dv/dp; } } } if(minmin===maxmax) { ax.range = axReverse ? [minmin+1, ax.rangemode!=='normal' ? 0 : minmin-1] : [ax.rangemode!=='normal' ? 0 : minmin-1, minmin+1]; } else if(mbest) { if(ax.type==='linear' || ax.type==='-') { if(ax.rangemode==='tozero' && minbest.val>=0) { minbest = {val: 0, pad: 0}; } else if(ax.rangemode==='nonnegative') { if(minbest.val - mbest*minbest.pad<0) { minbest = {val: 0, pad: 0}; } if(maxbest.val<0) { maxbest = {val: 1, pad: 0}; } } // in case it changed again... mbest = (maxbest.val-minbest.val) / (ax._length-minbest.pad-maxbest.pad); } ax.range = [ minbest.val - mbest*minbest.pad, maxbest.val + mbest*maxbest.pad ]; // don't let axis have zero size if(ax.range[0]===ax.range[1]) { ax.range = [ax.range[0]-1, ax.range[0]+1]; } // maintain reversal if(axReverse) { ax.range.reverse(); } } // doAutoRange will get called on fullLayout, // but we want to report its results back to layout var axIn = ax._td.layout[ax._name]; if(!axIn) ax._td.layout[ax._name] = axIn = {}; if(axIn!==ax) { axIn.range = ax.range.slice(); axIn.autorange = ax.autorange; } } }; // save a copy of the initial axis ranges in fullLayout // use them in mode bar and dblclick events axes.saveRangeInitial = function(gd, overwrite) { var axList = axes.list(gd, '', true), hasOneAxisChanged = false; for(var i = 0; i < axList.length; i++) { var ax = axList[i]; var isNew = (ax._rangeInitial === undefined); var hasChanged = ( isNew || !( ax.range[0] === ax._rangeInitial[0] && ax.range[1] === ax._rangeInitial[1] ) ); if((isNew && ax.autorange === false) || (overwrite && hasChanged)) { ax._rangeInitial = ax.range.slice(); hasOneAxisChanged = true; } } return hasOneAxisChanged; }; // axes.expand: if autoranging, include new data in the outer limits // for this axis // data is an array of numbers (ie already run through ax.d2c) // available options: // vpad: (number or number array) pad values (data value +-vpad) // ppad: (number or number array) pad pixels (pixel location +-ppad) // ppadplus, ppadminus, vpadplus, vpadminus: // separate padding for each side, overrides symmetric // padded: (boolean) add 5% padding to both ends // (unless one end is overridden by tozero) // tozero: (boolean) make sure to include zero if axis is linear, // and make it a tight bound if possible var FP_SAFE = Number.MAX_VALUE/2; axes.expand = function(ax, data, options) { if(!ax.autorange || !data) return; if(!ax._min) ax._min = []; if(!ax._max) ax._max = []; if(!options) options = {}; if(!ax._m) ax.setScale(); var len = data.length, extrappad = options.padded ? ax._length*0.05 : 0, tozero = options.tozero && (ax.type==='linear' || ax.type==='-'), i, j, v, di, dmin, dmax, ppadiplus, ppadiminus, includeThis, vmin, vmax; function getPad(item) { if(Array.isArray(item)) { return function(i) { return Math.max(Number(item[i]||0),0); }; } else { var v = Math.max(Number(item||0),0); return function() { return v; }; } } var ppadplus = getPad((ax._m>0 ? options.ppadplus : options.ppadminus) || options.ppad || 0), ppadminus = getPad((ax._m>0 ? options.ppadminus : options.ppadplus) || options.ppad || 0), vpadplus = getPad(options.vpadplus||options.vpad), vpadminus = getPad(options.vpadminus||options.vpad); function addItem(i) { di = data[i]; if(!isNumeric(di)) return; ppadiplus = ppadplus(i) + extrappad; ppadiminus = ppadminus(i) + extrappad; vmin = di-vpadminus(i); vmax = di+vpadplus(i); // special case for log axes: if vpad makes this object span // more than an order of mag, clip it to one order. This is so // we don't have non-positive errors or absurdly large lower // range due to rounding errors if(ax.type==='log' && vmin=ppadiminus) { includeThis = false; } else if(v.val>=dmin && v.pad<=ppadiminus) { ax._min.splice(j,1); j--; } } if(includeThis) { ax._min.push({ val: dmin, pad: (tozero && dmin===0) ? 0 : ppadiminus }); } } if(goodNumber(dmax)) { includeThis = true; for(j=0; j=dmax && v.pad>=ppadiplus) { includeThis = false; } else if(v.val<=dmax && v.pad<=ppadiplus) { ax._max.splice(j,1); j--; } } if(includeThis) { ax._max.push({ val: dmax, pad: (tozero && dmax===0) ? 0 : ppadiplus }); } } } // For efficiency covering monotonic or near-monotonic data, // check a few points at both ends first and then sweep // through the middle for(i=0; i<6; i++) addItem(i); for(i=len-1; i>5; i--) addItem(i); }; axes.autoBin = function(data,ax,nbins,is2d) { var datamin = Plotly.Lib.aggNums(Math.min, null, data), datamax = Plotly.Lib.aggNums(Math.max, null, data); if(ax.type==='category') { return { start: datamin - 0.5, end: datamax + 0.5, size: 1 }; } var size0; if(nbins) size0 = ((datamax-datamin)/nbins); else { // totally auto: scale off std deviation so the highest bin is // somewhat taller than the total number of bins, but don't let // the size get smaller than the 'nice' rounded down minimum // difference between values var distinctData = Plotly.Lib.distinctVals(data), msexp = Math.pow(10, Math.floor( Math.log(distinctData.minDiff) / Math.LN10)), // TODO: there are some date cases where this will fail... minSize = msexp*Plotly.Lib.roundUp( distinctData.minDiff/msexp, [0.9, 1.9, 4.9, 9.9], true); size0 = Math.max(minSize, 2*Plotly.Lib.stdev(data) / Math.pow(data.length, is2d ? 0.25 : 0.4)); } // piggyback off autotick code to make "nice" bin sizes var dummyax = { type: ax.type==='log' ? 'linear' : ax.type, range: [datamin, datamax] }; axes.autoTicks(dummyax, size0); var binstart = axes.tickIncrement( axes.tickFirst(dummyax), dummyax.dtick, 'reverse'), binend; function nearEdge(v) { // is a value within 1% of a bin edge? return (1 + (v-binstart)*100/dummyax.dtick)%100 < 2; } // check for too many data points right at the edges of bins // (>50% within 1% of bin edges) or all data points integral // and offset the bins accordingly if(typeof dummyax.dtick === 'number') { var edgecount = 0, midcount = 0, intcount = 0, blankcount = 0; for(var i=0; i datacount * 0.3 || nearEdge(datamin) || nearEdge(datamax)) { // lots of points at the edge, not many in the middle // shift half a bin var binshift = dummyax.dtick / 2; binstart += (binstart+binshift0 && ax.dtick=endtick):(x<=endtick); x = axes.tickIncrement(x,ax.dtick,axrev)) { vals.push(x); // prevent infinite loops if(vals.length>1000) break; } // save the last tick as well as first, so we can // show the exponent only on the last one ax._tmax = vals[vals.length - 1]; var ticksOut = new Array(vals.length); for(var i = 0; i < vals.length; i++) ticksOut[i] = axes.tickText(ax, vals[i]); return ticksOut; }; function arrayTicks(ax) { var vals = ax.tickvals, text = ax.ticktext, ticksOut = new Array(vals.length), r0expanded = ax.range[0] * 1.0001 - ax.range[1] * 0.0001, r1expanded = ax.range[1] * 1.0001 - ax.range[0] * 0.0001, tickMin = Math.min(r0expanded, r1expanded), tickMax = Math.max(r0expanded, r1expanded), vali, i, j = 0; // without a text array, just format the given values as any other ticks // except with more precision to the numbers if(!Array.isArray(text)) text = []; for(i = 0; i < vals.length; i++) { vali = ax.d2l(vals[i]); if(vali > tickMin && vali < tickMax) { if(text[i] === undefined) ticksOut[j] = axes.tickText(ax, vali); else ticksOut[j] = tickTextObj(ax, vali, String(text[i])); j++; } } if(j < vals.length) ticksOut.splice(j, vals.length - j); return ticksOut; } var roundBase10 = [2, 5, 10], roundBase24 = [1, 2, 3, 6, 12], roundBase60 = [1, 2, 5, 10, 15, 30], // 2&3 day ticks are weird, but need something btwn 1&7 roundDays = [1, 2, 3, 7, 14], // approx. tick positions for log axes, showing all (1) and just 1, 2, 5 (2) // these don't have to be exact, just close enough to round to the right value roundLog1 = [-0.046, 0, 0.301, 0.477, 0.602, 0.699, 0.778, 0.845, 0.903, 0.954, 1], roundLog2 = [-0.301, 0, 0.301, 0.699, 1]; function roundDTick(roughDTick, base, roundingSet) { return base * Plotly.Lib.roundUp(roughDTick / base, roundingSet); } // autoTicks: calculate best guess at pleasant ticks for this axis // inputs: // ax - an axis object // roughDTick - rough tick spacing (to be turned into a nice round number) // outputs (into ax): // tick0: starting point for ticks (not necessarily on the graph) // usually 0 for numeric (=10^0=1 for log) or jan 1, 2000 for dates // dtick: the actual, nice round tick spacing, somewhat larger than roughDTick // if the ticks are spaced linearly (linear scale, categories, // log with only full powers, date ticks < month), // this will just be a number // months: M# // years: M# where # is 12*number of years // log with linear ticks: L# where # is the linear tick spacing // log showing powers plus some intermediates: // D1 shows all digits, D2 shows 2 and 5 axes.autoTicks = function(ax, roughDTick) { var base; if(ax.type === 'date') { ax.tick0 = new Date(2000, 0, 1).getTime(); if(roughDTick > 15778800000) { // years if roughDTick > 6mo roughDTick /= 31557600000; base = Math.pow(10, Math.floor(Math.log(roughDTick) / Math.LN10)); ax.dtick = 'M' + (12 * roundDTick(roughDTick, base, roundBase10)); } else if(roughDTick > 1209600000) { // months if roughDTick > 2wk roughDTick /= 2629800000; ax.dtick = 'M' + roundDTick(roughDTick, 1, roundBase24); } else if(roughDTick > 43200000) { // days if roughDTick > 12h ax.dtick = roundDTick(roughDTick, 86400000, roundDays); // get week ticks on sunday ax.tick0 = new Date(2000, 0, 2).getTime(); } else if(roughDTick > 1800000) { // hours if roughDTick > 30m ax.dtick = roundDTick(roughDTick, 3600000, roundBase24); } else if(roughDTick > 30000) { // minutes if roughDTick > 30sec ax.dtick = roundDTick(roughDTick, 60000, roundBase60); } else if(roughDTick > 500) { // seconds if roughDTick > 0.5sec ax.dtick = roundDTick(roughDTick, 1000, roundBase60); } else { //milliseconds base = Math.pow(10, Math.floor(Math.log(roughDTick) / Math.LN10)); ax.dtick = roundDTick(roughDTick, base, roundBase10); } } else if(ax.type === 'log') { ax.tick0 = 0; //only show powers of 10 if(roughDTick > 0.7) ax.dtick = Math.ceil(roughDTick); else if(Math.abs(ax.range[1] - ax.range[0]) < 1) { // span is less than one power of 10 var nt = 1.5 * Math.abs((ax.range[1] - ax.range[0]) / roughDTick); // ticks on a linear scale, labeled fully roughDTick = Math.abs(Math.pow(10, ax.range[1]) - Math.pow(10, ax.range[0])) / nt; base = Math.pow(10, Math.floor(Math.log(roughDTick) / Math.LN10)); ax.dtick = 'L' + roundDTick(roughDTick, base, roundBase10); } else { // include intermediates between powers of 10, // labeled with small digits // ax.dtick = "D2" (show 2 and 5) or "D1" (show all digits) ax.dtick = (roughDTick > 0.3) ? 'D2' : 'D1'; } } else if(ax.type==='category') { ax.tick0 = 0; ax.dtick = Math.ceil(Math.max(roughDTick, 1)); } else { // auto ticks always start at 0 ax.tick0 = 0; base = Math.pow(10, Math.floor(Math.log(roughDTick) / Math.LN10)); ax.dtick = roundDTick(roughDTick, base, roundBase10); } // prevent infinite loops if(ax.dtick === 0) ax.dtick = 1; // TODO: this is from log axis histograms with autorange off if(!isNumeric(ax.dtick) && typeof ax.dtick !=='string') { var olddtick = ax.dtick; ax.dtick = 1; throw 'ax.dtick error: ' + String(olddtick); } }; // after dtick is already known, find tickround = precision // to display in tick labels // for numeric ticks, integer # digits after . to round to // for date ticks, the last date part to show (y,m,d,H,M,S) // or an integer # digits past seconds function autoTickRound(ax) { var dtick = ax.dtick, maxend; ax._tickexponent = 0; if(!isNumeric(dtick) && typeof dtick !== 'string') dtick = 1; if(ax.type === 'category') ax._tickround = null; else if(isNumeric(dtick) || dtick.charAt(0) === 'L') { if(ax.type === 'date') { if(dtick >= 86400000) ax._tickround = 'd'; else if(dtick >= 3600000) ax._tickround = 'H'; else if(dtick >= 60000) ax._tickround = 'M'; else if(dtick >= 1000) ax._tickround = 'S'; else ax._tickround = 3 - Math.round(Math.log(dtick / 2) / Math.LN10); } else { if(!isNumeric(dtick)) dtick = Number(dtick.substr(1)); // 2 digits past largest digit of dtick ax._tickround = 2 - Math.floor(Math.log(dtick) / Math.LN10 + 0.01); if(ax.type === 'log') { maxend = Math.pow(10, Math.max(ax.range[0], ax.range[1])); } else maxend = Math.max(Math.abs(ax.range[0]), Math.abs(ax.range[1])); var rangeexp = Math.floor(Math.log(maxend) / Math.LN10 + 0.01); if(Math.abs(rangeexp) > 3) { if(ax.exponentformat === 'SI' || ax.exponentformat === 'B') { ax._tickexponent = 3 * Math.round((rangeexp - 1) / 3); } else ax._tickexponent = rangeexp; } } } else if(dtick.charAt(0) === 'M') ax._tickround = (dtick.length===2) ? 'm' : 'y'; else ax._tickround = null; } // months and years don't have constant millisecond values // (but a year is always 12 months so we only need months) // log-scale ticks are also not consistently spaced, except // for pure powers of 10 // numeric ticks always have constant differences, other datetime ticks // can all be calculated as constant number of milliseconds axes.tickIncrement = function(x, dtick, axrev) { var axSign = axrev ? -1 : 1; // includes all dates smaller than month, and pure 10^n in log if(isNumeric(dtick)) return x + axSign * dtick; var tType = dtick.charAt(0), dtSigned = axSign * Number(dtick.substr(1)); // Dates: months (or years) if(tType === 'M') { var y = new Date(x); // is this browser consistent? setMonth edits a date but // returns that date's milliseconds return y.setMonth(y.getMonth() + dtSigned); } // Log scales: Linear, Digits else if(tType === 'L') return Math.log(Math.pow(10, x) + dtSigned) / Math.LN10; // log10 of 2,5,10, or all digits (logs just have to be // close enough to round) else if(tType === 'D') { var tickset = (dtick === 'D2') ? roundLog2 : roundLog1, x2 = x + axSign * 0.01, frac = Plotly.Lib.roundUp(mod(x2, 1), tickset, axrev); return Math.floor(x2) + Math.log(d3.round(Math.pow(10, frac), 1)) / Math.LN10; } else throw 'unrecognized dtick ' + String(dtick); }; // calculate the first tick on an axis axes.tickFirst = function(ax) { var axrev = ax.range[1] < ax.range[0], sRound = axrev ? Math.floor : Math.ceil, // add a tiny extra bit to make sure we get ticks // that may have been rounded out r0 = ax.range[0] * 1.0001 - ax.range[1] * 0.0001, dtick = ax.dtick, tick0 = ax.tick0; if(isNumeric(dtick)) { var tmin = sRound((r0 - tick0) / dtick) * dtick + tick0; // make sure no ticks outside the category list if(ax.type === 'category') { tmin = Plotly.Lib.constrain(tmin, 0, ax._categories.length - 1); } return tmin; } var tType = dtick.charAt(0), dtNum = Number(dtick.substr(1)), t0, mdif, t1; // Dates: months (or years) if(tType === 'M') { t0 = new Date(tick0); r0 = new Date(r0); mdif = (r0.getFullYear() - t0.getFullYear()) * 12 + r0.getMonth() - t0.getMonth(); t1 = t0.setMonth(t0.getMonth() + (Math.round(mdif / dtNum) + (axrev ? 1 : -1)) * dtNum); while(axrev ? t1 > r0 : t1 < r0) { t1 = axes.tickIncrement(t1, dtick, axrev); } return t1; } // Log scales: Linear, Digits else if(tType === 'L') { return Math.log(sRound( (Math.pow(10, r0) - tick0) / dtNum) * dtNum + tick0) / Math.LN10; } else if(tType === 'D') { var tickset = (dtick === 'D2') ? roundLog2 : roundLog1, frac = Plotly.Lib.roundUp(mod(r0, 1), tickset, axrev); return Math.floor(r0) + Math.log(d3.round(Math.pow(10, frac), 1)) / Math.LN10; } else throw 'unrecognized dtick ' + String(dtick); }; var yearFormat = d3.time.format('%Y'), monthFormat = d3.time.format('%b %Y'), dayFormat = d3.time.format('%b %-d'), hourFormat = d3.time.format('%b %-d %Hh'), minuteFormat = d3.time.format('%H:%M'), secondFormat = d3.time.format(':%S'); // add one item to d3's vocabulary: // %{n}f where n is the max number of digits // of fractional seconds var fracMatch = /%(\d?)f/g; function modDateFormat(fmt,x) { var fm = fmt.match(fracMatch), d = new Date(x); if(fm) { var digits = Math.min(+fm[1]||6,6), fracSecs = String((x/1000 % 1) + 2.0000005) .substr(2,digits).replace(/0+$/,'')||'0'; return d3.time.format(fmt.replace(fracMatch,fracSecs))(d); } else { return d3.time.format(fmt)(d); } } // draw the text for one tick. // px,py are the location on td.paper // prefix is there so the x axis ticks can be dropped a line // ax is the axis layout, x is the tick value // hover is a (truthy) flag for whether to show numbers with a bit // more precision for hovertext axes.tickText = function(ax, x, hover) { var out = tickTextObj(ax, x), hideexp, arrayMode = ax.tickmode === 'array', extraPrecision = hover || arrayMode, i; if(arrayMode && Array.isArray(ax.ticktext)) { var minDiff = Math.abs(ax.range[1] - ax.range[0]) / 10000; for(i = 0; i < ax.ticktext.length; i++) { if(Math.abs(x - ax.d2l(ax.tickvals[i])) < minDiff) break; } if(i < ax.ticktext.length) { out.text = String(ax.ticktext[i]); return out; } } function isHidden(showAttr) { var first_or_last; if(showAttr === undefined) return true; if(hover) return showAttr==='none'; first_or_last = { first: ax._tmin, last: ax._tmax }[showAttr]; return showAttr!=='all' && x!==first_or_last; } hideexp = ax.exponentformat!=='none' && isHidden(ax.showexponent) ? 'hide' : ''; if(ax.type==='date') formatDate(ax, out, hover, extraPrecision); else if(ax.type==='log') formatLog(ax, out, hover, extraPrecision, hideexp); else if(ax.type==='category') formatCategory(ax, out); else formatLinear(ax, out, hover, extraPrecision, hideexp); // add prefix and suffix if(ax.tickprefix && !isHidden(ax.showtickprefix)) out.text = ax.tickprefix + out.text; if(ax.ticksuffix && !isHidden(ax.showticksuffix)) out.text += ax.ticksuffix; return out; }; function tickTextObj(ax, x, text) { var tf = ax.tickfont || ax._td._fullLayout.font; return { x: x, dx: 0, dy: 0, text: text || '', fontSize: tf.size, font: tf.family, fontColor: tf.color }; } function formatDate(ax, out, hover, extraPrecision) { var x = out.x, tr = ax._tickround, d = new Date(x), // suffix completes the full date info, to be included // with only the first tick suffix = '', tt; if(hover && ax.hoverformat) { tt = modDateFormat(ax.hoverformat,x); } else if(ax.tickformat) { tt = modDateFormat(ax.tickformat,x); // TODO: potentially hunt for ways to automatically add more // precision to the hover text? } else { if(extraPrecision) { if(isNumeric(tr)) tr+=2; else tr = {y: 'm', m: 'd', d: 'H', H: 'M', M: 'S', S: 2}[tr]; } if(tr==='y') tt = yearFormat(d); else if(tr==='m') tt = monthFormat(d); else { if(x===ax._tmin && !hover) { suffix = '
'+yearFormat(d); } if(tr==='d') tt = dayFormat(d); else if(tr==='H') tt = hourFormat(d); else { if(x===ax._tmin && !hover) { suffix = '
'+dayFormat(d)+', '+yearFormat(d); } tt = minuteFormat(d); if(tr!=='M') { tt += secondFormat(d); if(tr!=='S') { tt += numFormat(mod(x/1000,1),ax,'none',hover) .substr(1); } } } } } out.text = tt + suffix; } function formatLog(ax, out, hover, extraPrecision, hideexp) { var dtick = ax.dtick, x = out.x; if(extraPrecision && ((typeof dtick !== 'string') || dtick.charAt(0)!=='L')) dtick = 'L3'; if(ax.tickformat || (typeof dtick === 'string' && dtick.charAt(0) === 'L')) { out.text = numFormat(Math.pow(10, x), ax, hideexp, extraPrecision); } else if(isNumeric(dtick)||((dtick.charAt(0)==='D')&&(mod(x+0.01,1)<0.1))) { if(['e','E','power'].indexOf(ax.exponentformat)!==-1) { var p = Math.round(x); if(p === 0) out.text = 1; else if(p === 1) out.text = '10'; else if(p > 1) out.text = '10' + p + ''; else out.text = '10\u2212' + -p + ''; out.fontSize *= 1.25; } else { out.text = numFormat(Math.pow(10,x), ax,'','fakehover'); if(dtick==='D1' && ax._id.charAt(0)==='y') { out.dy -= out.fontSize/6; } } } else if(dtick.charAt(0) === 'D') { out.text = String(Math.round(Math.pow(10, mod(x, 1)))); out.fontSize *= 0.75; } else throw 'unrecognized dtick ' + String(dtick); // if 9's are printed on log scale, move the 10's away a bit if(ax.dtick==='D1') { var firstChar = String(out.text).charAt(0); if(firstChar === '0' || firstChar === '1') { if(ax._id.charAt(0) === 'y') { out.dx -= out.fontSize / 4; } else { out.dy += out.fontSize / 2; out.dx += (ax.range[1] > ax.range[0] ? 1 : -1) * out.fontSize * (x < 0 ? 0.5 : 0.25); } } } } function formatCategory(ax, out) { var tt = ax._categories[Math.round(out.x)]; if(tt === undefined) tt = ''; out.text = String(tt); } function formatLinear(ax, out, hover, extraPrecision, hideexp) { // don't add an exponent to zero if we're showing all exponents // so the only reason you'd show an exponent on zero is if it's the // ONLY tick to get an exponent (first or last) if(ax.showexponent==='all' && Math.abs(out.x/ax.dtick)<1e-6) { hideexp = 'hide'; } out.text = numFormat(out.x, ax, hideexp, extraPrecision); } // format a number (tick value) according to the axis settings // new, more reliable procedure than d3.round or similar: // add half the rounding increment, then stringify and truncate // also automatically switch to sci. notation var SIPREFIXES = ['f', 'p', 'n', 'μ', 'm', '', 'k', 'M', 'G', 'T']; function numFormat(v, ax, fmtoverride, hover) { // negative? var isNeg = v < 0, // max number of digits past decimal point to show tickRound = ax._tickround, exponentFormat = fmtoverride || ax.exponentformat || 'B', exponent = ax._tickexponent, tickformat = ax.tickformat; // special case for hover: set exponent just for this value, and // add a couple more digits of precision over tick labels if(hover) { // make a dummy axis obj to get the auto rounding and exponent var ah = { exponentformat: ax.exponentformat, dtick: ax.showexponent==='none' ? ax.dtick : (isNumeric(v) ? Math.abs(v) || 1 : 1), // if not showing any exponents, don't change the exponent // from what we calculate range: ax.showexponent === 'none' ? ax.range : [0, v || 1] }; autoTickRound(ah); tickRound = (Number(ah._tickround) || 0) + 4; exponent = ah._tickexponent; if(ax.hoverformat) tickformat = ax.hoverformat; } if(tickformat) return d3.format(tickformat)(v).replace(/-/g,'\u2212'); // 'epsilon' - rounding increment var e = Math.pow(10, -tickRound) / 2; // exponentFormat codes: // 'e' (1.2e+6, default) // 'E' (1.2E+6) // 'SI' (1.2M) // 'B' (same as SI except 10^9=B not G) // 'none' (1200000) // 'power' (1.2x10^6) // 'hide' (1.2, use 3rd argument=='hide' to eg // only show exponent on last tick) if(exponentFormat === 'none') exponent = 0; // take the sign out, put it back manually at the end // - makes cases easier v = Math.abs(v); if(v < e) { // 0 is just 0, but may get exponent if it's the last tick v = '0'; isNeg = false; } else { v += e; // take out a common exponent, if any if(exponent) { v *= Math.pow(10, -exponent); tickRound += exponent; } // round the mantissa if(tickRound === 0) v = String(Math.floor(v)); else if(tickRound < 0) { v = String(Math.round(v)); v = v.substr(0, v.length + tickRound); for(var i = tickRound; i < 0; i++) v += '0'; } else { v = String(v); var dp = v.indexOf('.') + 1; if(dp) v = v.substr(0, dp + tickRound).replace(/\.?0+$/, ''); } // insert appropriate decimal point and thousands separator v = numSeparate(v, ax._td._fullLayout.separators); } // add exponent if(exponent && exponentFormat !== 'hide') { var signedExponent; if(exponent < 0) signedExponent = '\u2212' + -exponent; else if(exponentFormat !== 'power') signedExponent = '+' + exponent; else signedExponent = String(exponent); if(exponentFormat === 'e' || ((exponentFormat === 'SI' || exponentFormat === 'B') && (exponent > 12 || exponent < -15))) { v += 'e' + signedExponent; } else if(exponentFormat === 'E') { v += 'E' + signedExponent; } else if(exponentFormat === 'power') { v += '×10' + signedExponent + ''; } else if(exponentFormat === 'B' && exponent === 9) { v += 'B'; } else if(exponentFormat === 'SI' || exponentFormat === 'B') { v += SIPREFIXES[exponent / 3 + 5]; } } // put sign back in and return // replace standard minus character (which is technically a hyphen) // with a true minus sign if(isNeg) return '\u2212' + v; return v; } // add arbitrary decimal point and thousands separator var findThousands = /(\d+)(\d{3})/; function numSeparate(nStr, separators) { // separators - first char is decimal point, // next char is thousands separator if there is one var dp = separators.charAt(0), thou = separators.charAt(1), x = nStr.split('.'), x1 = x[0], x2 = x.length > 1 ? dp + x[1] : ''; // even if there is a thousands separator, don't use it on // 4-digit integers (like years) if(thou && (x.length > 1 || x1.length>4)) { while(findThousands.test(x1)) { x1 = x1.replace(findThousands, '$1' + thou + '$2'); } } return x1 + x2; } axes.subplotMatch = /^x([0-9]*)y([0-9]*)$/; // getSubplots - extract all combinations of axes we need to make plots for // as an array of items like 'xy', 'x2y', 'x2y2'... // sorted by x (x,x2,x3...) then y // optionally restrict to only subplots containing axis object ax // looks both for combinations of x and y found in the data // and at axes and their anchors axes.getSubplots = function(gd, ax) { var subplots = []; var i, j, sp; // look for subplots in the data var data = gd.data || []; for(i = 0; i < data.length; i++) { var trace = data[i]; if(trace.visible === false || trace.visible === 'legendonly' || !(Plotly.Plots.traceIs(trace, 'cartesian') || Plotly.Plots.traceIs(trace, 'gl2d')) ) continue; var xId = trace.xaxis || 'x', yId = trace.yaxis || 'y'; sp = xId + yId; if(subplots.indexOf(sp) === -1) subplots.push(sp); } // look for subplots in the axes/anchors, so that we at least draw all axes var axesList = axes.list(gd, '', true); function hasAx2(sp, ax2) { return sp.indexOf(ax2._id) !== -1; } for(i = 0; i < axesList.length; i++) { var ax2 = axesList[i], ax2Letter = ax2._id.charAt(0), ax3Id = (ax2.anchor === 'free') ? ((ax2Letter === 'x') ? 'y' : 'x') : ax2.anchor, ax3 = axes.getFromId(gd, ax3Id); // look if ax2 is already represented in the data var foundAx2 = false; for(j = 0; j < subplots.length; j++) { if(hasAx2(subplots[j], ax2)) { foundAx2 = true; break; } } // ignore free axes that already represented in the data if(ax2.anchor === 'free' && foundAx2) continue; // ignore anchor-less axes if(!ax3) continue; sp = (ax2Letter === 'x') ? ax2._id + ax3._id : ax3._id + ax2._id; if(subplots.indexOf(sp) === -1) subplots.push(sp); } // filter invalid subplots var spMatch = axes.subplotMatch, allSubplots = []; for(i = 0; i < subplots.length; i++) { sp = subplots[i]; if(spMatch.test(sp)) allSubplots.push(sp); } // sort the subplot ids allSubplots.sort(function(a, b) { var aMatch = a.match(spMatch), bMatch = b.match(spMatch); if(aMatch[1] === bMatch[1]) { return +(aMatch[2]||1) - (bMatch[2]||1); } return +(aMatch[1]||0) - (bMatch[1]||0); }); if(ax) return axes.findSubplotsWithAxis(allSubplots, ax); return allSubplots; }; // find all subplots with axis 'ax' axes.findSubplotsWithAxis = function(subplots, ax) { var axMatch = new RegExp( (ax._id.charAt(0) === 'x') ? ('^' + ax._id + 'y') : (ax._id + '$') ); var subplotsWithAxis = []; for(var i = 0; i < subplots.length; i++) { var sp = subplots[i]; if(axMatch.test(sp)) subplotsWithAxis.push(sp); } return subplotsWithAxis; }; // makeClipPaths: prepare clipPaths for all single axes and all possible xy pairings axes.makeClipPaths = function(td) { var layout = td._fullLayout, defs = layout._defs, fullWidth = {_offset: 0, _length: layout.width, _id: ''}, fullHeight = {_offset: 0, _length: layout.height, _id: ''}, xaList = axes.list(td, 'x', true), yaList = axes.list(td, 'y', true), clipList = [], i, j; for(i = 0; i < xaList.length; i++) { clipList.push({x: xaList[i], y: fullHeight}); for(j = 0; j < yaList.length; j++) { if(i===0) clipList.push({x: fullWidth, y: yaList[j]}); clipList.push({x: xaList[i], y: yaList[j]}); } } var defGroup = defs.selectAll('g.clips') .data([0]); defGroup.enter().append('g') .classed('clips', true); // selectors don't work right with camelCase tags, // have to use class instead // https://groups.google.com/forum/#!topic/d3-js/6EpAzQ2gU9I var axClips = defGroup.selectAll('.axesclip') .data(clipList, function(d) { return d.x._id + d.y._id; }); axClips.enter().append('clipPath') .classed('axesclip', true) .attr('id', function(d) { return 'clip' + layout._uid + d.x._id + d.y._id; }) .append('rect'); axClips.exit().remove(); axClips.each(function(d) { d3.select(this).select('rect').attr({ x: d.x._offset || 0, y: d.y._offset || 0, width: d.x._length || 1, height: d.y._length || 1 }); }); }; // doTicks: draw ticks, grids, and tick labels // axid: 'x', 'y', 'x2' etc, // blank to do all, // 'redraw' to force full redraw, and reset ax._r // (stored range for use by zoom/pan) // or can pass in an axis object directly axes.doTicks = function(td, axid, skipTitle) { var fullLayout = td._fullLayout, ax, independent = false; // allow passing an independent axis object instead of id if(typeof axid === 'object') { ax = axid; axid = ax._id; independent = true; } else { ax = axes.getFromId(td,axid); if(axid==='redraw') { fullLayout._paper.selectAll('g.subplot').each(function(subplot) { var plotinfo = fullLayout._plots[subplot], xa = plotinfo.x(), ya = plotinfo.y(); plotinfo.plot.attr('viewBox', '0 0 '+xa._length+' '+ya._length); plotinfo.xaxislayer .selectAll('.'+xa._id+'tick').remove(); plotinfo.yaxislayer .selectAll('.'+ya._id+'tick').remove(); plotinfo.gridlayer .selectAll('path').remove(); plotinfo.zerolinelayer .selectAll('path').remove(); }); } if(!axid || axid==='redraw') { return Plotly.Lib.syncOrAsync(axes.list(td, '', true).map(function(ax) { return function() { if(!ax._id) return; var axDone = axes.doTicks(td,ax._id); if(axid==='redraw') ax._r = ax.range.slice(); return axDone; }; })); } } // make sure we only have allowed options for exponents // (others can make confusing errors) if(!ax.tickformat) { if(['none','e','E','power','SI','B'].indexOf(ax.exponentformat)===-1) { ax.exponentformat = 'e'; } if(['all','first','last','none'].indexOf(ax.showexponent)===-1) { ax.showexponent = 'all'; } } // in case a val turns into string somehow ax.range = [+ax.range[0], +ax.range[1]]; // set scaling to pixels ax.setScale(); var axletter = axid.charAt(0), counterLetter = axes.counterLetter(axid), vals = axes.calcTicks(ax), datafn = function(d) { return d.text + d.x + ax.mirror; }, tcls = axid+'tick', gcls = axid+'grid', zcls = axid+'zl', pad = (ax.linewidth||1) / 2, labelStandoff = (ax.ticks==='outside' ? ax.ticklen : 1) + (ax.linewidth||0), gridWidth = Plotly.Drawing.crispRound(td, ax.gridwidth, 1), zeroLineWidth = Plotly.Drawing.crispRound(td, ax.zerolinewidth, gridWidth), tickWidth = Plotly.Drawing.crispRound(td, ax.tickwidth, 1), sides, transfn, tickprefix, tickmid, i; // positioning arguments for x vs y axes if(axletter==='x') { sides = ['bottom', 'top']; transfn = function(d) { return 'translate('+ax.l2p(d.x)+',0)'; }; // dumb templating with string concat // would be better to use an actual template tickprefix = 'M0,'; tickmid = 'v'; } else if(axletter==='y') { sides = ['left', 'right']; transfn = function(d) { return 'translate(0,'+ax.l2p(d.x)+')'; }; tickprefix = 'M'; tickmid = ',0h'; } else { console.log('unrecognized doTicks axis', axid); return; } var axside = ax.side||sides[0], // which direction do the side[0], side[1], and free ticks go? // then we flip if outside XOR y axis ticksign = [-1, 1, axside===sides[1] ? 1 : -1]; if((ax.ticks!=='inside') === (axletter==='x')) { ticksign = ticksign.map(function(v) { return -v; }); } // remove zero lines, grid lines, and inside ticks if they're within // 1 pixel of the end // The key case here is removing zero lines when the axis bound is zero. function clipEnds(d) { var p = ax.l2p(d.x); return (p>1 && p1) { for(j = 1; j < groupsi.length; j++) { groupj = groups[groupsi[j]]; mergeAxisGroups(group0.x, groupj.x); mergeAxisGroups(group0.y, groupj.y); } } mergeAxisGroups(group0.x, [xi]); mergeAxisGroups(group0.y, [yi]); } return groups; } function mergeAxisGroups(intoSet, fromSet) { for(var i = 0; i < fromSet.length; i++) { if(intoSet.indexOf(fromSet[i]) === -1) intoSet.push(fromSet[i]); } } function swapAxisGroup(gd, xIds, yIds) { var i, j, xFullAxes = [], yFullAxes = [], layout = gd.layout; for(i = 0; i < xIds.length; i++) xFullAxes.push(axes.getFromId(gd, xIds[i])); for(i = 0; i < yIds.length; i++) yFullAxes.push(axes.getFromId(gd, yIds[i])); var allAxKeys = Object.keys(xFullAxes[0]), noSwapAttrs = [ 'anchor', 'domain', 'overlaying', 'position', 'side', 'tickangle' ], numericTypes = ['linear', 'log']; for(i = 0; i < allAxKeys.length; i++) { var keyi = allAxKeys[i], xVal = xFullAxes[0][keyi], yVal = yFullAxes[0][keyi], allEqual = true, coerceLinearX = false, coerceLinearY = false; if(keyi.charAt(0) === '_' || typeof xVal === 'function' || noSwapAttrs.indexOf(keyi) !== -1) { continue; } for(j = 1; j < xFullAxes.length && allEqual; j++) { var xVali = xFullAxes[j][keyi]; if(keyi === 'type' && numericTypes.indexOf(xVal) !== -1 && numericTypes.indexOf(xVali) !== -1 && xVal !== xVali) { // type is special - if we find a mixture of linear and log, // coerce them all to linear on flipping coerceLinearX = true; } else if(xVali !== xVal) allEqual = false; } for(j = 1; j < yFullAxes.length && allEqual; j++) { var yVali = yFullAxes[j][keyi]; if(keyi === 'type' && numericTypes.indexOf(yVal) !== -1 && numericTypes.indexOf(yVali) !== -1 && yVal !== yVali) { // type is special - if we find a mixture of linear and log, // coerce them all to linear on flipping coerceLinearY = true; } else if(yFullAxes[j][keyi] !== yVal) allEqual = false; } if(allEqual) { if(coerceLinearX) layout[xFullAxes[0]._name].type = 'linear'; if(coerceLinearY) layout[yFullAxes[0]._name].type = 'linear'; swapAxisAttrs(layout, keyi, xFullAxes, yFullAxes); } } // now swap x&y for any annotations anchored to these x & y for(i = 0; i < gd._fullLayout.annotations.length; i++) { var ann = gd._fullLayout.annotations[i]; if(xIds.indexOf(ann.xref) !== -1 && yIds.indexOf(ann.yref) !== -1) { Plotly.Lib.swapAttrs(layout.annotations[i],['?']); } } } function swapAxisAttrs(layout, key, xFullAxes, yFullAxes) { // in case the value is the default for either axis, // look at the first axis in each list and see if // this key's value is undefined var np = Plotly.Lib.nestedProperty, xVal = np(layout[xFullAxes[0]._name], key).get(), yVal = np(layout[yFullAxes[0]._name], key).get(), i; if(key === 'title') { // special handling of placeholder titles if(xVal === 'Click to enter X axis title') { xVal = 'Click to enter Y axis title'; } if(yVal === 'Click to enter Y axis title') { yVal = 'Click to enter X axis title'; } } for(i = 0; i < xFullAxes.length; i++) { np(layout, xFullAxes[i]._name + '.' + key).set(yVal); } for(i = 0; i < yFullAxes.length; i++) { np(layout, yFullAxes[i]._name + '.' + key).set(xVal); } } // mod - version of modulus that always restricts to [0,divisor) // rather than built-in % which gives a negative value for negative v function mod(v,d) { return ((v%d) + d) % d; } },{"../../components/titles":332,"../../plotly":366,"./axis_ids":371,"./layout_attributes":376,"./layout_defaults":377,"./set_convert":380,"d3":70,"fast-isnumeric":74}],370:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var Plots = require('../plots'); var layoutAttributes = require('./layout_attributes'); var handleTickValueDefaults = require('./tick_value_defaults'); var handleTickDefaults = require('./tick_defaults'); var setConvert = require('./set_convert'); var cleanDatum = require('./clean_datum'); var axisIds = require('./axis_ids'); /** * options: object containing: * * letter: 'x' or 'y' * title: name of the axis (ie 'Colorbar') to go in default title * name: axis object name (ie 'xaxis') if one should be stored * font: the default font to inherit * outerTicks: boolean, should ticks default to outside? * showGrid: boolean, should gridlines be shown by default? * noHover: boolean, this axis doesn't support hover effects? * data: the plot data to use in choosing auto type */ module.exports = function handleAxisDefaults(containerIn, containerOut, coerce, options) { var letter = options.letter, font = options.font || {}, defaultTitle = 'Click to enter ' + (options.title || (letter.toUpperCase() + ' axis')) + ' title'; // set up some private properties if(options.name) { containerOut._name = options.name; containerOut._id = axisIds.name2id(options.name); } // now figure out type and do some more initialization var axType = coerce('type'); if(axType === '-') { setAutoType(containerOut, options.data); if(containerOut.type === '-') { containerOut.type = 'linear'; } else { // copy autoType back to input axis // note that if this object didn't exist // in the input layout, we have to put it in // this happens in the main supplyDefaults function axType = containerIn.type = containerOut.type; } } setConvert(containerOut); coerce('title', defaultTitle); Lib.coerceFont(coerce, 'titlefont', { family: font.family, size: Math.round(font.size * 1.2), color: font.color }); var validRange = ( (containerIn.range || []).length === 2 && isNumeric(containerIn.range[0]) && isNumeric(containerIn.range[1]) ); var autoRange = coerce('autorange', !validRange); if(autoRange) coerce('rangemode'); var range = coerce('range', [-1, letter === 'x' ? 6 : 4]); if(range[0] === range[1]) { containerOut.range = [range[0] - 1, range[0] + 1]; } Lib.noneOrAll(containerIn.range, containerOut.range, [0, 1]); coerce('fixedrange'); handleTickValueDefaults(containerIn, containerOut, coerce, axType); handleTickDefaults(containerIn, containerOut, coerce, axType, options); var lineColor = Lib.coerce2(containerIn, containerOut, layoutAttributes, 'linecolor'), lineWidth = Lib.coerce2(containerIn, containerOut, layoutAttributes, 'linewidth'), showLine = coerce('showline', !!lineColor || !!lineWidth); if(!showLine) { delete containerOut.linecolor; delete containerOut.linewidth; } if(showLine || containerOut.ticks) coerce('mirror'); var gridColor = Lib.coerce2(containerIn, containerOut, layoutAttributes, 'gridcolor'), gridWidth = Lib.coerce2(containerIn, containerOut, layoutAttributes, 'gridwidth'), showGridLines = coerce('showgrid', options.showGrid || !!gridColor || !!gridWidth); if(!showGridLines) { delete containerOut.gridcolor; delete containerOut.gridwidth; } var zeroLineColor = Lib.coerce2(containerIn, containerOut, layoutAttributes, 'zerolinecolor'), zeroLineWidth = Lib.coerce2(containerIn, containerOut, layoutAttributes, 'zerolinewidth'), showZeroLine = coerce('zeroline', options.showGrid || !!zeroLineColor || !!zeroLineWidth); if(!showZeroLine) { delete containerOut.zerolinecolor; delete containerOut.zerolinewidth; } return containerOut; }; function setAutoType(ax, data) { // new logic: let people specify any type they want, // only autotype if type is '-' if(ax.type!=='-') return; var id = ax._id, axLetter = id.charAt(0); // support 3d if(id.indexOf('scene') !== -1) id = axLetter; var d0 = getFirstNonEmptyTrace(data, id, axLetter); if(!d0) return; // first check for histograms, as the count direction // should always default to a linear axis if(d0.type==='histogram' && axLetter === {v: 'y', h: 'x'}[d0.orientation || 'v']) { ax.type='linear'; return; } // check all boxes on this x axis to see // if they're dates, numbers, or categories if(isBoxWithoutPositionCoords(d0, axLetter)) { var posLetter = getBoxPosLetter(d0), boxPositions = [], trace; for(var i = 0; i < data.length; i++) { trace = data[i]; if(!Plots.traceIs(trace, 'box') || (trace[axLetter + 'axis'] || axLetter) !== id) continue; if(trace[posLetter] !== undefined) boxPositions.push(trace[posLetter][0]); else if(trace.name !== undefined) boxPositions.push(trace.name); else boxPositions.push('text'); } ax.type = autoType(boxPositions); } else { ax.type = autoType(d0[axLetter] || [d0[axLetter+'0']]); } } function getBoxPosLetter(trace) { return {v: 'x', h: 'y'}[trace.orientation || 'v']; } function isBoxWithoutPositionCoords(trace, axLetter) { var posLetter = getBoxPosLetter(trace); return ( Plots.traceIs(trace, 'box') && axLetter === posLetter && trace[posLetter] === undefined && trace[posLetter + '0'] === undefined ); } function autoType(array) { if(moreDates(array)) return 'date'; if(category(array)) return 'category'; if(linearOK(array)) return 'linear'; else return '-'; } function getFirstNonEmptyTrace(data, id, axLetter) { for(var i = 0; i < data.length; i++) { var trace = data[i]; if((trace[axLetter + 'axis'] || axLetter) === id) { if(isBoxWithoutPositionCoords(trace, axLetter)) { return trace; } else if((trace[axLetter] || []).length || trace[axLetter + '0']) { return trace; } } } } // is there at least one number in array? If not, we should leave // ax.type empty so it can be autoset later function linearOK(array) { if(!array) return false; for(var i = 0; i < array.length; i++) { if(isNumeric(array[i])) return true; } return false; } // does the array a have mostly dates rather than numbers? // note: some values can be neither (such as blanks, text) // 2- or 4-digit integers can be both, so require twice as many // dates as non-dates, to exclude cases with mostly 2 & 4 digit // numbers and a few dates function moreDates(a) { var dcnt = 0, ncnt = 0, // test at most 1000 points, evenly spaced inc = Math.max(1, (a.length - 1) / 1000), ai; for(var i = 0; i < a.length; i += inc) { ai = a[Math.round(i)]; if(Lib.isDateTime(ai)) dcnt += 1; if(isNumeric(ai)) ncnt += 1; } return (dcnt > ncnt * 2); } // are the (x,y)-values in td.data mostly text? // require twice as many categories as numbers function category(a) { // test at most 1000 points var inc = Math.max(1, (a.length - 1) / 1000), curvenums = 0, curvecats = 0, ai; for(var i = 0; i < a.length; i += inc) { ai = cleanDatum(a[Math.round(i)]); if(isNumeric(ai)) curvenums++; else if(typeof ai === 'string' && ai !== '' && ai !== 'None') curvecats++; } return curvecats > curvenums * 2; } },{"../../lib":349,"../plots":413,"./axis_ids":371,"./clean_datum":372,"./layout_attributes":376,"./set_convert":380,"./tick_defaults":381,"./tick_value_defaults":382,"fast-isnumeric":74}],371:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plots = require('../plots'); var Lib = require('../../lib'); var constants = require('./constants'); // convert between axis names (xaxis, xaxis2, etc, elements of gd.layout) // and axis id's (x, x2, etc). Would probably have ditched 'xaxis' // completely in favor of just 'x' if it weren't ingrained in the API etc. exports.id2name = function id2name(id) { if(typeof id !== 'string' || !id.match(constants.AX_ID_PATTERN)) return; var axNum = id.substr(1); if(axNum === '1') axNum = ''; return id.charAt(0) + 'axis' + axNum; }; exports.name2id = function name2id(name) { if(!name.match(constants.AX_NAME_PATTERN)) return; var axNum = name.substr(5); if(axNum === '1') axNum = ''; return name.charAt(0) + axNum; }; exports.cleanId = function cleanId(id, axLetter) { if(!id.match(constants.AX_ID_PATTERN)) return; if(axLetter && id.charAt(0) !== axLetter) return; var axNum = id.substr(1).replace(/^0+/,''); if(axNum === '1') axNum = ''; return id.charAt(0) + axNum; }; // get all axis object names // optionally restricted to only x or y or z by string axLetter // and optionally 2D axes only, not those inside 3D scenes function listNames(gd, axLetter, only2d) { var fullLayout = gd._fullLayout; if(!fullLayout) return []; function filterAxis(obj, extra) { var keys = Object.keys(obj), axMatch = /^[xyz]axis[0-9]*/, out = []; for(var i = 0; i < keys.length; i++) { var k = keys[i]; if(axLetter && k.charAt(0) !== axLetter) continue; if(axMatch.test(k)) out.push(extra + k); } return out.sort(); } var names = filterAxis(fullLayout, ''); if(only2d) return names; var sceneIds3D = Plots.getSubplotIds(fullLayout, 'gl3d') || []; for(var i = 0; i < sceneIds3D.length; i++) { var sceneId = sceneIds3D[i]; names = names.concat( filterAxis(fullLayout[sceneId], sceneId + '.') ); } return names; } // get all axis objects, as restricted in listNames exports.list = function(gd, axletter, only2d) { return listNames(gd, axletter, only2d) .map(function(axName) { return Lib.nestedProperty(gd._fullLayout, axName).get(); }); }; // get all axis ids, optionally restricted by letter // this only makes sense for 2d axes exports.listIds = function(gd, axletter) { return listNames(gd, axletter, true).map(exports.name2id); }; // get an axis object from its id 'x','x2' etc // optionally, id can be a subplot (ie 'x2y3') and type gets x or y from it exports.getFromId = function(gd, id, type) { var fullLayout = gd._fullLayout; if(type === 'x') id = id.replace(/y[0-9]*/,''); else if(type === 'y') id = id.replace(/x[0-9]*/,''); return fullLayout[exports.id2name(id)]; }; // get an axis object of specified type from the containing trace exports.getFromTrace = function(gd, fullTrace, type) { var fullLayout = gd._fullLayout; var ax = null; if(Plots.traceIs(fullTrace, 'gl3d')) { var scene = fullTrace.scene; if(scene.substr(0, 5) === 'scene') { ax = fullLayout[scene][type + 'axis']; } } else { ax = exports.getFromId(gd, fullTrace[type + 'axis'] || type); } return ax; }; },{"../../lib":349,"../plots":413,"./constants":373}],372:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); /** * cleanDatum: removes characters * same replace criteria used in the grid.js:scrapeCol * but also handling dates, numbers, and NaN, null, Infinity etc */ module.exports = function cleanDatum(c) { try { if(typeof c === 'object' && c !== null && c.getTime) { return Lib.ms2DateTime(c); } if(typeof c !== 'string' && !isNumeric(c)) { return ''; } c = c.toString().replace(/['"%,$# ]/g, ''); } catch(e) { console.log(e, c); } return c; }; },{"../../lib":349,"fast-isnumeric":74}],373:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { /** * standardize all missing data in calcdata to use undefined * never null or NaN. * that way we can use !==undefined, or !== BADNUM, * to test for real data */ BADNUM: undefined, // axis match regular expression xAxisMatch: /^xaxis[0-9]*$/, yAxisMatch: /^yaxis[0-9]*$/, // pattern matching axis ids and names AX_ID_PATTERN: /^[xyz][0-9]*$/, AX_NAME_PATTERN: /^[xyz]axis[0-9]*$/, // ms between first mousedown and 2nd mouseup to constitute dblclick... // we don't seem to have access to the system setting DBLCLICKDELAY: 600, // pixels to move mouse before you stop clamping to starting point MINDRAG: 8, // smallest dimension allowed for a select box MINSELECT: 12, // smallest dimension allowed for a zoombox MINZOOM: 20, // width of axis drag regions DRAGGERSIZE: 20, // max pixels away from mouse to allow a point to highlight MAXDIST: 20, // hover labels for multiple horizontal bars get tilted by this angle YANGLE: 60, // size and display constants for hover text HOVERARROWSIZE: 6, // pixel size of hover arrows HOVERTEXTPAD: 3, // pixels padding around text HOVERFONTSIZE: 13, HOVERFONT: 'Arial, sans-serif', // minimum time (msec) between hover calls HOVERMINTIME: 100, // max pixels off straight before a lasso select line counts as bent BENDPX: 1.5 }; },{}],374:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var tinycolor = require('tinycolor2'); var isNumeric = require('fast-isnumeric'); var Plotly = require('../../plotly'); var Lib = require('../../lib'); var Events = require('../../lib/events'); var prepSelect = require('./select'); var constants = require('./constants'); var fx = module.exports = {}; fx.layoutAttributes = { dragmode: { valType: 'enumerated', values: ['zoom', 'pan', 'select', 'lasso', 'orbit', 'turntable'], dflt: 'zoom', }, hovermode: { valType: 'enumerated', values: ['x', 'y', 'closest', false], } }; fx.supplyLayoutDefaults = function(layoutIn, layoutOut, fullData) { function coerce(attr, dflt) { return Lib.coerce(layoutIn, layoutOut, fx.layoutAttributes, attr, dflt); } coerce('dragmode'); var hovermodeDflt; if(layoutOut._hasCartesian) { // flag for 'horizontal' plots: // determines the state of the mode bar 'compare' hovermode button var isHoriz = layoutOut._isHoriz = fx.isHoriz(fullData); hovermodeDflt = isHoriz ? 'y' : 'x'; } else hovermodeDflt = 'closest'; coerce('hovermode', hovermodeDflt); }; fx.isHoriz = function(fullData) { var isHoriz = true; for(var i = 0; i < fullData.length; i++) { var trace = fullData[i]; if(trace.orientation !== 'h') { isHoriz = false; break; } } return isHoriz; }; fx.init = function(gd) { var fullLayout = gd._fullLayout; if(!fullLayout._hasCartesian || gd._context.staticPlot) return; var subplots = Object.keys(fullLayout._plots || {}).sort(function(a,b) { // sort overlays last, then by x axis number, then y axis number if((fullLayout._plots[a].mainplot && true) === (fullLayout._plots[b].mainplot && true)) { var aParts = a.split('y'), bParts = b.split('y'); return (aParts[0]===bParts[0]) ? (Number(aParts[1]||1) - Number(bParts[1]||1)) : (Number(aParts[0]||1) - Number(bParts[0]||1)); } return fullLayout._plots[a].mainplot ? 1 : -1; }); subplots.forEach(function(subplot) { var plotinfo = fullLayout._plots[subplot]; if(!fullLayout._hasCartesian) return; var xa = plotinfo.x(), ya = plotinfo.y(), // the y position of the main x axis line y0 = (xa._linepositions[subplot]||[])[3], // the x position of the main y axis line x0 = (ya._linepositions[subplot]||[])[3]; var DRAGGERSIZE = constants.DRAGGERSIZE; if(isNumeric(y0) && xa.side==='top') y0 -= DRAGGERSIZE; if(isNumeric(x0) && ya.side!=='right') x0 -= DRAGGERSIZE; // main and corner draggers need not be repeated for // overlaid subplots - these draggers drag them all if(!plotinfo.mainplot) { // main dragger goes over the grids and data, so we use its // mousemove events for all data hover effects var maindrag = dragBox(gd, plotinfo, 0, 0, xa._length, ya._length,'ns','ew'); maindrag.onmousemove = function(evt) { fx.hover(gd, evt, subplot); fullLayout._lasthover = maindrag; fullLayout._hoversubplot = subplot; }; /* * IMPORTANT: * We must check for the presence of the drag cover here. * If we don't, a 'mouseout' event is triggered on the * maindrag before each 'click' event, which has the effect * of clearing the hoverdata; thus, cancelling the click event. */ maindrag.onmouseout = function(evt) { if(gd._dragging) return; fx.unhover(gd, evt); }; maindrag.onclick = function(evt) { fx.click(gd, evt); }; // corner draggers dragBox(gd, plotinfo, -DRAGGERSIZE, -DRAGGERSIZE, DRAGGERSIZE, DRAGGERSIZE, 'n', 'w'); dragBox(gd, plotinfo, xa._length, -DRAGGERSIZE, DRAGGERSIZE, DRAGGERSIZE, 'n', 'e'); dragBox(gd, plotinfo, -DRAGGERSIZE, ya._length, DRAGGERSIZE, DRAGGERSIZE, 's', 'w'); dragBox(gd, plotinfo, xa._length, ya._length, DRAGGERSIZE, DRAGGERSIZE, 's', 'e'); } // x axis draggers - if you have overlaid plots, // these drag each axis separately if(isNumeric(y0)) { if(xa.anchor==='free') y0 -= fullLayout._size.h*(1-ya.domain[1]); dragBox(gd, plotinfo, xa._length*0.1, y0, xa._length*0.8, DRAGGERSIZE, '', 'ew'); dragBox(gd, plotinfo, 0, y0, xa._length*0.1, DRAGGERSIZE, '', 'w'); dragBox(gd, plotinfo, xa._length*0.9, y0, xa._length*0.1, DRAGGERSIZE, '', 'e'); } // y axis draggers if(isNumeric(x0)) { if(ya.anchor==='free') x0 -= fullLayout._size.w*xa.domain[0]; dragBox(gd, plotinfo, x0, ya._length*0.1, DRAGGERSIZE, ya._length*0.8, 'ns', ''); dragBox(gd, plotinfo, x0, ya._length*0.9, DRAGGERSIZE, ya._length*0.1, 's', ''); dragBox(gd, plotinfo, x0, 0, DRAGGERSIZE, ya._length*0.1, 'n', ''); } }); // In case you mousemove over some hovertext, send it to fx.hover too // we do this so that we can put the hover text in front of everything, // but still be able to interact with everything as if it isn't there var hoverLayer = fullLayout._hoverlayer.node(); hoverLayer.onmousemove = function(evt) { evt.target = fullLayout._lasthover; fx.hover(gd, evt, fullLayout._hoversubplot); }; hoverLayer.onclick = function(evt) { evt.target = fullLayout._lasthover; fx.click(gd, evt); }; // also delegate mousedowns... TODO: does this actually work? hoverLayer.onmousedown = function(evt) { fullLayout._lasthover.onmousedown(evt); }; }; // hover labels for multiple horizontal bars get tilted by some angle, // then need to be offset differently if they overlap var YANGLE = constants.YANGLE, YA_RADIANS = Math.PI*YANGLE/180, // expansion of projected height YFACTOR = 1/Math.sin(YA_RADIANS), // to make the appropriate post-rotation x offset, // you need both x and y offsets YSHIFTX = Math.cos(YA_RADIANS), YSHIFTY = Math.sin(YA_RADIANS); // convenience functions for mapping all relevant axes function flat(subplots, v) { var out = []; for(var i=subplots.length; i>0; i--) out.push(v); return out; } function p2c(axArray, v) { var out = []; for(var i=0; i gd._lastHoverTime + constants.HOVERMINTIME) { hover(gd,evt,subplot); gd._lastHoverTime = Date.now(); return; } // Queue up the next hover for 100ms from now (if no further events) gd._hoverTimer = setTimeout(function() { hover(gd,evt,subplot); gd._lastHoverTime = Date.now(); gd._hoverTimer = undefined; }, constants.HOVERMINTIME); }; fx.unhover = function(gd, evt, subplot) { if(typeof gd === 'string') gd = document.getElementById(gd); // Important, clear any queued hovers if(gd._hoverTimer) { clearTimeout(gd._hoverTimer); gd._hoverTimer = undefined; } unhover(gd,evt,subplot); }; // The actual implementation is here: function hover(gd, evt, subplot) { if(subplot === 'pie') { gd.emit('plotly_hover', { points: [evt] }); return; } if(!subplot) subplot = 'xy'; var fullLayout = gd._fullLayout, plotinfo = fullLayout._plots[subplot], // list of all overlaid subplots to look at subplots = [subplot].concat(plotinfo.overlays .map(function(pi) { return pi.id; })), xaArray = subplots.map(function(spId) { return Plotly.Axes.getFromId(gd, spId, 'x'); }), yaArray = subplots.map(function(spId) { return Plotly.Axes.getFromId(gd, spId, 'y'); }), hovermode = evt.hovermode || fullLayout.hovermode; if(['x','y','closest'].indexOf(hovermode)===-1 || !gd.calcdata || gd.querySelector('.zoombox') || gd._dragging) { return unhover(gd, evt); } // hoverData: the set of candidate points we've found to highlight var hoverData = [], // searchData: the data to search in. Mostly this is just a copy of // gd.calcdata, filtered to the subplot and overlays we're on // but if a point array is supplied it will be a mapping // of indicated curves searchData = [], // [x|y]valArray: the axis values of the hover event // mapped onto each of the currently selected overlaid subplots xvalArray, yvalArray, // used in loops itemnum, curvenum, cd, trace, subploti, mode, xval, yval, pointData, closedataPreviousLength; // Figure out what we're hovering on: // mouse location or user-supplied data if(Array.isArray(evt)) { // user specified an array of points to highlight hovermode = 'array'; for(itemnum = 0; itemnumdbb.width || ypx<0 || ypx>dbb.height) { return unhover(gd,evt); } } else { if('xpx' in evt) xpx = evt.xpx; else xpx = xaArray[0]._length/2; if('ypx' in evt) ypx = evt.ypx; else ypx = yaArray[0]._length/2; } if('xval' in evt) xvalArray = flat(subplots, evt.xval); else xvalArray = p2c(xaArray, xpx); if('yval' in evt) yvalArray = flat(subplots, evt.yval); else yvalArray = p2c(yaArray, ypx); if(!isNumeric(xvalArray[0]) || !isNumeric(yvalArray[0])) { console.log('Plotly.Fx.hover failed', evt, gd); return unhover(gd, evt); } } // the pixel distance to beat as a matching point // in 'x' or 'y' mode this resets for each trace var distance = Infinity; // find the closest point in each trace // this is minimum dx and/or dy, depending on mode // and the pixel position for the label (labelXpx, labelYpx) for(curvenum = 0; curvenum1 || trace.hoverinfo.indexOf('name')!==-1) ? trace.name : undefined, // point properties - override all of these index: false, // point index in trace - only used by plotly.js hoverdata consumers distance: Math.min(distance, constants.MAXDIST), // pixel distance or pseudo-distance color: Plotly.Color.defaultLine, // trace color x0: undefined, x1: undefined, y0: undefined, y1: undefined, xLabelVal: undefined, yLabelVal: undefined, zLabelVal: undefined, text: undefined }; closedataPreviousLength = hoverData.length; // for a highlighting array, figure out what // we're searching for with this element if(mode==='array') { var selection = evt[curvenum]; if('pointNumber' in selection) { pointData.index = selection.pointNumber; mode = 'closest'; } else { mode = ''; if('xval' in selection) { xval = selection.xval; mode = 'x'; } if('yval' in selection) { yval = selection.yval; mode = mode ? 'closest' : 'y'; } } } else { xval = xvalArray[subploti]; yval = yvalArray[subploti]; } // Now find the points. if(trace._module && trace._module.hoverPoints) { var newPoints = trace._module.hoverPoints(pointData, xval, yval, mode); if(newPoints) { var newPoint; for(var newPointNum=0; newPointNum closedataPreviousLength) { hoverData.splice(0, closedataPreviousLength); distance = hoverData[0].distance; } } // nothing left: remove all labels and quit if(hoverData.length===0) return unhover(gd,evt); // if there's more than one horz bar trace, // rotate the labels so they don't overlap var rotateLabels = hovermode==='y' && searchData.length>1; hoverData.sort(function(d1, d2) { return d1.distance - d2.distance; }); var labelOpts = { hovermode: hovermode, rotateLabels: rotateLabels, bgColor: Plotly.Color.combine(fullLayout.plot_bgcolor, fullLayout.paper_bgcolor), container: fullLayout._hoverlayer, outerContainer: fullLayout._paperdiv }; var hoverLabels = createHoverText(hoverData, labelOpts); hoverAvoidOverlaps(hoverData, rotateLabels ? xaArray[0] : yaArray[0]); alignHoverText(hoverLabels, rotateLabels); // lastly, emit custom hover/unhover events var oldhoverdata = gd._hoverdata, newhoverdata = []; // pull out just the data that's useful to // other people and send it to the event for(itemnum = 0; itemnum=0 && pointData.index element - must be big enough to contain the whole // hover label var pointData = { color: hoverItem.color || Plotly.Color.defaultLine, x0: hoverItem.x0 || hoverItem.x || 0, x1: hoverItem.x1 || hoverItem.x || 0, y0: hoverItem.y0 || hoverItem.y || 0, y1: hoverItem.y1 || hoverItem.y || 0, xLabel: hoverItem.xLabel, yLabel: hoverItem.yLabel, zLabel: hoverItem.zLabel, text: hoverItem.text, name: hoverItem.name, idealAlign: hoverItem.idealAlign, // filler to make createHoverText happy trace: { index: 0, hoverinfo: '' }, xa: {_offset: 0}, ya: {_offset: 0}, index: 0 }; var container3 = d3.select(opts.container), outerContainer3 = opts.outerContainer ? d3.select(opts.outerContainer) : container3; var fullOpts = { hovermode: 'closest', rotateLabels: false, bgColor: opts.bgColor || Plotly.Color.background, container: container3, outerContainer: outerContainer3 }; var hoverLabel = createHoverText([pointData], fullOpts); alignHoverText(hoverLabel, fullOpts.rotateLabels); return hoverLabel.node(); }; fx.loneUnhover = function(containerOrSelection) { var selection = containerOrSelection instanceof d3.selection ? containerOrSelection : d3.select(containerOrSelection); selection.selectAll('g.hovertext').remove(); }; function createHoverText(hoverData, opts) { var hovermode = opts.hovermode, rotateLabels = opts.rotateLabels, bgColor = opts.bgColor, container = opts.container, outerContainer = opts.outerContainer, c0 = hoverData[0], xa = c0.xa, ya = c0.ya, commonAttr = hovermode==='y' ? 'yLabel' : 'xLabel', t0 = c0[commonAttr], t00 = (String(t0)||'').split(' ')[0], outerContainerBB = outerContainer.node().getBoundingClientRect(), outerTop = outerContainerBB.top, outerWidth = outerContainerBB.width, outerHeight = outerContainerBB.height; // show the common label, if any, on the axis // never show a common label in array mode, // even if sometimes there could be one var showCommonLabel = c0.distance<=constants.MAXDIST && (hovermode==='x' || hovermode==='y'); // all hover traces hoverinfo must contain the hovermode // to have common labels var i, traceHoverinfo; for(i = 0; i < hoverData.length; i++) { traceHoverinfo = hoverData[i].trace.hoverinfo; var parts = traceHoverinfo.split('+'); if(parts.indexOf('all') === -1 && parts.indexOf(hovermode) === -1) { showCommonLabel = false; break; } } var commonLabel = container.selectAll('g.axistext') .data(showCommonLabel ? [0] : []); commonLabel.enter().append('g') .classed('axistext', true); commonLabel.exit().remove(); commonLabel.each(function() { var label = d3.select(this), lpath = label.selectAll('path').data([0]), ltext = label.selectAll('text').data([0]); lpath.enter().append('path') .style({fill: Plotly.Color.defaultLine, 'stroke-width': '1px', stroke: Plotly.Color.background}); ltext.enter().append('text') .call(Plotly.Drawing.font, HOVERFONT, HOVERFONTSIZE, Plotly.Color.background) // prohibit tex interpretation until we can handle // tex and regular text together .attr('data-notex',1); ltext.text(t0) .call(Plotly.util.convertToTspans) .call(Plotly.Drawing.setPosition, 0, 0) .selectAll('tspan.line') .call(Plotly.Drawing.setPosition, 0, 0); label.attr('transform',''); var tbb = ltext.node().getBoundingClientRect(); if(hovermode==='x') { ltext.attr('text-anchor','middle') .call(Plotly.Drawing.setPosition,0,(xa.side==='top' ? (outerTop-tbb.bottom-HOVERARROWSIZE-HOVERTEXTPAD) : (outerTop-tbb.top+HOVERARROWSIZE+HOVERTEXTPAD))) .selectAll('tspan.line') .attr({ x: ltext.attr('x'), y: ltext.attr('y') }); var topsign = xa.side==='top' ? '-' : ''; lpath.attr('d','M0,0'+ 'L'+HOVERARROWSIZE+','+topsign+HOVERARROWSIZE+ 'H'+(HOVERTEXTPAD+tbb.width/2)+ 'v'+topsign+(HOVERTEXTPAD*2+tbb.height)+ 'H-'+(HOVERTEXTPAD+tbb.width/2)+ 'V'+topsign+HOVERARROWSIZE+'H-'+HOVERARROWSIZE+'Z'); label.attr('transform','translate(' + (xa._offset+(c0.x0+c0.x1)/2)+',' + (ya._offset + (xa.side==='top' ? 0 : ya._length))+')'); } else { ltext.attr('text-anchor',ya.side==='right' ? 'start' : 'end') .call(Plotly.Drawing.setPosition, (ya.side==='right' ? 1 : -1)*(HOVERTEXTPAD+HOVERARROWSIZE), outerTop-tbb.top-tbb.height/2) .selectAll('tspan.line') .attr({ x: ltext.attr('x'), y: ltext.attr('y') }); var leftsign = ya.side==='right' ? '' : '-'; lpath.attr('d','M0,0'+ 'L'+leftsign+HOVERARROWSIZE+','+HOVERARROWSIZE+ 'V'+(HOVERTEXTPAD+tbb.height/2)+ 'h'+leftsign+(HOVERTEXTPAD*2+tbb.width)+ 'V-'+(HOVERTEXTPAD+tbb.height/2)+ 'H'+leftsign+HOVERARROWSIZE+'V-'+HOVERARROWSIZE+'Z'); label.attr('transform','translate(' + (xa._offset+(ya.side==='right' ? xa._length : 0))+',' + (ya._offset+(c0.y0+c0.y1)/2)+')'); } // remove the "close but not quite" points // because of error bars, only take up to a space hoverData = hoverData.filter(function(d) { return (d.zLabelVal!==undefined) || (d[commonAttr]||'').split(' ')[0]===t00; }); }); // show all the individual labels // first create the objects var hoverLabels = container.selectAll('g.hovertext') .data(hoverData,function(d) { return [d.trace.index,d.index,d.x0,d.y0,d.name,d.attr||''].join(','); }); hoverLabels.enter().append('g') .classed('hovertext',true) .each(function() { var g = d3.select(this); // trace name label (rect and text.name) g.append('rect') .call(Plotly.Color.fill, Plotly.Color.addOpacity(bgColor, 0.8)); g.append('text').classed('name',true) .call(Plotly.Drawing.font,HOVERFONT,HOVERFONTSIZE); // trace data label (path and text.nums) g.append('path') .style('stroke-width','1px'); g.append('text').classed('nums',true) .call(Plotly.Drawing.font,HOVERFONT,HOVERFONTSIZE); }); hoverLabels.exit().remove(); // then put the text in, position the pointer to the data, // and figure out sizes hoverLabels.each(function(d) { var g = d3.select(this).attr('transform', ''), name = '', text = '', // combine possible non-opaque trace color with bgColor baseColor = Plotly.Color.opacity(d.color) ? d.color : Plotly.Color.defaultLine, traceColor = Plotly.Color.combine(baseColor, bgColor), // find a contrasting color for border and text contrastColor = tinycolor(traceColor).getBrightness()>128 ? '#000' : Plotly.Color.background; if(d.name && d.zLabelVal===undefined) { // strip out any html elements from d.name (if it exists at all) // Note that this isn't an XSS vector, only because it never gets // attached to the DOM var tmp = document.createElement('p'); tmp.innerHTML = d.name; name = tmp.textContent||''; if(name.length>15) name = name.substr(0,12)+'...'; } if(d.zLabel!==undefined) { if(d.xLabel!==undefined) text += 'x: ' + d.xLabel + '
'; if(d.yLabel!==undefined) text += 'y: ' + d.yLabel + '
'; text += (text ? 'z: ' : '') + d.zLabel; } else if(showCommonLabel && d[hovermode+'Label']===t0) { text = d[(hovermode==='x' ? 'y' : 'x') + 'Label'] || ''; } else if(d.xLabel===undefined) { if(d.yLabel!==undefined) text = d.yLabel; } else if(d.yLabel===undefined) text = d.xLabel; else text = '('+d.xLabel+', '+d.yLabel+')'; if(d.text && !Array.isArray(d.text)) text += (text ? '
' : '') + d.text; // if 'text' is empty at this point, // put 'name' in main label and don't show secondary label if(text === '') { // if 'name' is also empty, remove entire label if(name === '') g.remove(); text = name; } // main label var tx = g.select('text.nums') .style('fill',contrastColor) .call(Plotly.Drawing.setPosition,0,0) .text(text) .attr('data-notex',1) .call(Plotly.util.convertToTspans); tx.selectAll('tspan.line') .call(Plotly.Drawing.setPosition,0,0); var tx2 = g.select('text.name'), tx2width = 0; // secondary label for non-empty 'name' if(name && name!==text) { tx2.style('fill',traceColor) .text(name) .call(Plotly.Drawing.setPosition,0,0) .attr('data-notex',1) .call(Plotly.util.convertToTspans); tx2.selectAll('tspan.line') .call(Plotly.Drawing.setPosition,0,0); tx2width = tx2.node().getBoundingClientRect().width+2*HOVERTEXTPAD; } else { tx2.remove(); g.select('rect').remove(); } g.select('path') .style({ fill: traceColor, stroke: contrastColor }); var tbb = tx.node().getBoundingClientRect(), htx = xa._offset+(d.x0+d.x1)/2, hty = ya._offset+(d.y0+d.y1)/2, dx = Math.abs(d.x1-d.x0), dy = Math.abs(d.y1-d.y0), txTotalWidth = tbb.width+HOVERARROWSIZE+HOVERTEXTPAD+tx2width, anchorStartOK, anchorEndOK; d.ty0 = outerTop-tbb.top; d.bx = tbb.width+2*HOVERTEXTPAD; d.by = tbb.height+2*HOVERTEXTPAD; d.anchor = 'start'; d.txwidth = tbb.width; d.tx2width = tx2width; d.offset = 0; if(rotateLabels) { d.pos = htx; anchorStartOK = hty + dy / 2 + txTotalWidth <= outerHeight; anchorEndOK = hty - dy / 2 - txTotalWidth >= 0; if((d.idealAlign === 'top' || !anchorStartOK) && anchorEndOK) { hty -= dy / 2; d.anchor = 'end'; } else if(anchorStartOK) { hty += dy / 2; d.anchor = 'start'; } else d.anchor = 'middle'; } else { d.pos = hty; anchorStartOK = htx + dx / 2 + txTotalWidth <= outerWidth; anchorEndOK = htx - dx / 2 - txTotalWidth >= 0; if((d.idealAlign === 'left' || !anchorStartOK) && anchorEndOK) { htx -= dx / 2; d.anchor = 'end'; } else if(anchorStartOK) { htx += dx / 2; d.anchor = 'start'; } else d.anchor = 'middle'; } tx.attr('text-anchor',d.anchor); if(tx2width) tx2.attr('text-anchor',d.anchor); g.attr('transform','translate('+htx+','+hty+')'+ (rotateLabels ? 'rotate('+YANGLE+')' : '')); }); return hoverLabels; } // Make groups of touching points, and within each group // move each point so that no labels overlap, but the average // label position is the same as it was before moving. Indicentally, // this is equivalent to saying all the labels are on equal linear // springs about their initial position. Initially, each point is // its own group, but as we find overlaps we will clump the points. // // Also, there are hard constraints at the edges of the graphs, // that push all groups to the middle so they are visible. I don't // know what happens if the group spans all the way from one edge to // the other, though it hardly matters - there's just too much // information then. function hoverAvoidOverlaps(hoverData, ax) { var nummoves = 0, pmin = ax._offset, pmax = ax._offset+ax._length, // make groups of touching points pointgroups = hoverData .map(function(d,i) { return [{ i: i, dp: 0, pos: d.pos, posref: d.posref, size: d.by*(ax._id.charAt(0)==='x' ? YFACTOR : 1)/2 }]; }) .sort(function(a,b) { return a[0].posref-b[0].posref; }), donepositioning, topOverlap, bottomOverlap, i, j, pti, sumdp; function constrainGroup(grp) { var minPt = grp[0], maxPt = grp[grp.length-1]; // overlap with the top - positive vals are overlaps topOverlap = pmin-minPt.pos-minPt.dp+minPt.size; // overlap with the bottom - positive vals are overlaps bottomOverlap = maxPt.pos+maxPt.dp+maxPt.size-pmax; // check for min overlap first, so that we always // see the largest labels // allow for .01px overlap, so we don't get an // infinite loop from rounding errors if(topOverlap>0.01) { for(j=grp.length-1; j>=0; j--) grp[j].dp += topOverlap; donepositioning = false; } if(bottomOverlap<0.01) return; if(topOverlap<-0.01) { // make sure we're not pushing back and forth for(j=grp.length-1; j>=0; j--) grp[j].dp -= bottomOverlap; donepositioning = false; } if(!donepositioning) return; // no room to fix positioning, delete off-screen points // first see how many points we need to delete var deleteCount = 0; for(i=0; ipmax) deleteCount++; } // start by deleting points whose data is off screen for(i=grp.length-1; i>=0; i--) { if(deleteCount<=0) break; pti = grp[i]; // pos has already been constrained to [pmin,pmax] // so look for points close to that to delete if(pti.pos>pmax-1) { pti.del = true; deleteCount--; } } for(i=0; i=0; j--) grp[j].dp -= bottomOverlap; } } // then delete points that go off the bottom for(i=grp.length-1; i>=0; i--) { if(deleteCount<=0) break; pti = grp[i]; if(pti.pos+pti.dp+pti.size>pmax) { pti.del = true; deleteCount--; } } } // loop through groups, combining them if they overlap, // until nothing moves while(!donepositioning && nummoves<=hoverData.length) { // to avoid infinite loops, don't move more times // than there are traces nummoves++; // assume nothing will move in this iteration, // reverse this if it does donepositioning = true; i = 0; while(i0.01) { // push the new point(s) added to this group out of the way for(j=g1.length-1; j>=0; j--) g1[j].dp += topOverlap; // add them to the group g0.push.apply(g0,g1); pointgroups.splice(i+1,1); // adjust for minimum average movement sumdp = 0; for(j=g0.length-1; j>=0; j--) sumdp += g0[j].dp; bottomOverlap = sumdp/g0.length; for(j=g0.length-1; j>=0; j--) g0[j].dp -= bottomOverlap; donepositioning = false; } else i++; } // check if we're going off the plot on either side and fix pointgroups.forEach(constrainGroup); } // now put these offsets into hoverData for(i=pointgroups.length-1; i>=0; i--) { var grp = pointgroups[i]; for(j=grp.length-1; j>=0; j--) { var pt = grp[j], hoverPt = hoverData[pt.i]; hoverPt.offset = pt.dp; hoverPt.del = pt.del; } } } function alignHoverText(hoverLabels, rotateLabels) { // finally set the text positioning relative to the data and draw the // box around it hoverLabels.each(function(d) { var g = d3.select(this); if(d.del) { g.remove(); return; } var horzSign = d.anchor==='end' ? -1 : 1, tx = g.select('text.nums'), alignShift = {start: 1, end: -1, middle: 0}[d.anchor], txx = alignShift*(HOVERARROWSIZE+HOVERTEXTPAD), tx2x = txx+alignShift*(d.txwidth+HOVERTEXTPAD), offsetX = 0, offsetY = d.offset; if(d.anchor==='middle') { txx-=d.tx2width/2; tx2x-=d.tx2width/2; } if(rotateLabels) { offsetY *= -YSHIFTY; offsetX = d.offset*YSHIFTX; } g.select('path').attr('d',d.anchor==='middle' ? // middle aligned: rect centered on data ('M-'+(d.bx/2)+',-'+(d.by/2)+'h'+d.bx+'v'+d.by+'h-'+d.bx+'Z') : // left or right aligned: side rect with arrow to data ('M0,0L'+(horzSign*HOVERARROWSIZE+offsetX)+','+(HOVERARROWSIZE+offsetY)+ 'v'+(d.by/2-HOVERARROWSIZE)+ 'h'+(horzSign*d.bx)+ 'v-'+d.by+ 'H'+(horzSign*HOVERARROWSIZE+offsetX)+ 'V'+(offsetY-HOVERARROWSIZE)+ 'Z')); tx.call(Plotly.Drawing.setPosition, txx+offsetX, offsetY+d.ty0-d.by/2+HOVERTEXTPAD) .selectAll('tspan.line') .attr({ x: tx.attr('x'), y: tx.attr('y') }); if(d.tx2width) { g.select('text.name, text.name tspan.line') .call(Plotly.Drawing.setPosition, tx2x+alignShift*HOVERTEXTPAD+offsetX, offsetY+d.ty0-d.by/2+HOVERTEXTPAD); g.select('rect') .call(Plotly.Drawing.setRect, tx2x+(alignShift-1)*d.tx2width/2+offsetX, offsetY-d.by/2-1, d.tx2width, d.by+2); } }); } function hoverChanged(gd, evt, oldhoverdata) { // don't emit any events if nothing changed or // if fx.hover was called manually if(!evt.target) return false; if(!oldhoverdata || oldhoverdata.length!==gd._hoverdata.length) return true; for(var i = oldhoverdata.length-1; i>=0; i--) { var oldPt = oldhoverdata[i], newPt = gd._hoverdata[i]; if(oldPt.curveNumber!==newPt.curveNumber || String(oldPt.pointNumber)!==String(newPt.pointNumber)) { return true; } } return false; } // remove hover effects on mouse out, and emit unhover event function unhover(gd, evt) { var fullLayout = gd._fullLayout; if(!evt) evt = {}; if(evt.target && Events.triggerHandler(gd, 'plotly_beforehover', evt) === false) { return; } fullLayout._hoverlayer.selectAll('g').remove(); if(evt.target && gd._hoverdata) { gd.emit('plotly_unhover', {points: gd._hoverdata}); } gd._hoverdata = undefined; } // on click fx.click = function(gd,evt) { if(gd._hoverdata && evt && evt.target) { gd.emit('plotly_click', {points: gd._hoverdata}); // why do we get a double event without this??? if(evt.stopImmediatePropagation) evt.stopImmediatePropagation(); } }; // ---------------------------------------------------- // Axis dragging functions // ---------------------------------------------------- function getDragCursor(nsew, dragmode) { if(!nsew) return 'pointer'; if(nsew === 'nsew') { if(dragmode === 'pan') return 'move'; return 'crosshair'; } return nsew.toLowerCase() + '-resize'; } // flag for showing "doubleclick to zoom out" only at the beginning var SHOWZOOMOUTTIP = true; // dragBox: create an element to drag one or more axis ends // inputs: // plotinfo - which subplot are we making dragboxes on? // x,y,w,h - left, top, width, height of the box // ns - how does this drag the vertical axis? // 'n' - top only // 's' - bottom only // 'ns' - top and bottom together, difference unchanged // ew - same for horizontal axis function dragBox(gd, plotinfo, x, y, w, h, ns, ew) { // mouseDown stores ms of first mousedown event in the last // DBLCLICKDELAY ms on the drag bars // numClicks stores how many mousedowns have been seen // within DBLCLICKDELAY so we can check for click or doubleclick events // dragged stores whether a drag has occurred, so we don't have to // redraw unnecessarily, ie if no move bigger than MINDRAG or MINZOOM px var fullLayout = gd._fullLayout, // if we're dragging two axes at once, also drag overlays subplots = [plotinfo].concat((ns && ew) ? plotinfo.overlays : []), xa = [plotinfo.x()], ya = [plotinfo.y()], pw = xa[0]._length, ph = ya[0]._length, MINDRAG = constants.MINDRAG, MINZOOM = constants.MINZOOM, i, subplotXa, subplotYa; for(i = 1; i < subplots.length; i++) { subplotXa = subplots[i].x(); subplotYa = subplots[i].y(); if(xa.indexOf(subplotXa) === -1) xa.push(subplotXa); if(ya.indexOf(subplotYa) === -1) ya.push(subplotYa); } function isDirectionActive(axList, activeVal) { for(i = 0; i < axList.length; i++) { if(!axList[i].fixedrange) return activeVal; } return ''; } var allaxes = xa.concat(ya), xActive = isDirectionActive(xa, ew), yActive = isDirectionActive(ya, ns), cursor = getDragCursor(yActive + xActive, fullLayout.dragmode), dragClass = ns + ew + 'drag'; var dragger3 = plotinfo.draglayer.selectAll('.' + dragClass).data([0]); dragger3.enter().append('rect') .classed('drag', true) .classed(dragClass, true) .style({fill: 'transparent', 'stroke-width': 0}) .attr('data-subplot', plotinfo.id); dragger3.call(Plotly.Drawing.setRect, x, y, w, h) .call(fx.setCursor,cursor); var dragger = dragger3.node(); // still need to make the element if the axes are disabled // but nuke its events (except for maindrag which needs them for hover) // and stop there if(!yActive && !xActive) { dragger.onmousedown = null; dragger.style.pointerEvents = (ns + ew === 'nsew') ? 'all' : 'none'; return dragger; } function forceNumbers(axRange) { axRange[0] = Number(axRange[0]); axRange[1] = Number(axRange[1]); } var dragOptions = { element: dragger, gd: gd, plotinfo: plotinfo, xaxes: xa, yaxes: ya, doubleclick: doubleClick, prepFn: function(e, startX, startY) { var dragModeNow = gd._fullLayout.dragmode; if(ns + ew === 'nsew') { // main dragger handles all drag modes, and changes // to pan (or to zoom if it already is pan) on shift if(e.shiftKey) { if(dragModeNow === 'pan') dragModeNow = 'zoom'; else dragModeNow = 'pan'; } } // all other draggers just pan else dragModeNow = 'pan'; if(dragModeNow === 'lasso') dragOptions.minDrag = 1; else dragOptions.minDrag = undefined; if(dragModeNow === 'zoom') { dragOptions.moveFn = zoomMove; dragOptions.doneFn = zoomDone; zoomPrep(e, startX, startY); } else if(dragModeNow === 'pan') { dragOptions.moveFn = plotDrag; dragOptions.doneFn = dragDone; clearSelect(); } else if(dragModeNow === 'select' || dragModeNow === 'lasso') { prepSelect(e, startX, startY, dragOptions, dragModeNow); } } }; fx.dragElement(dragOptions); var x0, y0, box, lum, path0, dimmed, zoomMode, zb, corners; function zoomPrep(e, startX, startY) { var dragBBox = dragger.getBoundingClientRect(); x0 = startX - dragBBox.left; y0 = startY - dragBBox.top; box = {l: x0, r: x0, w: 0, t: y0, b: y0, h: 0}; lum = gd._hmpixcount ? (gd._hmlumcount / gd._hmpixcount) : tinycolor(gd._fullLayout.plot_bgcolor).getLuminance(); path0 = path0 = 'M0,0H'+pw+'V'+ph+'H0V0'; dimmed = false; zoomMode = 'xy'; zb = plotinfo.plot.append('path') .attr('class', 'zoombox') .style({ 'fill': lum>0.2 ? 'rgba(0,0,0,0)' : 'rgba(255,255,255,0)', 'stroke-width': 0 }) .attr('d', path0 + 'Z'); corners = plotinfo.plot.append('path') .attr('class', 'zoombox-corners') .style({ fill: Plotly.Color.background, stroke: Plotly.Color.defaultLine, 'stroke-width': 1, opacity: 0 }) .attr('d','M0,0Z'); clearSelect(); for(i = 0; i < allaxes.length; i++) forceNumbers(allaxes[i].range); } function clearSelect() { // until we get around to persistent selections, remove the outline // here. The selection itself will be removed when the plot redraws // at the end. plotinfo.plot.selectAll('.select-outline').remove(); } function zoomMove(dx0, dy0) { var x1 = Math.max(0, Math.min(pw, dx0 + x0)), y1 = Math.max(0, Math.min(ph, dy0 + y0)), dx = Math.abs(x1 - x0), dy = Math.abs(y1 - y0), clen = Math.floor(Math.min(dy, dx, MINZOOM) / 2); box.l = Math.min(x0, x1); box.r = Math.max(x0, x1); box.t = Math.min(y0, y1); box.b = Math.max(y0, y1); // look for small drags in one direction or the other, // and only drag the other axis if(!yActive || dy < Math.min(Math.max(dx * 0.6, MINDRAG), MINZOOM)) { if(dx < MINDRAG) { zoomMode = ''; box.r = box.l; box.t = box.b; corners.attr('d', 'M0,0Z'); } else { box.t = 0; box.b = ph; zoomMode = 'x'; corners.attr('d', 'M' + (box.l - 0.5) + ',' + (y0 - MINZOOM - 0.5) + 'h-3v' + (2 * MINZOOM + 1) + 'h3ZM' + (box.r + 0.5) + ',' + (y0 - MINZOOM - 0.5) + 'h3v' + (2 * MINZOOM + 1) + 'h-3Z'); } } else if(!xActive || dx < Math.min(dy * 0.6, MINZOOM)) { box.l = 0; box.r = pw; zoomMode = 'y'; corners.attr('d', 'M' + (x0 - MINZOOM - 0.5) + ',' + (box.t - 0.5) + 'v-3h' + (2 * MINZOOM + 1) + 'v3ZM' + (x0 - MINZOOM - 0.5) + ',' + (box.b + 0.5) + 'v3h' + (2 * MINZOOM + 1) + 'v-3Z'); } else { zoomMode = 'xy'; corners.attr('d', 'M'+(box.l-3.5)+','+(box.t-0.5+clen)+'h3v'+(-clen)+ 'h'+clen+'v-3h-'+(clen+3)+'ZM'+ (box.r+3.5)+','+(box.t-0.5+clen)+'h-3v'+(-clen)+ 'h'+(-clen)+'v-3h'+(clen+3)+'ZM'+ (box.r+3.5)+','+(box.b+0.5-clen)+'h-3v'+clen+ 'h'+(-clen)+'v3h'+(clen+3)+'ZM'+ (box.l-3.5)+','+(box.b+0.5-clen)+'h3v'+clen+ 'h'+clen+'v3h-'+(clen+3)+'Z'); } box.w = box.r - box.l; box.h = box.b - box.t; // Not sure about the addition of window.scrollX/Y... // seems to work but doesn't seem robust. zb.attr('d', path0+'M'+(box.l)+','+(box.t)+'v'+(box.h)+ 'h'+(box.w)+'v-'+(box.h)+'h-'+(box.w)+'Z'); if(!dimmed) { zb.transition() .style('fill', lum>0.2 ? 'rgba(0,0,0,0.4)' : 'rgba(255,255,255,0.3)') .duration(200); corners.transition() .style('opacity',1) .duration(200); dimmed = true; } } function zoomAxRanges(axList, r0Fraction, r1Fraction) { var i, axi, axRange; for(i = 0; i < axList.length; i++) { axi = axList[i]; if(axi.fixedrange) continue; axRange = axi.range; axi.range = [ axRange[0] + (axRange[1] - axRange[0]) * r0Fraction, axRange[0] + (axRange[1] - axRange[0]) * r1Fraction ]; } } function zoomDone(dragged, numClicks) { if(Math.min(box.h, box.w) < MINDRAG * 2) { if(numClicks === 2) doubleClick(); else pauseForDrag(gd); return removeZoombox(gd); } if(zoomMode === 'xy' || zoomMode === 'x') zoomAxRanges(xa, box.l / pw, box.r / pw); if(zoomMode === 'xy' || zoomMode === 'y') zoomAxRanges(ya, (ph - box.b) / ph, (ph - box.t) / ph); removeZoombox(gd); dragTail(zoomMode); if(SHOWZOOMOUTTIP && gd.data && gd._context.showTips) { Plotly.Lib.notifier('Double-click to
zoom back out','long'); SHOWZOOMOUTTIP = false; } } function dragDone(dragged, numClicks) { var singleEnd = (ns + ew).length === 1; if(dragged) dragTail(); else if(numClicks === 2 && !singleEnd) doubleClick(); else if(numClicks === 1 && singleEnd) { var ax = ns ? ya[0] : xa[0], end = (ns==='s' || ew==='w') ? 0 : 1, attrStr = ax._name + '.range[' + end + ']', initialText = getEndText(ax, end), hAlign = 'left', vAlign = 'middle'; if(ax.fixedrange) return; if(ns) { vAlign = (ns === 'n') ? 'top' : 'bottom'; if(ax.side === 'right') hAlign = 'right'; } else if(ew === 'e') hAlign = 'right'; dragger3 .call(Plotly.util.makeEditable, null, { immediate: true, background: fullLayout.paper_bgcolor, text: String(initialText), fill: ax.tickfont ? ax.tickfont.color : '#444', horizontalAlign: hAlign, verticalAlign: vAlign }) .on('edit', function(text) { var v = ax.type==='category' ? ax.c2l(text) : ax.d2l(text); if(v !== undefined) { Plotly.relayout(gd, attrStr, v); } }); } else pauseForDrag(gd); } // scroll zoom, on all draggers except corners var scrollViewBox = [0,0,pw,ph], // wait a little after scrolling before redrawing redrawTimer = null, REDRAWDELAY = 300, mainplot = plotinfo.mainplot ? fullLayout._plots[plotinfo.mainplot] : plotinfo; function zoomWheel(e) { // deactivate mousewheel scrolling on embedded graphs // devs can override this with layout._enablescrollzoom, // but _ ensures this setting won't leave their page if(!gd._context.scrollZoom && !fullLayout._enablescrollzoom) { return; } var pc = gd.querySelector('.plotly'); // if the plot has scrollbars (more than a tiny excess) // disable scrollzoom too. if(pc.scrollHeight-pc.clientHeight>10 || pc.scrollWidth-pc.clientWidth>10) { return; } clearTimeout(redrawTimer); var wheelDelta = -e.deltaY; if(!isFinite(wheelDelta)) wheelDelta = e.wheelDelta / 10; if(!isFinite(wheelDelta)) { console.log('did not find wheel motion attributes', e); return; } var zoom = Math.exp(-Math.min(Math.max(wheelDelta, -20), 20) / 100), gbb = mainplot.draglayer.select('.nsewdrag') .node().getBoundingClientRect(), xfrac = (e.clientX - gbb.left) / gbb.width, vbx0 = scrollViewBox[0] + scrollViewBox[2]*xfrac, yfrac = (gbb.bottom - e.clientY)/gbb.height, vby0 = scrollViewBox[1]+scrollViewBox[3]*(1-yfrac), i; function zoomWheelOneAxis(ax, centerFraction, zoom) { if(ax.fixedrange) return; forceNumbers(ax.range); var axRange = ax.range, v0 = axRange[0] + (axRange[1] - axRange[0]) * centerFraction; ax.range = [v0 + (axRange[0] - v0) * zoom, v0 + (axRange[1] - v0) * zoom]; } if(ew) { for(i = 0; i < xa.length; i++) zoomWheelOneAxis(xa[i], xfrac, zoom); scrollViewBox[2] *= zoom; scrollViewBox[0] = vbx0 - scrollViewBox[2] * xfrac; } if(ns) { for(i = 0; i < ya.length; i++) zoomWheelOneAxis(ya[i], yfrac, zoom); scrollViewBox[3] *= zoom; scrollViewBox[1] = vby0 - scrollViewBox[3] * (1 - yfrac); } // viewbox redraw at first updateViewBoxes(scrollViewBox); ticksAndAnnotations(ns,ew); // then replot after a delay to make sure // no more scrolling is coming redrawTimer = setTimeout(function() { scrollViewBox = [0,0,pw,ph]; dragTail(); }, REDRAWDELAY); return Plotly.Lib.pauseEvent(e); } // everything but the corners gets wheel zoom if(ns.length*ew.length!==1) { // still seems to be some confusion about onwheel vs onmousewheel... if(dragger.onwheel!==undefined) dragger.onwheel = zoomWheel; else if(dragger.onmousewheel!==undefined) dragger.onmousewheel = zoomWheel; } // plotDrag: move the plot in response to a drag function plotDrag(dx,dy) { function dragAxList(axList, pix) { for(var i = 0; i < axList.length; i++) { var axi = axList[i]; if(!axi.fixedrange) { axi.range = [axi._r[0] - pix / axi._m, axi._r[1] - pix / axi._m]; } } } if(xActive === 'ew' || yActive === 'ns') { if(xActive) dragAxList(xa, dx); if(yActive) dragAxList(ya, dy); updateViewBoxes([xActive ? -dx : 0, yActive ? -dy : 0, pw, ph]); ticksAndAnnotations(yActive, xActive); return; } // common transform for dragging one end of an axis // d>0 is compressing scale (cursor is over the plot, // the axis end should move with the cursor) // d<0 is expanding (cursor is off the plot, axis end moves // nonlinearly so you can expand far) function dZoom(d) { return 1-((d>=0) ? Math.min(d,0.9) : 1/(1/Math.max(d,-0.3)+3.222)); } // dz: set a new value for one end (0 or 1) of an axis array ax, // and return a pixel shift for that end for the viewbox // based on pixel drag distance d // TODO: this makes (generally non-fatal) errors when you get // near floating point limits function dz(ax, end, d) { var otherEnd = 1 - end, movedi = 0; for(var i = 0; i < ax.length; i++) { var axi = ax[i]; if(axi.fixedrange) continue; movedi = i; axi.range[end] = axi._r[otherEnd] + (axi._r[end] - axi._r[otherEnd]) / dZoom(d / axi._length); } return ax[movedi]._length * (ax[movedi]._r[end] - ax[movedi].range[end]) / (ax[movedi]._r[end] - ax[movedi]._r[otherEnd]); } if(xActive === 'w') dx = dz(xa, 0, dx); else if(xActive === 'e') dx = dz(xa, 1, -dx); else if(!xActive) dx = 0; if(yActive === 'n') dy = dz(ya, 1, dy); else if(yActive === 's') dy = dz(ya, 0, -dy); else if(!yActive) dy = 0; updateViewBoxes([ (xActive === 'w') ? dx : 0, (yActive === 'n') ? dy : 0, pw - dx, ph - dy ]); ticksAndAnnotations(yActive, xActive); } function ticksAndAnnotations(ns, ew) { var activeAxIds = [], i; function pushActiveAxIds(axList) { for(i = 0; i < axList.length; i++) { if(!axList[i].fixedrange) activeAxIds.push(axList[i]._id); } } if(ew) pushActiveAxIds(xa); if(ns) pushActiveAxIds(ya); for(i = 0; i < activeAxIds.length; i++) { Plotly.Axes.doTicks(gd, activeAxIds[i], true); } function redrawObjs(objArray, module) { var obji; for(i = 0; i < objArray.length; i++) { obji = objArray[i]; if((ew && activeAxIds.indexOf(obji.xref) !== -1) || (ns && activeAxIds.indexOf(obji.yref) !== -1)) { module.draw(gd, i); } } } redrawObjs(fullLayout.annotations || [], Plotly.Annotations); redrawObjs(fullLayout.shapes || [], Plotly.Shapes); } function doubleClick() { var doubleClickConfig = gd._context.doubleClick, axList = (xActive ? xa : []).concat(yActive ? ya : []), attrs = {}; var ax, i; if(doubleClickConfig === 'autosize') { for(i = 0; i < axList.length; i++) { ax = axList[i]; if(!ax.fixedrange) attrs[ax._name + '.autorange'] = true; } } else if(doubleClickConfig === 'reset') { for(i = 0; i < axList.length; i++) { ax = axList[i]; if(!ax._rangeInitial) { attrs[ax._name + '.autorange'] = true; } else { attrs[ax._name + '.range'] = ax._rangeInitial.slice(); } } } else if(doubleClickConfig === 'reset+autosize') { for(i = 0; i < axList.length; i++) { ax = axList[i]; if(ax.fixedrange) continue; if(ax._rangeInitial === undefined || ax.range[0] === ax._rangeInitial[0] && ax.range[1] === ax._rangeInitial[1] ) { attrs[ax._name + '.autorange'] = true; } else attrs[ax._name + '.range'] = ax._rangeInitial.slice(); } } gd.emit('plotly_doubleclick', null); Plotly.relayout(gd, attrs); } // dragTail - finish a drag event with a redraw function dragTail(zoommode) { var attrs = {}; // revert to the previous axis settings, then apply the new ones // through relayout - this lets relayout manage undo/redo for(var i = 0; i < allaxes.length; i++) { var axi = allaxes[i]; if(zoommode && zoommode.indexOf(axi._id.charAt(0))===-1) { continue; } if(axi._r[0] !== axi.range[0]) attrs[axi._name+'.range[0]'] = axi.range[0]; if(axi._r[1] !== axi.range[1]) attrs[axi._name+'.range[1]'] = axi.range[1]; axi.range=axi._r.slice(); } updateViewBoxes([0,0,pw,ph]); Plotly.relayout(gd,attrs); } // updateViewBoxes - find all plot viewboxes that should be // affected by this drag, and update them. look for all plots // sharing an affected axis (including the one being dragged) function updateViewBoxes(viewBox) { var plotinfos = fullLayout._plots, subplots = Object.keys(plotinfos), i, plotinfo2, xa2, ya2, editX, editY; for(i = 0; i < subplots.length; i++) { plotinfo2 = plotinfos[subplots[i]]; xa2 = plotinfo2.x(); ya2 = plotinfo2.y(); editX = ew && xa.indexOf(xa2)!==-1 && !xa2.fixedrange; editY = ns && ya.indexOf(ya2)!==-1 && !ya2.fixedrange; if(editX || editY) { var newVB = [0,0,xa2._length,ya2._length]; if(editX) { newVB[0] = viewBox[0]; newVB[2] = viewBox[2]; } if(editY) { newVB[1] = viewBox[1]; newVB[3] = viewBox[3]; } plotinfo2.plot.attr('viewBox',newVB.join(' ')); } } } return dragger; } function getEndText(ax, end) { var initialVal = ax.range[end], diff = Math.abs(initialVal - ax.range[1 - end]), dig; if(ax.type === 'date') { return Plotly.Lib.ms2DateTime(initialVal, diff); } else if(ax.type==='log') { dig = Math.ceil(Math.max(0, -Math.log(diff) / Math.LN10)) + 3; return d3.format('.' + dig + 'g')(Math.pow(10, initialVal)); } else { // linear numeric (or category... but just show numbers here) dig = Math.floor(Math.log(Math.abs(initialVal)) / Math.LN10) - Math.floor(Math.log(diff) / Math.LN10) + 4; return d3.format('.'+String(dig)+'g')(initialVal); } } function pauseForDrag(gd) { // prevent more redraws until we know if a doubleclick // has occurred gd._dragging = true; var deferredReplot = gd._replotPending; gd._replotPending = false; setTimeout(function() { gd._replotPending = deferredReplot; finishDrag(gd); }, constants.DBLCLICKDELAY ); } function finishDrag(gd) { gd._dragging = false; if(gd._replotPending) Plotly.plot(gd); } function removeZoombox(gd) { d3.select(gd) .selectAll('.zoombox,.js-zoombox-backdrop,.js-zoombox-menu,.zoombox-corners') .remove(); } // for automatic alignment on dragging, <1/3 means left align, // >2/3 means right, and between is center. Pick the right fraction // based on where you are, and return the fraction corresponding to // that position on the object fx.dragAlign = function(v, dv, v0, v1, anchor) { var vmin = (v-v0)/(v1-v0), vmax = vmin+dv/(v1-v0), vc = (vmin+vmax)/2; // explicitly specified anchor if(anchor==='left' || anchor==='bottom') return vmin; if(anchor==='center' || anchor==='middle') return vc; if(anchor==='right' || anchor==='top') return vmax; // automatic based on position if(vmin<(2/3)-vc) return vmin; if(vmax>(4/3)-vc) return vmax; return vc; }; // set cursors pointing toward the closest corner/side, // to indicate alignment // x and y are 0-1, fractions of the plot area var cursorset = [['sw-resize','s-resize','se-resize'], ['w-resize','move','e-resize'], ['nw-resize','n-resize','ne-resize']]; fx.dragCursors = function(x,y,xanchor,yanchor) { if(xanchor==='left') x=0; else if(xanchor==='center') x=1; else if(xanchor==='right') x=2; else x = Plotly.Lib.constrain(Math.floor(x*3),0,2); if(yanchor==='bottom') y=0; else if(yanchor==='middle') y=1; else if(yanchor==='top') y=2; else y = Plotly.Lib.constrain(Math.floor(y*3),0,2); return cursorset[y][x]; }; /** * Abstracts click & drag interactions * @param {object} options with keys: * element (required) the DOM element to drag * prepFn (optional) function(event, startX, startY) * executed on mousedown * startX and startY are the clientX and clientY pixel position * of the mousedown event * moveFn (optional) function(dx, dy, dragged) * executed on move * dx and dy are the net pixel offset of the drag, * dragged is true/false, has the mouse moved enough to * constitute a drag * doneFn (optional) function(dragged, numClicks) * executed on mouseup, or mouseout of window since * we don't get events after that * dragged is as in moveFn * numClicks is how many clicks we've registered within * a doubleclick time */ fx.dragElement = function(options) { var gd = Plotly.Lib.getPlotDiv(options.element) || {}, numClicks = 1, DBLCLICKDELAY = constants.DBLCLICKDELAY, startX, startY, newMouseDownTime, dragCover, initialTarget; if(!gd._mouseDownTime) gd._mouseDownTime = 0; function onStart(e) { // because we cancel event bubbling, // explicitly trigger input blur event. var inputBox = document.querySelector('.plugin-editable'); if(inputBox) d3.select(inputBox).on('blur').call(inputBox); // make dragging and dragged into properties of gd // so that others can look at and modify them gd._dragged = false; gd._dragging = true; startX = e.clientX; startY = e.clientY; initialTarget = e.target; newMouseDownTime = (new Date()).getTime(); if(newMouseDownTime - gd._mouseDownTime < DBLCLICKDELAY) { // in a click train numClicks += 1; } else { // new click train numClicks = 1; gd._mouseDownTime = newMouseDownTime; } if(options.prepFn) options.prepFn(e, startX, startY); dragCover = coverSlip(); dragCover.onmousemove = onMove; dragCover.onmouseup = onDone; dragCover.onmouseout = onDone; dragCover.style.cursor = window.getComputedStyle(options.element).cursor; return Plotly.Lib.pauseEvent(e); } function onMove(e) { var dx = e.clientX - startX, dy = e.clientY - startY, minDrag = options.minDrag || constants.MINDRAG; if(Math.abs(dx) < minDrag) dx = 0; if(Math.abs(dy) < minDrag) dy = 0; if(dx||dy) { gd._dragged = true; fx.unhover(gd); } if(options.moveFn) options.moveFn(dx, dy, gd._dragged); return Plotly.Lib.pauseEvent(e); } function onDone(e) { dragCover.onmousemove = null; dragCover.onmouseup = null; dragCover.onmouseout = null; Plotly.Lib.removeElement(dragCover); if(!gd._dragging) { gd._dragged = false; return; } gd._dragging = false; // don't count as a dblClick unless the mouseUp is also within // the dblclick delay if((new Date()).getTime() - gd._mouseDownTime > DBLCLICKDELAY) { numClicks = Math.max(numClicks - 1, 1); } if(options.doneFn) options.doneFn(gd._dragged, numClicks); if(!gd._dragged) { var e2 = document.createEvent('MouseEvents'); e2.initEvent('click', true, true); initialTarget.dispatchEvent(e2); } finishDrag(gd); gd._dragged = false; return Plotly.Lib.pauseEvent(e); } options.element.onmousedown = onStart; options.element.style.pointerEvents = 'all'; }; function coverSlip() { var cover = document.createElement('div'); cover.className = 'dragcover'; var cStyle = cover.style; cStyle.position = 'fixed'; cStyle.left = 0; cStyle.right = 0; cStyle.top = 0; cStyle.bottom = 0; cStyle.zIndex = 999999999; cStyle.background = 'none'; document.body.appendChild(cover); return cover; } fx.setCursor = function(el3,csr) { (el3.attr('class')||'').split(' ').forEach(function(cls) { if(cls.indexOf('cursor-')===0) { el3.classed(cls,false); } }); if(csr) { el3.classed('cursor-'+csr, true); } }; // for bar charts and others with finite-size objects: you must be inside // it to see its hover info, so distance is infinite outside. // But make distance inside be at least 1/4 MAXDIST, and a little bigger // for bigger bars, to prioritize scatter and smaller bars over big bars // note that for closest mode, two inbox's will get added in quadrature // args are (signed) difference from the two opposite edges // count one edge as in, so that over continuous ranges you never get a gap fx.inbox = function(v0,v1) { if(v0*v1<0 || v0===0) { return constants.MAXDIST*(0.6-0.3/Math.max(3,Math.abs(v0-v1))); } return Infinity; }; },{"../../lib":349,"../../lib/events":344,"../../plotly":366,"./constants":373,"./select":379,"d3":70,"fast-isnumeric":74,"tinycolor2":229}],375:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var Plots = require('../plots'); var ErrorBars = require('../../components/errorbars'); exports.name = 'cartesian'; exports.attr = ['xaxis', 'yaxis']; exports.idRoot = ['x', 'y']; exports.attributes = require('./attributes'); exports.idRegex = { x: /^x([2-9]|[1-9][0-9]+)?$/, y: /^y([2-9]|[1-9][0-9]+)?$/ }; exports.attrRegex = { x: /^xaxis([2-9]|[1-9][0-9]+)?$/, y: /^yaxis([2-9]|[1-9][0-9]+)?$/ }; exports.plot = function(gd) { var fullLayout = gd._fullLayout, subplots = Plots.getSubplotIds(fullLayout, 'cartesian'), calcdata = gd.calcdata, modules = gd._modules; function getCdSubplot(calcdata, subplot) { var cdSubplot = []; for(var i = 0; i < calcdata.length; i++) { var cd = calcdata[i]; var trace = cd[0].trace; if(trace.xaxis + trace.yaxis === subplot) { cdSubplot.push(cd); } } return cdSubplot; } function getCdModule(cdSubplot, _module) { var cdModule = []; for(var i = 0; i < cdSubplot.length; i++) { var cd = cdSubplot[i]; var trace = cd[0].trace; if((trace._module === _module) && (trace.visible === true)) { cdModule.push(cd); } } return cdModule; } for(var i = 0; i < subplots.length; i++) { var subplot = subplots[i], subplotInfo = fullLayout._plots[subplot], cdSubplot = getCdSubplot(calcdata, subplot), cdError = []; // remove old traces, then redraw everything // TODO: use enter/exit appropriately in the plot functions // so we don't need this - should sometimes be a big speedup if(subplotInfo.plot) subplotInfo.plot.selectAll('g.trace').remove(); for(var j = 0; j < modules.length; j++) { var _module = modules[j]; // skip over non-cartesian trace modules if(_module.basePlotModule.name !== 'cartesian') continue; // skip over pies, there are drawn below if(_module.name === 'pie') continue; // plot all traces of this type on this subplot at once var cdModule = getCdModule(cdSubplot, _module); _module.plot(gd, subplotInfo, cdModule); Lib.markTime('done ' + (cdModule[0] && cdModule[0][0].trace.type)); // collect the traces that may have error bars if(cdModule[0] && cdModule[0][0].trace && Plots.traceIs(cdModule[0][0].trace, 'errorBarsOK')) { cdError = cdError.concat(cdModule); } } // finally do all error bars at once ErrorBars.plot(gd, subplotInfo, cdError); Lib.markTime('done ErrorBars'); } // now draw stuff not on subplots (ie, only pies at the moment) if(fullLayout._hasPie) { var Pie = Plots.getModule('pie'); var cdPie = getCdModule(calcdata, Pie); if(cdPie.length) Pie.plot(gd, cdPie); } }; exports.clean = function(newFullData, newFullLayout, oldFullData, oldFullLayout) { if(oldFullLayout._hasPie && !newFullLayout._hasPie) { oldFullLayout._pielayer.selectAll('g.trace').remove(); } }; },{"../../components/errorbars":323,"../../lib":349,"../plots":413,"./attributes":368}],376:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Cartesian = require('./index'); var fontAttrs = require('../font_attributes'); var colorAttrs = require('../../components/color/attributes'); var extendFlat = require('../../lib/extend').extendFlat; module.exports = { title: { valType: 'string', }, titlefont: extendFlat({}, fontAttrs, { }), type: { valType: 'enumerated', // '-' means we haven't yet run autotype or couldn't find any data // it gets turned into linear in td._fullLayout but not copied back // to td.data like the others are. values: ['-', 'linear', 'log', 'date', 'category'], dflt: '-', }, autorange: { valType: 'enumerated', values: [true, false, 'reversed'], dflt: true, }, rangemode: { valType: 'enumerated', values: ['normal', 'tozero', 'nonnegative'], dflt: 'normal', }, range: { valType: 'info_array', items: [ {valType: 'number'}, {valType: 'number'} ], }, fixedrange: { valType: 'boolean', dflt: false, }, // ticks tickmode: { valType: 'enumerated', values: ['auto', 'linear', 'array'], }, nticks: { valType: 'integer', min: 0, dflt: 0, }, tick0: { valType: 'number', dflt: 0, }, dtick: { valType: 'any', dflt: 1, }, tickvals: { valType: 'data_array', }, ticktext: { valType: 'data_array', }, ticks: { valType: 'enumerated', values: ['outside', 'inside', ''], }, mirror: { valType: 'enumerated', values: [true, 'ticks', false, 'all', 'allticks'], dflt: false, }, ticklen: { valType: 'number', min: 0, dflt: 5, }, tickwidth: { valType: 'number', min: 0, dflt: 1, }, tickcolor: { valType: 'color', dflt: colorAttrs.defaultLine, }, showticklabels: { valType: 'boolean', dflt: true, }, tickfont: extendFlat({}, fontAttrs, { }), tickangle: { valType: 'angle', dflt: 'auto', }, tickprefix: { valType: 'string', dflt: '', }, showtickprefix: { valType: 'enumerated', values: ['all', 'first', 'last', 'none'], dflt: 'all', }, ticksuffix: { valType: 'string', dflt: '', }, showticksuffix: { valType: 'enumerated', values: ['all', 'first', 'last', 'none'], dflt: 'all', }, showexponent: { valType: 'enumerated', values: ['all', 'first', 'last', 'none'], dflt: 'all', }, exponentformat: { valType: 'enumerated', values: ['none', 'e', 'E', 'power', 'SI', 'B'], dflt: 'B', }, tickformat: { valType: 'string', dflt: '', }, hoverformat: { valType: 'string', dflt: '', }, // lines and grids showline: { valType: 'boolean', dflt: false, }, linecolor: { valType: 'color', dflt: colorAttrs.defaultLine, }, linewidth: { valType: 'number', min: 0, dflt: 1, }, showgrid: { valType: 'boolean', }, gridcolor: { valType: 'color', dflt: colorAttrs.lightLine, }, gridwidth: { valType: 'number', min: 0, dflt: 1, }, zeroline: { valType: 'boolean', }, zerolinecolor: { valType: 'color', dflt: colorAttrs.defaultLine, }, zerolinewidth: { valType: 'number', dflt: 1, }, // positioning attributes // anchor: not used directly, just put here for reference // values are any opposite-letter axis id anchor: { valType: 'enumerated', values: [ 'free', Cartesian.idRegex.x.toString(), Cartesian.idRegex.y.toString() ], }, // side: not used directly, as values depend on direction // values are top, bottom for x axes, and left, right for y side: { valType: 'enumerated', values: ['top', 'bottom', 'left', 'right'], }, // overlaying: not used directly, just put here for reference // values are false and any other same-letter axis id that's not // itself overlaying anything overlaying: { valType: 'enumerated', values: [ 'free', Cartesian.idRegex.x.toString(), Cartesian.idRegex.y.toString() ], }, domain: { valType: 'info_array', items: [ {valType: 'number', min: 0, max: 1}, {valType: 'number', min: 0, max: 1} ], dflt: [0, 1], }, position: { valType: 'number', min: 0, max: 1, dflt: 0, }, _deprecated: { autotick: { valType: 'boolean', } } }; },{"../../components/color/attributes":298,"../../lib/extend":345,"../font_attributes":383,"./index":375}],377:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var Plots = require('../plots'); var constants = require('./constants'); var layoutAttributes = require('./layout_attributes'); var handleAxisDefaults = require('./axis_defaults'); var handlePositionDefaults = require('./position_defaults'); var axisIds = require('./axis_ids'); module.exports = function supplyLayoutDefaults(layoutIn, layoutOut, fullData) { var layoutKeys = Object.keys(layoutIn), xaListCartesian = [], yaListCartesian = [], xaListGl2d = [], yaListGl2d = [], outerTicks = {}, noGrids = {}, i; // look for axes in the data for(i = 0; i < fullData.length; i++) { var trace = fullData[i]; var listX, listY; if(Plots.traceIs(trace, 'cartesian')) { listX = xaListCartesian; listY = yaListCartesian; } else if(Plots.traceIs(trace, 'gl2d')) { listX = xaListGl2d; listY = yaListGl2d; } else continue; var xaName = axisIds.id2name(trace.xaxis), yaName = axisIds.id2name(trace.yaxis); // add axes implied by traces if(xaName && listX.indexOf(xaName) === -1) listX.push(xaName); if(yaName && listY.indexOf(yaName) === -1) listY.push(yaName); // check for default formatting tweaks if(Plots.traceIs(trace, '2dMap')) { outerTicks[xaName] = true; outerTicks[yaName] = true; } if(Plots.traceIs(trace, 'oriented')) { var positionAxis = trace.orientation === 'h' ? yaName : xaName; noGrids[positionAxis] = true; } } // N.B. Ignore orphan axes (i.e. axes that have no data attached to them) // if gl3d or geo is present on graph. This is retain backward compatible. // // TODO drop this in version 2.0 var ignoreOrphan = (layoutOut._hasGL3D || layoutOut._hasGeo); if(!ignoreOrphan) { for(i = 0; i < layoutKeys.length; i++) { var key = layoutKeys[i]; // orphan layout axes are considered cartesian subplots if(xaListGl2d.indexOf(key) === -1 && xaListCartesian.indexOf(key) === -1 && constants.xAxisMatch.test(key)) { xaListCartesian.push(key); } else if(yaListGl2d.indexOf(key) === -1 && yaListCartesian.indexOf(key) === -1 && constants.yAxisMatch.test(key)) { yaListCartesian.push(key); } } } // make sure that plots with orphan cartesian axes // are considered 'cartesian' if(xaListCartesian.length && yaListCartesian.length) { layoutOut._hasCartesian = true; } function axSort(a, b) { var aNum = Number(a.substr(5) || 1), bNum = Number(b.substr(5) || 1); return aNum - bNum; } var xaList = xaListCartesian.concat(xaListGl2d).sort(axSort), yaList = yaListCartesian.concat(yaListGl2d).sort(axSort); xaList.concat(yaList).forEach(function(axName) { var axLetter = axName.charAt(0), axLayoutIn = layoutIn[axName] || {}, axLayoutOut = {}, defaultOptions = { letter: axLetter, font: layoutOut.font, outerTicks: outerTicks[axName], showGrid: !noGrids[axName], name: axName, data: fullData }, positioningOptions = { letter: axLetter, counterAxes: {x: yaList, y: xaList}[axLetter].map(axisIds.name2id), overlayableAxes: {x: xaList, y: yaList}[axLetter].filter(function(axName2) { return axName2!==axName && !(layoutIn[axName2]||{}).overlaying; }).map(axisIds.name2id) }; function coerce(attr, dflt) { return Lib.coerce(axLayoutIn, axLayoutOut, layoutAttributes, attr, dflt); } handleAxisDefaults(axLayoutIn, axLayoutOut, coerce, defaultOptions); handlePositionDefaults(axLayoutIn, axLayoutOut, coerce, positioningOptions); layoutOut[axName] = axLayoutOut; // so we don't have to repeat autotype unnecessarily, // copy an autotype back to layoutIn if(!layoutIn[axName] && axLayoutIn.type !== '-') { layoutIn[axName] = {type: axLayoutIn.type}; } }); // plot_bgcolor only makes sense if there's a (2D) plot! // TODO: bgcolor for each subplot, to inherit from the main one if(xaList.length && yaList.length) { Lib.coerce(layoutIn, layoutOut, Plots.layoutAttributes, 'plot_bgcolor'); } }; },{"../../lib":349,"../plots":413,"./axis_defaults":370,"./axis_ids":371,"./constants":373,"./layout_attributes":376,"./position_defaults":378}],378:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); module.exports = function handlePositionDefaults(containerIn, containerOut, coerce, options) { var counterAxes = options.counterAxes || [], overlayableAxes = options.overlayableAxes || [], letter = options.letter; var anchor = Lib.coerce(containerIn, containerOut, { anchor: { valType: 'enumerated', values: ['free'].concat(counterAxes), dflt: isNumeric(containerIn.position) ? 'free' : (counterAxes[0] || 'free') } }, 'anchor'); if(anchor === 'free') coerce('position'); Lib.coerce(containerIn, containerOut, { side: { valType: 'enumerated', values: letter === 'x' ? ['bottom', 'top'] : ['left', 'right'], dflt: letter === 'x' ? 'bottom' : 'left' } }, 'side'); var overlaying = false; if(overlayableAxes.length) { overlaying = Lib.coerce(containerIn, containerOut, { overlaying: { valType: 'enumerated', values: [false].concat(overlayableAxes), dflt: false } }, 'overlaying'); } if(!overlaying) { // TODO: right now I'm copying this domain over to overlaying axes // in ax.setscale()... but this means we still need (imperfect) logic // in the axes popover to hide domain for the overlaying axis. // perhaps I should make a private version _domain that all axes get??? var domain = coerce('domain'); if(domain[0] > domain[1] - 0.01) containerOut.domain = [0, 1]; Lib.noneOrAll(containerIn.domain, containerOut.domain, [0, 1]); } return containerOut; }; },{"../../lib":349,"fast-isnumeric":74}],379:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var polygon = require('../../lib/polygon'); var color = require('../../components/color'); var axes = require('./axes'); var constants = require('./constants'); var filteredPolygon = polygon.filter; var polygonTester = polygon.tester; var MINSELECT = constants.MINSELECT; function getAxId(ax) { return ax._id; } module.exports = function prepSelect(e, startX, startY, dragOptions, mode) { var plot = dragOptions.plotinfo.plot, dragBBox = dragOptions.element.getBoundingClientRect(), x0 = startX - dragBBox.left, y0 = startY - dragBBox.top, x1 = x0, y1 = y0, path0 = 'M' + x0 + ',' + y0, pw = dragOptions.xaxes[0]._length, ph = dragOptions.yaxes[0]._length, xAxisIds = dragOptions.xaxes.map(getAxId), yAxisIds = dragOptions.yaxes.map(getAxId), allAxes = dragOptions.xaxes.concat(dragOptions.yaxes), pts; if(mode === 'lasso') { pts = filteredPolygon([[x0, y0]], constants.BENDPX); } var outlines = plot.selectAll('path.select-outline').data([1,2]); outlines.enter() .append('path') .attr('class', function(d) { return 'select-outline select-outline-' + d; }) .attr('d', path0 + 'Z'); var corners = plot.append('path') .attr('class', 'zoombox-corners') .style({ fill: color.background, stroke: color.defaultLine, 'stroke-width': 1 }) .attr('d','M0,0Z'); // find the traces to search for selection points var searchTraces = [], gd = dragOptions.gd, i, cd, trace, searchInfo, selection = [], eventData; for(i = 0; i < gd.calcdata.length; i++) { cd = gd.calcdata[i]; trace = cd[0].trace; if(!trace._module || !trace._module.selectPoints) continue; if(xAxisIds.indexOf(trace.xaxis) === -1) continue; if(yAxisIds.indexOf(trace.yaxis) === -1) continue; searchTraces.push({ selectPoints: trace._module.selectPoints, cd: cd, xaxis: axes.getFromId(gd, trace.xaxis), yaxis: axes.getFromId(gd, trace.yaxis) }); } function axValue(ax) { var index = (ax._id.charAt(0) === 'y') ? 1 : 0; return function(v) { return ax.p2d(v[index]); }; } function ascending(a, b) { return a - b; } dragOptions.moveFn = function(dx0, dy0) { var poly, ax; x1 = Math.max(0, Math.min(pw, dx0 + x0)); y1 = Math.max(0, Math.min(ph, dy0 + y0)); var dx = Math.abs(x1 - x0), dy = Math.abs(y1 - y0); if(mode === 'select') { if(dy < Math.min(dx * 0.6, MINSELECT)) { // horizontal motion: make a vertical box poly = polygonTester([[x0, 0], [x0, ph], [x1, ph], [x1, 0]]); // extras to guide users in keeping a straight selection corners.attr('d', 'M' + poly.xmin + ',' + (y0 - MINSELECT) + 'h-4v' + (2 * MINSELECT) + 'h4Z' + 'M' + (poly.xmax - 1) + ',' + (y0 - MINSELECT) + 'h4v' + (2 * MINSELECT) + 'h-4Z'); } else if(dx < Math.min(dy * 0.6, MINSELECT)) { // vertical motion: make a horizontal box poly = polygonTester([[0, y0], [0, y1], [pw, y1], [pw, y0]]); corners.attr('d', 'M' + (x0 - MINSELECT) + ',' + poly.ymin + 'v-4h' + (2 * MINSELECT) + 'v4Z' + 'M' + (x0 - MINSELECT) + ',' + (poly.ymax - 1) + 'v4h' + (2 * MINSELECT) + 'v-4Z'); } else { // diagonal motion poly = polygonTester([[x0, y0], [x0, y1], [x1, y1], [x1, y0]]); corners.attr('d','M0,0Z'); } outlines.attr('d', 'M' + poly.xmin + ',' + poly.ymin + 'H' + (poly.xmax - 1) + 'V' + (poly.ymax - 1) + 'H' + poly.xmin + 'Z'); } else if(mode === 'lasso') { pts.addPt([x1, y1]); poly = polygonTester(pts.filtered); outlines.attr('d', 'M' + pts.filtered.join('L') + 'Z'); } selection = []; for(i = 0; i < searchTraces.length; i++) { searchInfo = searchTraces[i]; [].push.apply(selection, searchInfo.selectPoints(searchInfo, poly)); } eventData = {points: selection}; if(mode === 'select') { var ranges = eventData.range = {}, axLetter; for(i = 0; i < allAxes.length; i++) { ax = allAxes[i]; axLetter = ax._id.charAt(0); ranges[ax._id] = [ ax.p2d(poly[axLetter + 'min']), ax.p2d(poly[axLetter + 'max'])].sort(ascending); } } else { var dataPts = eventData.lassoPoints = {}; for(i = 0; i < allAxes.length; i++) { ax = allAxes[i]; dataPts[ax._id] = pts.filtered.map(axValue(ax)); } } dragOptions.gd.emit('plotly_selecting', eventData); }; dragOptions.doneFn = function(dragged, numclicks) { if(!dragged && numclicks === 2) { // clear selection on doubleclick outlines.remove(); for(i = 0; i < searchTraces.length; i++) { searchInfo = searchTraces[i]; searchInfo.selectPoints(searchInfo, false); } gd.emit('plotly_deselect', null); } else { dragOptions.gd.emit('plotly_selected', eventData); } corners.remove(); }; }; },{"../../components/color":299,"../../lib/polygon":354,"./axes":369,"./constants":373}],380:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var constants = require('./constants'); var cleanDatum = require('./clean_datum'); var axisIds = require('./axis_ids'); /** * Define the conversion functions for an axis data is used in 4 ways: * * d: data, in whatever form it's provided * c: calcdata: turned into numbers, but not linearized * l: linearized - same as c except for log axes (and other * mappings later?) this is used by ranges, and when we * need to know if it's *possible* to show some data on * this axis, without caring about the current range * p: pixel value - mapped to the screen with current size and zoom * * Creates/updates these conversion functions * also clears the autorange bounds ._min and ._max * and the autotick constraints ._minDtick, ._forceTick0, * and looks for date ranges that aren't yet in numeric format */ module.exports = function setConvert(ax) { // clipMult: how many axis lengths past the edge do we render? // for panning, 1-2 would suffice, but for zooming more is nice. // also, clipping can affect the direction of lines off the edge... var clipMult = 10; function toLog(v, clip) { if(v>0) return Math.log(v)/Math.LN10; else if(v<=0 && clip && ax.range && ax.range.length===2) { // clip NaN (ie past negative infinity) to clipMult axis // length past the negative edge var r0 = ax.range[0], r1 = ax.range[1]; return 0.5*(r0 + r1 - 3 * clipMult * Math.abs(r0 - r1)); } else return constants.BADNUM; } function fromLog(v) { return Math.pow(10,v); } function num(v) { return isNumeric(v) ? Number(v) : constants.BADNUM; } ax.c2l = (ax.type==='log') ? toLog : num; ax.l2c = (ax.type==='log') ? fromLog : num; ax.l2d = function(v) { return ax.c2d(ax.l2c(v)); }; ax.p2d = function(v) { return ax.l2d(ax.p2l(v)); }; // set scaling to pixels ax.setScale = function() { var gs = ax._td._fullLayout._size, i; // TODO cleaner way to handle this case if(!ax._categories) ax._categories = []; // make sure we have a domain (pull it in from the axis // this one is overlaying if necessary) if(ax.overlaying) { var ax2 = axisIds.getFromId(ax._td, ax.overlaying); ax.domain = ax2.domain; } // make sure we have a range (linearized data values) // and that it stays away from the limits of javascript numbers if(!ax.range || ax.range.length!==2 || ax.range[0]===ax.range[1]) { ax.range = [-1,1]; } for(i=0; i<2; i++) { if(!isNumeric(ax.range[i])) { ax.range[i] = isNumeric(ax.range[1-i]) ? (ax.range[1-i] * (i ? 10 : 0.1)) : (i ? 1 : -1); } if(ax.range[i]<-(Number.MAX_VALUE/2)) { ax.range[i] = -(Number.MAX_VALUE/2); } else if(ax.range[i]>Number.MAX_VALUE/2) { ax.range[i] = Number.MAX_VALUE/2; } } if(ax._id.charAt(0)==='y') { ax._offset = gs.t+(1-ax.domain[1])*gs.h; ax._length = gs.h*(ax.domain[1]-ax.domain[0]); ax._m = ax._length/(ax.range[0]-ax.range[1]); ax._b = -ax._m*ax.range[1]; } else { ax._offset = gs.l+ax.domain[0]*gs.w; ax._length = gs.w*(ax.domain[1]-ax.domain[0]); ax._m = ax._length/(ax.range[1]-ax.range[0]); ax._b = -ax._m*ax.range[0]; } if(!isFinite(ax._m) || !isFinite(ax._b)) { Lib.notifier( 'Something went wrong with axis scaling', 'long'); ax._td._replotting = false; throw new Error('axis scaling'); } }; ax.l2p = function(v) { if(!isNumeric(v)) return constants.BADNUM; // include 2 fractional digits on pixel, for PDF zooming etc return d3.round(Lib.constrain(ax._b + ax._m*v, -clipMult*ax._length, (1+clipMult)*ax._length), 2); }; ax.p2l = function(px) { return (px-ax._b)/ax._m; }; ax.c2p = function(v, clip) { return ax.l2p(ax.c2l(v, clip)); }; ax.p2c = function(px) { return ax.l2c(ax.p2l(px)); }; if(['linear','log','-'].indexOf(ax.type)!==-1) { ax.c2d = num; ax.d2c = function(v) { v = cleanDatum(v); return isNumeric(v) ? Number(v) : constants.BADNUM; }; ax.d2l = function(v, clip) { if(ax.type === 'log') return ax.c2l(ax.d2c(v), clip); else return ax.d2c(v); }; } else if(ax.type==='date') { ax.c2d = function(v) { return isNumeric(v) ? Lib.ms2DateTime(v) : constants.BADNUM; }; ax.d2c = function(v) { return (isNumeric(v)) ? Number(v) : Lib.dateTime2ms(v); }; ax.d2l = ax.d2c; // check if date strings or js date objects are provided for range // and convert to ms if(ax.range && ax.range.length>1) { try { var ar1 = ax.range.map(Lib.dateTime2ms); if(!isNumeric(ax.range[0]) && isNumeric(ar1[0])) { ax.range[0] = ar1[0]; } if(!isNumeric(ax.range[1]) && isNumeric(ar1[1])) { ax.range[1] = ar1[1]; } } catch(e) { console.log(e, ax.range); } } } else if(ax.type==='category') { ax.c2d = function(v) { return ax._categories[Math.round(v)]; }; ax.d2c = function(v) { // create the category list // this will enter the categories in the order it // encounters them, ie all the categories from the // first data set, then all the ones from the second // that aren't in the first etc. // TODO: sorting options - do the sorting // progressively here as we insert? if(v !== null && v !== undefined && ax._categories.indexOf(v) === -1) { ax._categories.push(v); } var c = ax._categories.indexOf(v); return c === -1 ? constants.BADNUM : c; }; ax.d2l = ax.d2c; } // makeCalcdata: takes an x or y array and converts it // to a position on the axis object "ax" // inputs: // tdc - a data object from td.data // axletter - a string, either 'x' or 'y', for which item // to convert (TODO: is this now always the same as // the first letter of ax._id?) // in case the expected data isn't there, make a list of // integers based on the opposite data ax.makeCalcdata = function(tdc, axletter) { var arrayIn, arrayOut, i; if(axletter in tdc) { arrayIn = tdc[axletter]; arrayOut = new Array(arrayIn.length); for(i = 0; i < arrayIn.length; i++) arrayOut[i] = ax.d2c(arrayIn[i]); } else { var v0 = ((axletter+'0') in tdc) ? ax.d2c(tdc[axletter+'0']) : 0, dv = (tdc['d'+axletter]) ? Number(tdc['d'+axletter]) : 1; // the opposing data, for size if we have x and dx etc arrayIn = tdc[{x: 'y',y: 'x'}[axletter]]; arrayOut = new Array(arrayIn.length); for(i = 0; i < arrayIn.length; i++) arrayOut[i] = v0+i*dv; } return arrayOut; }; // for autoranging: arrays of objects: // {val: axis value, pad: pixel padding} // on the low and high sides ax._min = []; ax._max = []; // and for bar charts and box plots: reset forced minimum tick spacing ax._minDtick = null; ax._forceTick0 = null; }; },{"../../lib":349,"./axis_ids":371,"./clean_datum":372,"./constants":373,"d3":70,"fast-isnumeric":74}],381:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var layoutAttributes = require('./layout_attributes'); /** * options: inherits font, outerTicks, noHover from axes.handleAxisDefaults */ module.exports = function handleTickDefaults(containerIn, containerOut, coerce, axType, options) { var tickLen = Lib.coerce2(containerIn, containerOut, layoutAttributes, 'ticklen'), tickWidth = Lib.coerce2(containerIn, containerOut, layoutAttributes, 'tickwidth'), tickColor = Lib.coerce2(containerIn, containerOut, layoutAttributes, 'tickcolor'), showTicks = coerce('ticks', (options.outerTicks || tickLen || tickWidth || tickColor) ? 'outside' : ''); if(!showTicks) { delete containerOut.ticklen; delete containerOut.tickwidth; delete containerOut.tickcolor; } var showAttrDflt = getShowAttrDflt(containerIn); var tickPrefix = coerce('tickprefix'); if(tickPrefix) coerce('showtickprefix', showAttrDflt); var tickSuffix = coerce('ticksuffix'); if(tickSuffix) coerce('showticksuffix', showAttrDflt); var showTickLabels = coerce('showticklabels'); if(showTickLabels) { Lib.coerceFont(coerce, 'tickfont', options.font || {}); coerce('tickangle'); if(axType !== 'category') { var tickFormat = coerce('tickformat'); if(!tickFormat && axType !== 'date') { coerce('showexponent', showAttrDflt); coerce('exponentformat'); } } } if(axType !== 'category' && !options.noHover) coerce('hoverformat'); }; /* * Attributes 'showexponent', 'showtickprefix' and 'showticksuffix' * share values. * * If only 1 attribute is set, * the remaining attributes inherit that value. * * If 2 attributes are set to the same value, * the remaining attribute inherits that value. * * If 2 attributes are set to different values, * the remaining is set to its dflt value. * */ function getShowAttrDflt(containerIn) { var showAttrsAll = ['showexponent', 'showtickprefix', 'showticksuffix'], showAttrs = showAttrsAll.filter(function(a) { return containerIn[a]!==undefined; }), sameVal = function(a) { return containerIn[a]===containerIn[showAttrs[0]]; }; if(showAttrs.every(sameVal) || showAttrs.length===1) { return containerIn[showAttrs[0]]; } } },{"../../lib":349,"./layout_attributes":376}],382:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); module.exports = function handleTickValueDefaults(containerIn, containerOut, coerce, axType) { var tickmodeDefault = 'auto'; if(containerIn.tickmode === 'array' && (axType === 'log' || axType === 'date')) { containerIn.tickmode = 'auto'; } if(Array.isArray(containerIn.tickvals)) tickmodeDefault = 'array'; else if(containerIn.dtick && isNumeric(containerIn.dtick)) { tickmodeDefault = 'linear'; } var tickmode = coerce('tickmode', tickmodeDefault); if(tickmode === 'auto') coerce('nticks'); else if(tickmode === 'linear') { coerce('tick0'); coerce('dtick'); } else { var tickvals = coerce('tickvals'); if(tickvals === undefined) containerOut.tickmode = 'auto'; else coerce('ticktext'); } }; },{"fast-isnumeric":74}],383:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { family: { valType: 'string', noBlank: true, strict: true, }, size: { valType: 'number', min: 1 }, color: { valType: 'color', } }; },{}],384:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /* global PlotlyGeoAssets:false */ var d3 = require('d3'); var Color = require('../../components/color'); var Drawing = require('../../components/drawing'); var Axes = require('../../plots/cartesian/axes'); var addProjectionsToD3 = require('./projections'); var createGeoScale = require('./set_scale'); var createGeoZoom = require('./zoom'); var createGeoZoomReset = require('./zoom_reset'); var xmlnsNamespaces = require('../../constants/xmlns_namespaces'); var constants = require('../../constants/geo_constants'); var topojsonUtils = require('../../lib/topojson_utils'); var topojsonFeature = require('topojson').feature; function Geo(options, fullLayout) { this.id = options.id; this.graphDiv = options.graphDiv; this.container = options.container; this.topojsonURL = options.topojsonURL; // add a few projection types to d3.geo, // a subset of https://github.com/d3/d3-geo-projection addProjectionsToD3(); this.hoverContainer = null; this.topojsonName = null; this.topojson = null; this.projectionType = null; this.projection = null; this.clipAngle = null; this.setScale = null; this.path = null; this.zoom = null; this.zoomReset = null; this.makeFramework(); this.updateFx(fullLayout.hovermode); this.traceHash = {}; } module.exports = Geo; var proto = Geo.prototype; proto.plot = function(geoData, fullLayout, promises) { var _this = this, geoLayout = fullLayout[_this.id], graphSize = fullLayout._size; var topojsonNameNew, topojsonPath; // N.B. 'geoLayout' is unambiguous, no need for 'user' geo layout here // TODO don't reset projection on all graph edits _this.projection = null; _this.setScale = createGeoScale(geoLayout, graphSize); _this.makeProjection(geoLayout); _this.makePath(); _this.adjustLayout(geoLayout, graphSize); _this.zoom = createGeoZoom(_this, geoLayout); _this.zoomReset = createGeoZoomReset(_this, geoLayout); _this.mockAxis = createMockAxis(fullLayout); _this.framework .call(_this.zoom) .on('dblclick.zoom', _this.zoomReset); topojsonNameNew = topojsonUtils.getTopojsonName(geoLayout); if(_this.topojson===null || topojsonNameNew!==_this.topojsonName) { _this.topojsonName = topojsonNameNew; if(PlotlyGeoAssets.topojson[_this.topojsonName] !== undefined) { _this.topojson = PlotlyGeoAssets.topojson[_this.topojsonName]; _this.onceTopojsonIsLoaded(geoData, geoLayout); } else { topojsonPath = topojsonUtils.getTopojsonPath( _this.topojsonURL, _this.topojsonName ); promises.push(new Promise(function(resolve, reject) { d3.json(topojsonPath, function(error, topojson) { if(error) { if(error.status === 404) { reject(new Error([ 'plotly.js could not find topojson file at', topojsonPath, '.', 'Make sure the *topojsonURL* plot config option', 'is set properly.' ].join(' '))); } else { reject(new Error([ 'unexpected error while fetching topojson file at', topojsonPath ].join(' '))); } return; } _this.topojson = topojson; PlotlyGeoAssets.topojson[_this.topojsonName] = topojson; _this.onceTopojsonIsLoaded(geoData, geoLayout); resolve(); }); })); } } else _this.onceTopojsonIsLoaded(geoData, geoLayout); // TODO handle topojson-is-loading case // to avoid making multiple request while streaming }; // filter out non-visible trace // geo plot routine use the classic join/enter/exit pattern to update traces function filterData(dataIn) { var dataOut = []; for(var i = 0; i < dataIn.length; i++) { var trace = dataIn[i]; if(trace.visible === true) dataOut.push(trace); } return dataOut; } proto.onceTopojsonIsLoaded = function(geoData, geoLayout) { var i; this.drawLayout(geoLayout); var traceHashOld = this.traceHash; var traceHash = {}; for(i = 0; i < geoData.length; i++) { var trace = geoData[i]; traceHash[trace.type] = traceHash[trace.type] || []; traceHash[trace.type].push(trace); } var moduleNamesOld = Object.keys(traceHashOld); var moduleNames = Object.keys(traceHash); // when a trace gets deleted, make sure that its module's // plot method is called so that it is properly // removed from the DOM. for(i = 0; i < moduleNamesOld.length; i++) { var moduleName = moduleNamesOld[i]; if(moduleNames.indexOf(moduleName) === -1) { var fakeModule = traceHashOld[moduleName][0]; fakeModule.visible = false; traceHash[moduleName] = [fakeModule]; } } moduleNames = Object.keys(traceHash); for(i = 0; i < moduleNames.length; i++) { var moduleData = traceHash[moduleNames[i]]; var _module = moduleData[0]._module; _module.plot(this, filterData(moduleData), geoLayout); } this.traceHash = traceHash; this.render(); }; proto.updateFx = function(hovermode) { this.showHover = (hovermode !== false); // TODO should more strict, any layout.hovermode other // then false will make all geo subplot display hover text. // Instead each geo should have its own geo.hovermode // to control hover visibility independently of other subplots. }; proto.makeProjection = function(geoLayout) { var projLayout = geoLayout.projection, projType = projLayout.type, isNew = this.projection===null || projType!==this.projectionType, projection; if(isNew) { this.projectionType = projType; projection = this.projection = d3.geo[constants.projNames[projType]](); } else projection = this.projection; projection .translate(projLayout._translate0) .precision(constants.precision); if(!geoLayout._isAlbersUsa) { projection .rotate(projLayout._rotate) .center(projLayout._center); } if(geoLayout._clipAngle) { this.clipAngle = geoLayout._clipAngle; // needed in proto.render projection .clipAngle(geoLayout._clipAngle - constants.clipPad); } else this.clipAngle = null; // for graph edits if(projLayout.parallels) { projection .parallels(projLayout.parallels); } if(isNew) this.setScale(projection); projection .translate(projLayout._translate) .scale(projLayout._scale); }; proto.makePath = function() { this.path = d3.geo.path().projection(this.projection); }; /* *

*
* * */ proto.makeFramework = function() { var geoDiv = this.geoDiv = d3.select(this.container).append('div'); geoDiv .attr('id', this.id) .style('position', 'absolute'); var hoverContainer = this.hoverContainer = geoDiv.append('svg'); hoverContainer .attr(xmlnsNamespaces.svgAttrs) .style({ 'position': 'absolute', 'z-index': 20, 'pointer-events': 'none' }); var framework = this.framework = geoDiv.append('svg'); framework .attr(xmlnsNamespaces.svgAttrs) .attr({ 'position': 'absolute', 'preserveAspectRatio': 'none' }); framework.append('g').attr('class', 'bglayer') .append('rect'); framework.append('g').attr('class', 'baselayer'); framework.append('g').attr('class', 'choroplethlayer'); framework.append('g').attr('class', 'baselayeroverchoropleth'); framework.append('g').attr('class', 'scattergeolayer'); // N.B. disable dblclick zoom default framework.on('dblclick.zoom', null); // TODO use clip paths instead of nested SVG }; proto.adjustLayout = function(geoLayout, graphSize) { var domain = geoLayout.domain; this.geoDiv.style({ left: graphSize.l + graphSize.w * domain.x[0] + geoLayout._marginX + 'px', top: graphSize.t + graphSize.h * (1 - domain.y[1]) + geoLayout._marginY + 'px', width: geoLayout._width + 'px', height: geoLayout._height + 'px' }); this.hoverContainer.attr({ width: geoLayout._width, height: geoLayout._height }); this.framework.attr({ width: geoLayout._width, height: geoLayout._height }); this.framework.select('.bglayer').select('rect') .attr({ width: geoLayout._width, height: geoLayout._height }) .style({ 'fill': geoLayout.bgcolor, 'stroke-width': 0 }); }; proto.drawTopo = function(selection, layerName, geoLayout) { if(geoLayout['show' + layerName] !== true) return; var topojson = this.topojson, datum = layerName==='frame' ? constants.sphereSVG : topojsonFeature(topojson, topojson.objects[layerName]); selection.append('g') .datum(datum) .attr('class', layerName) .append('path') .attr('class', 'basepath'); }; function makeGraticule(lonaxisRange, lataxisRange, step) { return d3.geo.graticule() .extent([ [lonaxisRange[0], lataxisRange[0]], [lonaxisRange[1], lataxisRange[1]] ]) .step(step); } proto.drawGraticule = function(selection, axisName, geoLayout) { var axisLayout = geoLayout[axisName]; if(axisLayout.showgrid !== true) return; var scopeDefaults = constants.scopeDefaults[geoLayout.scope], lonaxisRange = scopeDefaults.lonaxisRange, lataxisRange = scopeDefaults.lataxisRange, step = axisName==='lonaxis' ? [axisLayout.dtick] : [0, axisLayout.dtick], graticule = makeGraticule(lonaxisRange, lataxisRange, step); selection.append('g') .datum(graticule) .attr('class', axisName + 'graticule') .append('path') .attr('class', 'graticulepath'); }; proto.drawLayout = function(geoLayout) { var gBaseLayer = this.framework.select('g.baselayer'), baseLayers = constants.baseLayers, axesNames = constants.axesNames, layerName; // TODO move to more d3-idiomatic pattern (that's work on replot) // N.B. html('') does not work in IE11 gBaseLayer.selectAll('*').remove(); for(var i = 0; i < baseLayers.length; i++) { layerName = baseLayers[i]; if(axesNames.indexOf(layerName)!==-1) { this.drawGraticule(gBaseLayer, layerName, geoLayout); } else this.drawTopo(gBaseLayer, layerName, geoLayout); } this.styleLayout(geoLayout); }; function styleFillLayer(selection, layerName, geoLayout) { var layerAdj = constants.layerNameToAdjective[layerName]; selection.select('.' + layerName) .selectAll('path') .attr('stroke', 'none') .call(Color.fill, geoLayout[layerAdj + 'color']); } function styleLineLayer(selection, layerName, geoLayout) { var layerAdj = constants.layerNameToAdjective[layerName]; selection.select('.' + layerName) .selectAll('path') .attr('fill', 'none') .call(Color.stroke, geoLayout[layerAdj + 'color']) .call(Drawing.dashLine, '', geoLayout[layerAdj + 'width']); } function styleGraticule(selection, axisName, geoLayout) { selection.select('.' + axisName + 'graticule') .selectAll('path') .attr('fill', 'none') .call(Color.stroke, geoLayout[axisName].gridcolor) .call(Drawing.dashLine, '', geoLayout[axisName].gridwidth); } proto.styleLayer = function(selection, layerName, geoLayout) { var fillLayers = constants.fillLayers, lineLayers = constants.lineLayers; if(fillLayers.indexOf(layerName)!==-1) { styleFillLayer(selection, layerName, geoLayout); } else if(lineLayers.indexOf(layerName)!==-1) { styleLineLayer(selection, layerName, geoLayout); } }; proto.styleLayout = function(geoLayout) { var gBaseLayer = this.framework.select('g.baselayer'), baseLayers = constants.baseLayers, axesNames = constants.axesNames, layerName; for(var i = 0; i < baseLayers.length; i++) { layerName = baseLayers[i]; if(axesNames.indexOf(layerName)!==-1) { styleGraticule(gBaseLayer, layerName, geoLayout); } else this.styleLayer(gBaseLayer, layerName, geoLayout); } }; // [hot code path] (re)draw all paths which depend on the projection proto.render = function() { var framework = this.framework, gChoropleth = framework.select('g.choroplethlayer'), gScatterGeo = framework.select('g.scattergeolayer'), projection = this.projection, path = this.path, clipAngle = this.clipAngle; function translatePoints(d) { var lonlat = projection([d.lon, d.lat]); if(!lonlat) return null; return 'translate(' + lonlat[0] + ',' + lonlat[1] + ')'; } // hide paths over edges of clipped projections function hideShowPoints(d) { var p = projection.rotate(), angle = d3.geo.distance([d.lon, d.lat], [-p[0], -p[1]]), maxAngle = clipAngle * Math.PI / 180; return (angle > maxAngle) ? '0' : '1.0'; } framework.selectAll('path.basepath').attr('d', path); framework.selectAll('path.graticulepath').attr('d', path); gChoropleth.selectAll('path.choroplethlocation').attr('d', path); gChoropleth.selectAll('path.basepath').attr('d', path); gScatterGeo.selectAll('path.js-line').attr('d', path); if(clipAngle !== null) { gScatterGeo.selectAll('path.point') .style('opacity', hideShowPoints) .attr('transform', translatePoints); gScatterGeo.selectAll('text') .style('opacity', hideShowPoints) .attr('transform', translatePoints); } else { gScatterGeo.selectAll('path.point') .attr('transform', translatePoints); gScatterGeo.selectAll('text') .attr('transform', translatePoints); } }; // create a mock axis used to format hover text function createMockAxis(fullLayout) { var mockAxis = { type: 'linear', showexponent: 'all', exponentformat: Axes.layoutAttributes.exponentformat.dflt, _td: { _fullLayout: fullLayout } }; Axes.setConvert(mockAxis); return mockAxis; } },{"../../components/color":299,"../../components/drawing":317,"../../constants/geo_constants":334,"../../constants/xmlns_namespaces":338,"../../lib/topojson_utils":361,"../../plots/cartesian/axes":369,"./projections":391,"./set_scale":392,"./zoom":393,"./zoom_reset":394,"d3":70,"topojson":230}],385:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Geo = require('./geo'); var Plots = require('../../plots/plots'); exports.name = 'geo'; exports.attr = 'geo'; exports.idRoot = 'geo'; exports.idRegex = /^geo([2-9]|[1-9][0-9]+)?$/; exports.attrRegex = /^geo([2-9]|[1-9][0-9]+)?$/; exports.attributes = require('./layout/attributes'); exports.layoutAttributes = require('./layout/layout_attributes'); exports.supplyLayoutDefaults = require('./layout/defaults'); exports.plot = function plotGeo(gd) { var fullLayout = gd._fullLayout, fullData = gd._fullData, geoIds = Plots.getSubplotIds(fullLayout, 'geo'); /** * If 'plotly-geo-assets.js' is not included, * initialize object to keep reference to every loaded topojson */ if(window.PlotlyGeoAssets === undefined) { window.PlotlyGeoAssets = { topojson: {} }; } for(var i = 0; i < geoIds.length; i++) { var geoId = geoIds[i], fullGeoData = Plots.getSubplotData(fullData, 'geo', geoId), geo = fullLayout[geoId]._geo; // If geo is not instantiated, create one! if(geo === undefined) { geo = new Geo({ id: geoId, graphDiv: gd, container: fullLayout._geocontainer.node(), topojsonURL: gd._context.topojsonURL }, fullLayout ); fullLayout[geoId]._geo = geo; } geo.plot(fullGeoData, fullLayout, gd._promises); } }; exports.clean = function(newFullData, newFullLayout, oldFullData, oldFullLayout) { var oldGeoKeys = Plots.getSubplotIds(oldFullLayout, 'geo'); for(var i = 0; i < oldGeoKeys.length; i++) { var oldGeoKey = oldGeoKeys[i]; var oldGeo = oldFullLayout[oldGeoKey]._geo; if(!newFullLayout[oldGeoKey] && !!oldGeo) { oldGeo.geoDiv.remove(); } } }; },{"../../plots/plots":413,"./geo":384,"./layout/attributes":386,"./layout/defaults":389,"./layout/layout_attributes":390}],386:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { geo: { valType: 'geoid', dflt: 'geo', } }; },{}],387:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var colorAttrs = require('../../../components/color/attributes'); module.exports = { range: { valType: 'info_array', items: [ {valType: 'number'}, {valType: 'number'} ], }, showgrid: { valType: 'boolean', dflt: false, }, tick0: { valType: 'number', }, dtick: { valType: 'number', }, gridcolor: { valType: 'color', dflt: colorAttrs.lightLine, }, gridwidth: { valType: 'number', min: 0, dflt: 1, } }; },{"../../../components/color/attributes":298}],388:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../../lib'); var constants = require('../../../constants/geo_constants'); var axisAttributes = require('./axis_attributes'); module.exports = function supplyGeoAxisLayoutDefaults(geoLayoutIn, geoLayoutOut) { var axesNames = constants.axesNames; var axisIn, axisOut; function coerce(attr, dflt) { return Lib.coerce(axisIn, axisOut, axisAttributes, attr, dflt); } function getRangeDflt(axisName) { var scope = geoLayoutOut.scope; var projLayout, projType, projRotation, rotateAngle, dfltSpans, halfSpan; if(scope === 'world') { projLayout = geoLayoutOut.projection; projType = projLayout.type; projRotation = projLayout.rotation; dfltSpans = constants[axisName + 'Span']; halfSpan = dfltSpans[projType]!==undefined ? dfltSpans[projType] / 2 : dfltSpans['*'] / 2; rotateAngle = axisName==='lonaxis' ? projRotation.lon : projRotation.lat; return [rotateAngle - halfSpan, rotateAngle + halfSpan]; } else return constants.scopeDefaults[scope][axisName + 'Range']; } for(var i = 0; i < axesNames.length; i++) { var axisName = axesNames[i]; axisIn = geoLayoutIn[axisName] || {}; axisOut = {}; var rangeDflt = getRangeDflt(axisName); var range = coerce('range', rangeDflt); Lib.noneOrAll(axisIn.range, axisOut.range, [0, 1]); coerce('tick0', range[0]); coerce('dtick', axisName==='lonaxis' ? 30 : 10); var show = coerce('showgrid'); if(show) { coerce('gridcolor'); coerce('gridwidth'); } geoLayoutOut[axisName] = axisOut; geoLayoutOut[axisName]._fullRange = rangeDflt; } }; },{"../../../constants/geo_constants":334,"../../../lib":349,"./axis_attributes":387}],389:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../../lib'); var Plots = require('../../plots'); var constants = require('../../../constants/geo_constants'); var layoutAttributes = require('./layout_attributes'); var supplyGeoAxisLayoutDefaults = require('./axis_defaults'); module.exports = function supplyLayoutDefaults(layoutIn, layoutOut, fullData) { if(!layoutOut._hasGeo) return; var geos = Plots.findSubplotIds(fullData, 'geo'), geosLength = geos.length; var geoLayoutIn, geoLayoutOut; function coerce(attr, dflt) { return Lib.coerce(geoLayoutIn, geoLayoutOut, layoutAttributes, attr, dflt); } for(var i = 0; i < geosLength; i++) { var geo = geos[i]; // geo traces get a layout geo for free! if(layoutIn[geo]) geoLayoutIn = layoutIn[geo]; else geoLayoutIn = layoutIn[geo] = {}; geoLayoutIn = layoutIn[geo]; geoLayoutOut = {}; coerce('domain.x'); coerce('domain.y', [i / geosLength, (i + 1) / geosLength]); handleGeoDefaults(geoLayoutIn, geoLayoutOut, coerce); layoutOut[geo] = geoLayoutOut; } }; function handleGeoDefaults(geoLayoutIn, geoLayoutOut, coerce) { var show; var scope = coerce('scope'); var isScoped = (scope !== 'world'); var scopeParams = constants.scopeDefaults[scope]; var resolution = coerce('resolution'); var projType = coerce('projection.type', scopeParams.projType); var isAlbersUsa = projType==='albers usa'; var isConic = projType.indexOf('conic')!==-1; if(isConic) { var dfltProjParallels = scopeParams.projParallels || [0, 60]; coerce('projection.parallels', dfltProjParallels); } if(!isAlbersUsa) { var dfltProjRotate = scopeParams.projRotate || [0, 0, 0]; coerce('projection.rotation.lon', dfltProjRotate[0]); coerce('projection.rotation.lat', dfltProjRotate[1]); coerce('projection.rotation.roll', dfltProjRotate[2]); show = coerce('showcoastlines', !isScoped); if(show) { coerce('coastlinecolor'); coerce('coastlinewidth'); } show = coerce('showocean'); if(show) coerce('oceancolor'); } else geoLayoutOut.scope = 'usa'; coerce('projection.scale'); show = coerce('showland'); if(show) coerce('landcolor'); show = coerce('showlakes'); if(show) coerce('lakecolor'); show = coerce('showrivers'); if(show) { coerce('rivercolor'); coerce('riverwidth'); } show = coerce('showcountries', isScoped); if(show) { coerce('countrycolor'); coerce('countrywidth'); } if(scope==='usa' || (scope==='north america' && resolution===50)) { // Only works for: // USA states at 110m // USA states + Canada provinces at 50m coerce('showsubunits', true); coerce('subunitcolor'); coerce('subunitwidth'); } if(!isScoped) { // Does not work in non-world scopes show = coerce('showframe', true); if(show) { coerce('framecolor'); coerce('framewidth'); } } coerce('bgcolor'); supplyGeoAxisLayoutDefaults(geoLayoutIn, geoLayoutOut); // bind a few helper variables geoLayoutOut._isHighRes = resolution===50; geoLayoutOut._clipAngle = constants.lonaxisSpan[projType] / 2; geoLayoutOut._isAlbersUsa = isAlbersUsa; geoLayoutOut._isConic = isConic; geoLayoutOut._isScoped = isScoped; var rotation = geoLayoutOut.projection.rotation || {}; geoLayoutOut.projection._rotate = [ -rotation.lon || 0, -rotation.lat || 0, rotation.roll || 0 ]; } },{"../../../constants/geo_constants":334,"../../../lib":349,"../../plots":413,"./axis_defaults":388,"./layout_attributes":390}],390:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var colorAttrs = require('../../../components/color/attributes'); var constants = require('../../../constants/geo_constants'); var geoAxesAttrs = require('./axis_attributes'); module.exports = { domain: { x: { valType: 'info_array', items: [ {valType: 'number', min: 0, max: 1}, {valType: 'number', min: 0, max: 1} ], dflt: [0, 1], }, y: { valType: 'info_array', items: [ {valType: 'number', min: 0, max: 1}, {valType: 'number', min: 0, max: 1} ], dflt: [0, 1], } }, resolution: { valType: 'enumerated', values: [110, 50], dflt: 110, coerceNumber: true, }, scope: { valType: 'enumerated', values: Object.keys(constants.scopeDefaults), dflt: 'world', }, projection: { type: { valType: 'enumerated', values: Object.keys(constants.projNames), }, rotation: { lon: { valType: 'number', }, lat: { valType: 'number', }, roll: { valType: 'number', } }, parallels: { valType: 'info_array', items: [ {valType: 'number'}, {valType: 'number'} ], }, scale: { valType: 'number', min: 0, max: 10, dflt: 1, } }, showcoastlines: { valType: 'boolean', }, coastlinecolor: { valType: 'color', dflt: colorAttrs.defaultLine, }, coastlinewidth: { valType: 'number', min: 0, dflt: 1, }, showland: { valType: 'boolean', dflt: false, }, landcolor: { valType: 'color', dflt: constants.landColor, }, showocean: { valType: 'boolean', dflt: false, }, oceancolor: { valType: 'color', dflt: constants.waterColor, }, showlakes: { valType: 'boolean', dflt: false, }, lakecolor: { valType: 'color', dflt: constants.waterColor, }, showrivers: { valType: 'boolean', dflt: false, }, rivercolor: { valType: 'color', dflt: constants.waterColor, }, riverwidth: { valType: 'number', min: 0, dflt: 1, }, showcountries: { valType: 'boolean', }, countrycolor: { valType: 'color', dflt: colorAttrs.defaultLine, }, countrywidth: { valType: 'number', min: 0, dflt: 1, }, showsubunits: { valType: 'boolean', }, subunitcolor: { valType: 'color', dflt: colorAttrs.defaultLine, }, subunitwidth: { valType: 'number', min: 0, dflt: 1, }, showframe: { valType: 'boolean', }, framecolor: { valType: 'color', dflt: colorAttrs.defaultLine, }, framewidth: { valType: 'number', min: 0, dflt: 1, }, bgcolor: { valType: 'color', dflt: colorAttrs.background, }, lonaxis: geoAxesAttrs, lataxis: geoAxesAttrs }; },{"../../../components/color/attributes":298,"../../../constants/geo_constants":334,"./axis_attributes":387}],391:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ /** * Forked from https://github.com/d3/d3-geo-projection * Pasted from https://github.com/etpinard/d3-geo-projection * * Containing only the 'most useful' projection types * and compatible with CommonJs * */ var d3 = require('d3'); function addProjectionToD3() { d3.geo.project = function(object, projection) { var stream = projection.stream; if (!stream) throw new Error("not yet supported"); return (object && d3_geo_projectObjectType.hasOwnProperty(object.type) ? d3_geo_projectObjectType[object.type] : d3_geo_projectGeometry)(object, stream); }; function d3_geo_projectFeature(object, stream) { return { type: "Feature", id: object.id, properties: object.properties, geometry: d3_geo_projectGeometry(object.geometry, stream) }; } function d3_geo_projectGeometry(geometry, stream) { if (!geometry) return null; if (geometry.type === "GeometryCollection") return { type: "GeometryCollection", geometries: object.geometries.map(function(geometry) { return d3_geo_projectGeometry(geometry, stream); }) }; if (!d3_geo_projectGeometryType.hasOwnProperty(geometry.type)) return null; var sink = d3_geo_projectGeometryType[geometry.type]; d3.geo.stream(geometry, stream(sink)); return sink.result(); } var d3_geo_projectObjectType = { Feature: d3_geo_projectFeature, FeatureCollection: function(object, stream) { return { type: "FeatureCollection", features: object.features.map(function(feature) { return d3_geo_projectFeature(feature, stream); }) }; } }; var d3_geo_projectPoints = [], d3_geo_projectLines = []; var d3_geo_projectPoint = { point: function(x, y) { d3_geo_projectPoints.push([ x, y ]); }, result: function() { var result = !d3_geo_projectPoints.length ? null : d3_geo_projectPoints.length < 2 ? { type: "Point", coordinates: d3_geo_projectPoints[0] } : { type: "MultiPoint", coordinates: d3_geo_projectPoints }; d3_geo_projectPoints = []; return result; } }; var d3_geo_projectLine = { lineStart: d3_geo_projectNoop, point: function(x, y) { d3_geo_projectPoints.push([ x, y ]); }, lineEnd: function() { if (d3_geo_projectPoints.length) d3_geo_projectLines.push(d3_geo_projectPoints), d3_geo_projectPoints = []; }, result: function() { var result = !d3_geo_projectLines.length ? null : d3_geo_projectLines.length < 2 ? { type: "LineString", coordinates: d3_geo_projectLines[0] } : { type: "MultiLineString", coordinates: d3_geo_projectLines }; d3_geo_projectLines = []; return result; } }; var d3_geo_projectPolygon = { polygonStart: d3_geo_projectNoop, lineStart: d3_geo_projectNoop, point: function(x, y) { d3_geo_projectPoints.push([ x, y ]); }, lineEnd: function() { var n = d3_geo_projectPoints.length; if (n) { do d3_geo_projectPoints.push(d3_geo_projectPoints[0].slice()); while (++n < 4); d3_geo_projectLines.push(d3_geo_projectPoints), d3_geo_projectPoints = []; } }, polygonEnd: d3_geo_projectNoop, result: function() { if (!d3_geo_projectLines.length) return null; var polygons = [], holes = []; d3_geo_projectLines.forEach(function(ring) { if (d3_geo_projectClockwise(ring)) polygons.push([ ring ]); else holes.push(ring); }); holes.forEach(function(hole) { var point = hole[0]; polygons.some(function(polygon) { if (d3_geo_projectContains(polygon[0], point)) { polygon.push(hole); return true; } }) || polygons.push([ hole ]); }); d3_geo_projectLines = []; return !polygons.length ? null : polygons.length > 1 ? { type: "MultiPolygon", coordinates: polygons } : { type: "Polygon", coordinates: polygons[0] }; } }; var d3_geo_projectGeometryType = { Point: d3_geo_projectPoint, MultiPoint: d3_geo_projectPoint, LineString: d3_geo_projectLine, MultiLineString: d3_geo_projectLine, Polygon: d3_geo_projectPolygon, MultiPolygon: d3_geo_projectPolygon, Sphere: d3_geo_projectPolygon }; function d3_geo_projectNoop() {} function d3_geo_projectClockwise(ring) { if ((n = ring.length) < 4) return false; var i = 0, n, area = ring[n - 1][1] * ring[0][0] - ring[n - 1][0] * ring[0][1]; while (++i < n) area += ring[i - 1][1] * ring[i][0] - ring[i - 1][0] * ring[i][1]; return area <= 0; } function d3_geo_projectContains(ring, point) { var x = point[0], y = point[1], contains = false; for (var i = 0, n = ring.length, j = n - 1; i < n; j = i++) { var pi = ring[i], xi = pi[0], yi = pi[1], pj = ring[j], xj = pj[0], yj = pj[1]; if (yi > y ^ yj > y && x < (xj - xi) * (y - yi) / (yj - yi) + xi) contains = !contains; } return contains; } var ε = 1e-6, ε2 = ε * ε, π = Math.PI, halfπ = π / 2, sqrtπ = Math.sqrt(π), radians = π / 180, degrees = 180 / π; function sinci(x) { return x ? x / Math.sin(x) : 1; } function sgn(x) { return x > 0 ? 1 : x < 0 ? -1 : 0; } function asin(x) { return x > 1 ? halfπ : x < -1 ? -halfπ : Math.asin(x); } function acos(x) { return x > 1 ? 0 : x < -1 ? π : Math.acos(x); } function asqrt(x) { return x > 0 ? Math.sqrt(x) : 0; } var projection = d3.geo.projection, projectionMutator = d3.geo.projectionMutator; d3.geo.interrupt = function(project) { var lobes = [ [ [ [ -π, 0 ], [ 0, halfπ ], [ π, 0 ] ] ], [ [ [ -π, 0 ], [ 0, -halfπ ], [ π, 0 ] ] ] ]; var bounds; function forward(λ, φ) { var sign = φ < 0 ? -1 : +1, hemilobes = lobes[+(φ < 0)]; for (var i = 0, n = hemilobes.length - 1; i < n && λ > hemilobes[i][2][0]; ++i) ; var coordinates = project(λ - hemilobes[i][1][0], φ); coordinates[0] += project(hemilobes[i][1][0], sign * φ > sign * hemilobes[i][0][1] ? hemilobes[i][0][1] : φ)[0]; return coordinates; } function reset() { bounds = lobes.map(function(hemilobes) { return hemilobes.map(function(lobe) { var x0 = project(lobe[0][0], lobe[0][1])[0], x1 = project(lobe[2][0], lobe[2][1])[0], y0 = project(lobe[1][0], lobe[0][1])[1], y1 = project(lobe[1][0], lobe[1][1])[1], t; if (y0 > y1) t = y0, y0 = y1, y1 = t; return [ [ x0, y0 ], [ x1, y1 ] ]; }); }); } if (project.invert) forward.invert = function(x, y) { var hemibounds = bounds[+(y < 0)], hemilobes = lobes[+(y < 0)]; for (var i = 0, n = hemibounds.length; i < n; ++i) { var b = hemibounds[i]; if (b[0][0] <= x && x < b[1][0] && b[0][1] <= y && y < b[1][1]) { var coordinates = project.invert(x - project(hemilobes[i][1][0], 0)[0], y); coordinates[0] += hemilobes[i][1][0]; return pointEqual(forward(coordinates[0], coordinates[1]), [ x, y ]) ? coordinates : null; } } }; var projection = d3.geo.projection(forward), stream_ = projection.stream; projection.stream = function(stream) { var rotate = projection.rotate(), rotateStream = stream_(stream), sphereStream = (projection.rotate([ 0, 0 ]), stream_(stream)); projection.rotate(rotate); rotateStream.sphere = function() { d3.geo.stream(sphere(), sphereStream); }; return rotateStream; }; projection.lobes = function(_) { if (!arguments.length) return lobes.map(function(lobes) { return lobes.map(function(lobe) { return [ [ lobe[0][0] * 180 / π, lobe[0][1] * 180 / π ], [ lobe[1][0] * 180 / π, lobe[1][1] * 180 / π ], [ lobe[2][0] * 180 / π, lobe[2][1] * 180 / π ] ]; }); }); lobes = _.map(function(lobes) { return lobes.map(function(lobe) { return [ [ lobe[0][0] * π / 180, lobe[0][1] * π / 180 ], [ lobe[1][0] * π / 180, lobe[1][1] * π / 180 ], [ lobe[2][0] * π / 180, lobe[2][1] * π / 180 ] ]; }); }); reset(); return projection; }; function sphere() { var ε = 1e-6, coordinates = []; for (var i = 0, n = lobes[0].length; i < n; ++i) { var lobe = lobes[0][i], λ0 = lobe[0][0] * 180 / π, φ0 = lobe[0][1] * 180 / π, φ1 = lobe[1][1] * 180 / π, λ2 = lobe[2][0] * 180 / π, φ2 = lobe[2][1] * 180 / π; coordinates.push(resample([ [ λ0 + ε, φ0 + ε ], [ λ0 + ε, φ1 - ε ], [ λ2 - ε, φ1 - ε ], [ λ2 - ε, φ2 + ε ] ], 30)); } for (var i = lobes[1].length - 1; i >= 0; --i) { var lobe = lobes[1][i], λ0 = lobe[0][0] * 180 / π, φ0 = lobe[0][1] * 180 / π, φ1 = lobe[1][1] * 180 / π, λ2 = lobe[2][0] * 180 / π, φ2 = lobe[2][1] * 180 / π; coordinates.push(resample([ [ λ2 - ε, φ2 - ε ], [ λ2 - ε, φ1 + ε ], [ λ0 + ε, φ1 + ε ], [ λ0 + ε, φ0 - ε ] ], 30)); } return { type: "Polygon", coordinates: [ d3.merge(coordinates) ] }; } function resample(coordinates, m) { var i = -1, n = coordinates.length, p0 = coordinates[0], p1, dx, dy, resampled = []; while (++i < n) { p1 = coordinates[i]; dx = (p1[0] - p0[0]) / m; dy = (p1[1] - p0[1]) / m; for (var j = 0; j < m; ++j) resampled.push([ p0[0] + j * dx, p0[1] + j * dy ]); p0 = p1; } resampled.push(p1); return resampled; } function pointEqual(a, b) { return Math.abs(a[0] - b[0]) < ε && Math.abs(a[1] - b[1]) < ε; } return projection; }; function eckert4(λ, φ) { var k = (2 + halfπ) * Math.sin(φ); φ /= 2; for (var i = 0, δ = Infinity; i < 10 && Math.abs(δ) > ε; i++) { var cosφ = Math.cos(φ); φ -= δ = (φ + Math.sin(φ) * (cosφ + 2) - k) / (2 * cosφ * (1 + cosφ)); } return [ 2 / Math.sqrt(π * (4 + π)) * λ * (1 + Math.cos(φ)), 2 * Math.sqrt(π / (4 + π)) * Math.sin(φ) ]; } eckert4.invert = function(x, y) { var A = .5 * y * Math.sqrt((4 + π) / π), k = asin(A), c = Math.cos(k); return [ x / (2 / Math.sqrt(π * (4 + π)) * (1 + c)), asin((k + A * (c + 2)) / (2 + halfπ)) ]; }; (d3.geo.eckert4 = function() { return projection(eckert4); }).raw = eckert4; var hammerAzimuthalEqualArea = d3.geo.azimuthalEqualArea.raw; function hammer(A, B) { if (arguments.length < 2) B = A; if (B === 1) return hammerAzimuthalEqualArea; if (B === Infinity) return hammerQuarticAuthalic; function forward(λ, φ) { var coordinates = hammerAzimuthalEqualArea(λ / B, φ); coordinates[0] *= A; return coordinates; } forward.invert = function(x, y) { var coordinates = hammerAzimuthalEqualArea.invert(x / A, y); coordinates[0] *= B; return coordinates; }; return forward; } function hammerProjection() { var B = 2, m = projectionMutator(hammer), p = m(B); p.coefficient = function(_) { if (!arguments.length) return B; return m(B = +_); }; return p; } function hammerQuarticAuthalic(λ, φ) { return [ λ * Math.cos(φ) / Math.cos(φ /= 2), 2 * Math.sin(φ) ]; } hammerQuarticAuthalic.invert = function(x, y) { var φ = 2 * asin(y / 2); return [ x * Math.cos(φ / 2) / Math.cos(φ), φ ]; }; (d3.geo.hammer = hammerProjection).raw = hammer; function kavrayskiy7(λ, φ) { return [ 3 * λ / (2 * π) * Math.sqrt(π * π / 3 - φ * φ), φ ]; } kavrayskiy7.invert = function(x, y) { return [ 2 / 3 * π * x / Math.sqrt(π * π / 3 - y * y), y ]; }; (d3.geo.kavrayskiy7 = function() { return projection(kavrayskiy7); }).raw = kavrayskiy7; function miller(λ, φ) { return [ λ, 1.25 * Math.log(Math.tan(π / 4 + .4 * φ)) ]; } miller.invert = function(x, y) { return [ x, 2.5 * Math.atan(Math.exp(.8 * y)) - .625 * π ]; }; (d3.geo.miller = function() { return projection(miller); }).raw = miller; function mollweideBromleyθ(Cp) { return function(θ) { var Cpsinθ = Cp * Math.sin(θ), i = 30, δ; do θ -= δ = (θ + Math.sin(θ) - Cpsinθ) / (1 + Math.cos(θ)); while (Math.abs(δ) > ε && --i > 0); return θ / 2; }; } function mollweideBromley(Cx, Cy, Cp) { var θ = mollweideBromleyθ(Cp); function forward(λ, φ) { return [ Cx * λ * Math.cos(φ = θ(φ)), Cy * Math.sin(φ) ]; } forward.invert = function(x, y) { var θ = asin(y / Cy); return [ x / (Cx * Math.cos(θ)), asin((2 * θ + Math.sin(2 * θ)) / Cp) ]; }; return forward; } var mollweideθ = mollweideBromleyθ(π), mollweide = mollweideBromley(Math.SQRT2 / halfπ, Math.SQRT2, π); (d3.geo.mollweide = function() { return projection(mollweide); }).raw = mollweide; function naturalEarth(λ, φ) { var φ2 = φ * φ, φ4 = φ2 * φ2; return [ λ * (.8707 - .131979 * φ2 + φ4 * (-.013791 + φ4 * (.003971 * φ2 - .001529 * φ4))), φ * (1.007226 + φ2 * (.015085 + φ4 * (-.044475 + .028874 * φ2 - .005916 * φ4))) ]; } naturalEarth.invert = function(x, y) { var φ = y, i = 25, δ; do { var φ2 = φ * φ, φ4 = φ2 * φ2; φ -= δ = (φ * (1.007226 + φ2 * (.015085 + φ4 * (-.044475 + .028874 * φ2 - .005916 * φ4))) - y) / (1.007226 + φ2 * (.015085 * 3 + φ4 * (-.044475 * 7 + .028874 * 9 * φ2 - .005916 * 11 * φ4))); } while (Math.abs(δ) > ε && --i > 0); return [ x / (.8707 + (φ2 = φ * φ) * (-.131979 + φ2 * (-.013791 + φ2 * φ2 * φ2 * (.003971 - .001529 * φ2)))), φ ]; }; (d3.geo.naturalEarth = function() { return projection(naturalEarth); }).raw = naturalEarth; var robinsonConstants = [ [ .9986, -.062 ], [ 1, 0 ], [ .9986, .062 ], [ .9954, .124 ], [ .99, .186 ], [ .9822, .248 ], [ .973, .31 ], [ .96, .372 ], [ .9427, .434 ], [ .9216, .4958 ], [ .8962, .5571 ], [ .8679, .6176 ], [ .835, .6769 ], [ .7986, .7346 ], [ .7597, .7903 ], [ .7186, .8435 ], [ .6732, .8936 ], [ .6213, .9394 ], [ .5722, .9761 ], [ .5322, 1 ] ]; robinsonConstants.forEach(function(d) { d[1] *= 1.0144; }); function robinson(λ, φ) { var i = Math.min(18, Math.abs(φ) * 36 / π), i0 = Math.floor(i), di = i - i0, ax = (k = robinsonConstants[i0])[0], ay = k[1], bx = (k = robinsonConstants[++i0])[0], by = k[1], cx = (k = robinsonConstants[Math.min(19, ++i0)])[0], cy = k[1], k; return [ λ * (bx + di * (cx - ax) / 2 + di * di * (cx - 2 * bx + ax) / 2), (φ > 0 ? halfπ : -halfπ) * (by + di * (cy - ay) / 2 + di * di * (cy - 2 * by + ay) / 2) ]; } robinson.invert = function(x, y) { var yy = y / halfπ, φ = yy * 90, i = Math.min(18, Math.abs(φ / 5)), i0 = Math.max(0, Math.floor(i)); do { var ay = robinsonConstants[i0][1], by = robinsonConstants[i0 + 1][1], cy = robinsonConstants[Math.min(19, i0 + 2)][1], u = cy - ay, v = cy - 2 * by + ay, t = 2 * (Math.abs(yy) - by) / u, c = v / u, di = t * (1 - c * t * (1 - 2 * c * t)); if (di >= 0 || i0 === 1) { φ = (y >= 0 ? 5 : -5) * (di + i); var j = 50, δ; do { i = Math.min(18, Math.abs(φ) / 5); i0 = Math.floor(i); di = i - i0; ay = robinsonConstants[i0][1]; by = robinsonConstants[i0 + 1][1]; cy = robinsonConstants[Math.min(19, i0 + 2)][1]; φ -= (δ = (y >= 0 ? halfπ : -halfπ) * (by + di * (cy - ay) / 2 + di * di * (cy - 2 * by + ay) / 2) - y) * degrees; } while (Math.abs(δ) > ε2 && --j > 0); break; } } while (--i0 >= 0); var ax = robinsonConstants[i0][0], bx = robinsonConstants[i0 + 1][0], cx = robinsonConstants[Math.min(19, i0 + 2)][0]; return [ x / (bx + di * (cx - ax) / 2 + di * di * (cx - 2 * bx + ax) / 2), φ * radians ]; }; (d3.geo.robinson = function() { return projection(robinson); }).raw = robinson; function sinusoidal(λ, φ) { return [ λ * Math.cos(φ), φ ]; } sinusoidal.invert = function(x, y) { return [ x / Math.cos(y), y ]; }; (d3.geo.sinusoidal = function() { return projection(sinusoidal); }).raw = sinusoidal; } module.exports = addProjectionToD3; },{"d3":70}],392:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var clipPad = require('../../constants/geo_constants').clipPad; function createGeoScale(geoLayout, graphSize) { var projLayout = geoLayout.projection, lonaxisLayout = geoLayout.lonaxis, lataxisLayout = geoLayout.lataxis, geoDomain = geoLayout.domain, frameWidth = geoLayout.framewidth || 0; // width & height the geo div var geoWidth = graphSize.w * (geoDomain.x[1] - geoDomain.x[0]), geoHeight = graphSize.h * (geoDomain.y[1] - geoDomain.y[0]); // add padding around range to avoid aliasing var lon0 = lonaxisLayout.range[0] + clipPad, lon1 = lonaxisLayout.range[1] - clipPad, lat0 = lataxisLayout.range[0] + clipPad, lat1 = lataxisLayout.range[1] - clipPad, lonfull0 = lonaxisLayout._fullRange[0] + clipPad, lonfull1 = lonaxisLayout._fullRange[1] - clipPad, latfull0 = lataxisLayout._fullRange[0] + clipPad, latfull1 = lataxisLayout._fullRange[1] - clipPad; // initial translation (makes the math easier) projLayout._translate0 = [ graphSize.l + geoWidth / 2, graphSize.t + geoHeight / 2 ]; // center of the projection is given by // the lon/lat ranges and the rotate angle var dlon = lon1 - lon0, dlat = lat1 - lat0, c0 = [lon0 + dlon / 2, lat0 + dlat / 2], r = projLayout._rotate; projLayout._center = [c0[0] + r[0], c0[1] + r[1]]; // needs a initial projection; it is called from makeProjection var setScale = function(projection) { var scale0 = projection.scale(), translate0 = projLayout._translate0, rangeBox = makeRangeBox(lon0, lat0, lon1, lat1), fullRangeBox = makeRangeBox(lonfull0, latfull0, lonfull1, latfull1); var scale, translate, bounds, fullBounds; // Inspired by: http://stackoverflow.com/a/14654988/4068492 // using the path determine the bounds of the current map and use // these to determine better values for the scale and translation function getScale(bounds) { return Math.min( scale0 * geoWidth / (bounds[1][0] - bounds[0][0]), scale0 * geoHeight / (bounds[1][1] - bounds[0][1]) ); } // scale projection given how range box get deformed // by the projection bounds = getBounds(projection, rangeBox); scale = getScale(bounds); // similarly, get scale at full range fullBounds = getBounds(projection, fullRangeBox); projLayout._fullScale = getScale(fullBounds); projection.scale(scale); // translate the projection so that the top-left corner // of the range box is at the top-left corner of the viewbox bounds = getBounds(projection, rangeBox); translate = [ translate0[0] - bounds[0][0] + frameWidth, translate0[1] - bounds[0][1] + frameWidth ]; projLayout._translate = translate; projection.translate(translate); // clip regions out of the range box // (these are clipping along horizontal/vertical lines) bounds = getBounds(projection, rangeBox); if(!geoLayout._isAlbersUsa) projection.clipExtent(bounds); // adjust scale one more time with the 'scale' attribute scale = projLayout.scale * scale; // set projection scale and save it projLayout._scale = scale; // save the effective width & height of the geo framework geoLayout._width = Math.round(bounds[1][0]) + frameWidth; geoLayout._height = Math.round(bounds[1][1]) + frameWidth; // save the margin length induced by the map scaling geoLayout._marginX = (geoWidth - Math.round(bounds[1][0])) / 2; geoLayout._marginY = (geoHeight - Math.round(bounds[1][1])) / 2; }; return setScale; } module.exports = createGeoScale; // polygon GeoJSON corresponding to lon/lat range box // with well-defined direction function makeRangeBox(lon0, lat0, lon1, lat1) { var dlon4 = (lon1 - lon0) / 4; // TODO is this enough to handle ALL cases? // -- this makes scaling less precise than using d3.geo.graticule // as great circles can overshoot the boundary // (that's not a big deal I think) return { type: 'Polygon', coordinates: [ [ [lon0, lat0], [lon0 , lat1], [lon0 + dlon4, lat1], [lon0 + 2 * dlon4, lat1], [lon0 + 3 * dlon4, lat1], [lon1, lat1], [lon1, lat0], [lon1 - dlon4, lat0], [lon1 - 2 * dlon4, lat0], [lon1 - 3 * dlon4, lat0], [lon0, lat0] ] ] }; } // bounds array [[top, left], [bottom, right]] // of the lon/lat range box function getBounds(projection, rangeBox) { return d3.geo.path().projection(projection).bounds(rangeBox); } },{"../../constants/geo_constants":334,"d3":70}],393:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var radians = Math.PI / 180, degrees = 180 / Math.PI, zoomstartStyle = { cursor: 'pointer' }, zoomendStyle = { cursor: 'auto' }; function createGeoZoom(geo, geoLayout) { var zoomConstructor; if(geoLayout._isScoped) zoomConstructor = zoomScoped; else if(geoLayout._clipAngle) zoomConstructor = zoomClipped; else zoomConstructor = zoomNonClipped; // TODO add a conic-specific zoom return zoomConstructor(geo, geoLayout.projection); } module.exports = createGeoZoom; // common to all zoom types function initZoom(projection, projLayout) { var fullScale = projLayout._fullScale; return d3.behavior.zoom() .translate(projection.translate()) .scale(projection.scale()) .scaleExtent([0.5 * fullScale, 100 * fullScale]); } // zoom for scoped projections function zoomScoped(geo, projLayout) { var projection = geo.projection, zoom = initZoom(projection, projLayout); function handleZoomstart() { d3.select(this).style(zoomstartStyle); } function handleZoom() { projection .scale(d3.event.scale) .translate(d3.event.translate); geo.render(); } function handleZoomend() { d3.select(this).style(zoomendStyle); } zoom .on('zoomstart', handleZoomstart) .on('zoom', handleZoom) .on('zoomend', handleZoomend); return zoom; } // zoom for non-clipped projections function zoomNonClipped(geo, projLayout) { var projection = geo.projection, zoom = initZoom(projection, projLayout); var INSIDETOLORANCEPXS = 2; var mouse0, rotate0, translate0, lastRotate, zoomPoint, mouse1, rotate1, point1; function position(x) { return projection.invert(x); } function outside(x) { var pt = projection(position(x)); return (Math.abs(pt[0] - x[0]) > INSIDETOLORANCEPXS || Math.abs(pt[1] - x[1]) > INSIDETOLORANCEPXS); } function handleZoomstart() { d3.select(this).style(zoomstartStyle); mouse0 = d3.mouse(this); rotate0 = projection.rotate(); translate0 = projection.translate(); lastRotate = rotate0; zoomPoint = position(mouse0); } function handleZoom() { mouse1 = d3.mouse(this); if(outside(mouse0)) { zoom.scale(projection.scale()); zoom.translate(projection.translate()); return; } projection.scale(d3.event.scale); projection.translate([translate0[0], d3.event.translate[1]]); if(!zoomPoint) { mouse0 = mouse1; zoomPoint = position(mouse0); } else if(position(mouse1)) { point1 = position(mouse1); rotate1 = [lastRotate[0] + (point1[0] - zoomPoint[0]), rotate0[1], rotate0[2]]; projection.rotate(rotate1); lastRotate = rotate1; } geo.render(); } function handleZoomend() { d3.select(this).style(zoomendStyle); // or something like // http://www.jasondavies.com/maps/gilbert/ // ... a little harder with multiple base layers } zoom .on('zoomstart', handleZoomstart) .on('zoom', handleZoom) .on('zoomend', handleZoomend); return zoom; } // zoom for clipped projections // inspired by https://www.jasondavies.com/maps/d3.geo.zoom.js function zoomClipped(geo, projLayout) { var projection = geo.projection, view = {r: projection.rotate(), k: projection.scale()}, zoom = initZoom(projection, projLayout), event = d3_eventDispatch(zoom, 'zoomstart', 'zoom', 'zoomend'), zooming = 0, zoomOn = zoom.on; var zoomPoint; zoom.on('zoomstart', function() { d3.select(this).style(zoomstartStyle); var mouse0 = d3.mouse(this), rotate0 = projection.rotate(), lastRotate = rotate0, translate0 = projection.translate(), q = quaternionFromEuler(rotate0); zoomPoint = position(projection, mouse0); zoomOn.call(zoom, 'zoom', function() { var mouse1 = d3.mouse(this); projection.scale(view.k = d3.event.scale); if(!zoomPoint) { // if no zoomPoint, the mouse wasn't over the actual geography yet // maybe this point is the start... we'll find out next time! mouse0 = mouse1; zoomPoint = position(projection, mouse0); } // check if the point is on the map // if not, don't do anything new but scale // if it is, then we can assume between will exist below // so we don't need the 'bank' function, whatever that is. // TODO: is this right? else if(position(projection, mouse1)) { // go back to original projection temporarily // except for scale... that's kind of independent? projection .rotate(rotate0) .translate(translate0); // calculate the new params var point1 = position(projection, mouse1), between = rotateBetween(zoomPoint, point1), newEuler = eulerFromQuaternion(multiply(q, between)), rotateAngles = view.r = unRoll(newEuler, zoomPoint, lastRotate); if(!isFinite(rotateAngles[0]) || !isFinite(rotateAngles[1]) || !isFinite(rotateAngles[2])) { rotateAngles = lastRotate; } // update the projection projection.rotate(rotateAngles); lastRotate = rotateAngles; } zoomed(event.of(this, arguments)); }); zoomstarted(event.of(this, arguments)); }) .on('zoomend', function() { d3.select(this).style(zoomendStyle); zoomOn.call(zoom, 'zoom', null); zoomended(event.of(this, arguments)); }) .on('zoom.redraw', function() { geo.render(); }); function zoomstarted(dispatch) { if(!zooming++) dispatch({type: 'zoomstart'}); } function zoomed(dispatch) { dispatch({type: 'zoom'}); } function zoomended(dispatch) { if(!--zooming) dispatch({type: 'zoomend'}); } return d3.rebind(zoom, event, 'on'); } // -- helper functions for zoomClipped function position(projection, point) { var spherical = projection.invert(point); return spherical && isFinite(spherical[0]) && isFinite(spherical[1]) && cartesian(spherical); } function quaternionFromEuler(euler) { var lambda = 0.5 * euler[0] * radians, phi = 0.5 * euler[1] * radians, gamma = 0.5 * euler[2] * radians, sinLambda = Math.sin(lambda), cosLambda = Math.cos(lambda), sinPhi = Math.sin(phi), cosPhi = Math.cos(phi), sinGamma = Math.sin(gamma), cosGamma = Math.cos(gamma); return [ cosLambda * cosPhi * cosGamma + sinLambda * sinPhi * sinGamma, sinLambda * cosPhi * cosGamma - cosLambda * sinPhi * sinGamma, cosLambda * sinPhi * cosGamma + sinLambda * cosPhi * sinGamma, cosLambda * cosPhi * sinGamma - sinLambda * sinPhi * cosGamma ]; } function multiply(a, b) { var a0 = a[0], a1 = a[1], a2 = a[2], a3 = a[3], b0 = b[0], b1 = b[1], b2 = b[2], b3 = b[3]; return [ a0 * b0 - a1 * b1 - a2 * b2 - a3 * b3, a0 * b1 + a1 * b0 + a2 * b3 - a3 * b2, a0 * b2 - a1 * b3 + a2 * b0 + a3 * b1, a0 * b3 + a1 * b2 - a2 * b1 + a3 * b0 ]; } function rotateBetween(a, b) { if(!a || !b) return; var axis = cross(a, b), norm = Math.sqrt(dot(axis, axis)), halfgamma = 0.5 * Math.acos(Math.max(-1, Math.min(1, dot(a, b)))), k = Math.sin(halfgamma) / norm; return norm && [Math.cos(halfgamma), axis[2] * k, -axis[1] * k, axis[0] * k]; } // input: // rotateAngles: a calculated set of Euler angles // pt: a point (cartesian in 3-space) to keep fixed // roll0: an initial roll, to be preserved // output: // a set of Euler angles that preserve the projection of pt // but set roll (output[2]) equal to roll0 // note that this doesn't depend on the particular projection, // just on the rotation angles function unRoll(rotateAngles, pt, lastRotate) { // calculate the fixed point transformed by these Euler angles // but with the desired roll undone var ptRotated = rotateCartesian(pt, 2, rotateAngles[0]); ptRotated = rotateCartesian(ptRotated, 1, rotateAngles[1]); ptRotated = rotateCartesian(ptRotated, 0, rotateAngles[2] - lastRotate[2]); var x = pt[0], y = pt[1], z = pt[2], f = ptRotated[0], g = ptRotated[1], h = ptRotated[2], // the following essentially solves: // ptRotated = rotateCartesian(rotateCartesian(pt, 2, newYaw), 1, newPitch) // for newYaw and newPitch, as best it can theta = Math.atan2(y, x) * degrees, a = Math.sqrt(x * x + y * y), b, newYaw1; if(Math.abs(g) > a) { newYaw1 = (g > 0 ? 90 : -90) - theta; b = 0; } else { newYaw1 = Math.asin(g / a) * degrees - theta; b = Math.sqrt(a * a - g * g); } var newYaw2 = 180 - newYaw1 - 2*theta, newPitch1 = (Math.atan2(h, f) - Math.atan2(z, b)) * degrees, newPitch2 = (Math.atan2(h, f) - Math.atan2(z, -b)) * degrees; // which is closest to lastRotate[0,1]: newYaw/Pitch or newYaw2/Pitch2? var dist1 = angleDistance(lastRotate[0], lastRotate[1], newYaw1, newPitch1), dist2 = angleDistance(lastRotate[0], lastRotate[1], newYaw2, newPitch2); if(dist1 <= dist2) return [newYaw1, newPitch1, lastRotate[2]]; else return [newYaw2, newPitch2, lastRotate[2]]; } function angleDistance(yaw0, pitch0, yaw1, pitch1) { var dYaw = angleMod(yaw1 - yaw0), dPitch = angleMod(pitch1 - pitch0); return Math.sqrt(dYaw * dYaw + dPitch * dPitch); } // reduce an angle in degrees to [-180,180] function angleMod(angle) { return (angle % 360 + 540) %360 - 180; } // rotate a cartesian vector // axis is 0 (x), 1 (y), or 2 (z) // angle is in degrees function rotateCartesian(vector, axis, angle) { var angleRads = angle * radians, vectorOut = vector.slice(), ax1 = (axis===0) ? 1 : 0, ax2 = (axis===2) ? 1 : 2, cosa = Math.cos(angleRads), sina = Math.sin(angleRads); vectorOut[ax1] = vector[ax1] * cosa - vector[ax2] * sina; vectorOut[ax2] = vector[ax2] * cosa + vector[ax1] * sina; return vectorOut; } function eulerFromQuaternion(q) { return [ Math.atan2(2 * (q[0] * q[1] + q[2] * q[3]), 1 - 2 * (q[1] * q[1] + q[2] * q[2])) * degrees, Math.asin(Math.max(-1, Math.min(1, 2 * (q[0] * q[2] - q[3] * q[1])))) * degrees, Math.atan2(2 * (q[0] * q[3] + q[1] * q[2]), 1 - 2 * (q[2] * q[2] + q[3] * q[3])) * degrees ]; } function cartesian(spherical) { var lambda = spherical[0] * radians, phi = spherical[1] * radians, cosPhi = Math.cos(phi); return [ cosPhi * Math.cos(lambda), cosPhi * Math.sin(lambda), Math.sin(phi) ]; } function dot(a, b) { var s = 0; for(var i = 0, n = a.length; i < n; ++i) s += a[i] * b[i]; return s; } function cross(a, b) { return [ a[1] * b[2] - a[2] * b[1], a[2] * b[0] - a[0] * b[2], a[0] * b[1] - a[1] * b[0] ]; } // Like d3.dispatch, but for custom events abstracting native UI events. These // events have a target component (such as a brush), a target element (such as // the svg:g element containing the brush) and the standard arguments `d` (the // target element's data) and `i` (the selection index of the target element). function d3_eventDispatch(target) { var i = 0, n = arguments.length, argumentz = []; while(++i < n) argumentz.push(arguments[i]); var dispatch = d3.dispatch.apply(null, argumentz); // Creates a dispatch context for the specified `thiz` (typically, the target // DOM element that received the source event) and `argumentz` (typically, the // data `d` and index `i` of the target element). The returned function can be // used to dispatch an event to any registered listeners; the function takes a // single argument as input, being the event to dispatch. The event must have // a "type" attribute which corresponds to a type registered in the // constructor. This context will automatically populate the "sourceEvent" and // "target" attributes of the event, as well as setting the `d3.event` global // for the duration of the notification. dispatch.of = function(thiz, argumentz) { return function(e1) { var e0; try { e0 = e1.sourceEvent = d3.event; e1.target = target; d3.event = e1; dispatch[e1.type].apply(thiz, argumentz); } finally { d3.event = e0; } }; }; return dispatch; } },{"d3":70}],394:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Fx = require('../cartesian/graph_interact'); function createGeoZoomReset(geo, geoLayout) { var projection = geo.projection, zoom = geo.zoom; var zoomReset = function() { geo.makeProjection(geoLayout); geo.makePath(); zoom.scale(projection.scale()); zoom.translate(projection.translate()); Fx.loneUnhover(geo.hoverContainer); geo.render(); }; return zoomReset; } module.exports = createGeoZoomReset; },{"../cartesian/graph_interact":374}],395:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var mouseChange = require('mouse-change'); var mouseWheel = require('mouse-wheel'); module.exports = createCamera; function Camera2D(element, plot) { this.element = element; this.plot = plot; this.mouseListener = null; this.wheelListener = null; this.lastInputTime = Date.now(); this.lastPos = [0, 0]; this.boxEnabled = false; this.boxStart = [0, 0]; this.boxEnd = [0, 0]; } function createCamera(scene) { var element = scene.mouseContainer, plot = scene.glplot, result = new Camera2D(element, plot); result.mouseListener = mouseChange(element, function(buttons, x, y) { var xrange = scene.xaxis.range, yrange = scene.yaxis.range, viewBox = plot.viewBox; var lastX = result.lastPos[0], lastY = result.lastPos[1]; x *= plot.pixelRatio; y *= plot.pixelRatio; // mouseChange gives y about top; convert to about bottom y = (viewBox[3] - viewBox[1]) - y; function updateRange(range, start, end) { var range0 = Math.min(start, end), range1 = Math.max(start, end); if(range0 !== range1) { range[0] = range0; range[1] = range1; result.dataBox = range; } else { scene.selectBox.selectBox = [0, 0, 1, 1]; scene.glplot.setDirty(); } } switch(scene.fullLayout.dragmode) { case 'zoom': if(buttons) { var dataX = x / (viewBox[2] - viewBox[0]) * (xrange[1] - xrange[0]) + xrange[0]; var dataY = y / (viewBox[3] - viewBox[1]) * (yrange[1] - yrange[0]) + yrange[0]; if(!result.boxEnabled) { result.boxStart[0] = dataX; result.boxStart[1] = dataY; } result.boxEnd[0] = dataX; result.boxEnd[1] = dataY; result.boxEnabled = true; } else if(result.boxEnabled) { updateRange(xrange, result.boxStart[0], result.boxEnd[0]); updateRange(yrange, result.boxStart[1], result.boxEnd[1]); result.boxEnabled = false; } break; case 'pan': result.boxEnabled = false; if(buttons) { var dx = (lastX - x) * (xrange[1] - xrange[0]) / (plot.viewBox[2] - plot.viewBox[0]); var dy = (lastY - y) * (yrange[1] - yrange[0]) / (plot.viewBox[3] - plot.viewBox[1]); xrange[0] += dx; xrange[1] += dx; yrange[0] += dy; yrange[1] += dy; result.lastInputTime = Date.now(); scene.cameraChanged(); } break; } result.lastPos[0] = x; result.lastPos[1] = y; }); result.wheelListener = mouseWheel(element, function(dx, dy) { var xrange = scene.xaxis.range, yrange = scene.yaxis.range, viewBox = plot.viewBox; var lastX = result.lastPos[0], lastY = result.lastPos[1]; switch(scene.fullLayout.dragmode) { case 'zoom': break; case 'pan': var scale = Math.exp(0.1 * dy / (viewBox[3] - viewBox[1])); var cx = lastX / (viewBox[2] - viewBox[0]) * (xrange[1] - xrange[0]) + xrange[0]; var cy = lastY / (viewBox[3] - viewBox[1]) * (yrange[1] - yrange[0]) + yrange[0]; xrange[0] = (xrange[0] - cx) * scale + cx; xrange[1] = (xrange[1] - cx) * scale + cx; yrange[0] = (yrange[0] - cy) * scale + cy; yrange[1] = (yrange[1] - cy) * scale + cy; result.lastInputTime = Date.now(); scene.cameraChanged(); break; } return true; }); return result; } },{"mouse-change":196,"mouse-wheel":200}],396:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../../plotly'); var htmlToUnicode = require('../../lib/html2unicode'); var str2RGBArray = require('../../lib/str2rgbarray'); function Axes2DOptions(scene) { this.scene = scene; this.gl = scene.gl; this.pixelRatio = scene.pixelRatio; this.screenBox = [0, 0, 1, 1]; this.viewBox = [0 ,0, 1, 1]; this.dataBox = [-1, -1, 1, 1]; this.borderLineEnable = [false, false, false, false]; this.borderLineWidth = [1, 1, 1, 1]; this.borderLineColor = [ [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1] ]; this.ticks = [[], []]; this.tickEnable = [true, true, false, false]; this.tickPad = [15, 15, 15, 15]; this.tickAngle = [0, 0, 0, 0]; this.tickColor = [ [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1] ]; this.tickMarkLength = [0, 0, 0, 0]; this.tickMarkWidth = [0, 0, 0, 0]; this.tickMarkColor = [ [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1] ]; this.labels = ['x', 'y']; this.labelEnable = [true, true, false, false]; this.labelAngle = [0, Math.PI/2, 0, 3.0*Math.PI/2]; this.labelPad = [15, 15, 15, 15]; this.labelSize = [12, 12]; this.labelFont = ['sans-serif', 'sans-serif']; this.labelColor = [ [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1] ]; this.title = ''; this.titleEnable = true; this.titleCenter = [0, 0, 0, 0]; this.titleAngle = 0; this.titleColor = [0, 0, 0, 1]; this.titleFont = 'sans-serif'; this.titleSize = 18; this.gridLineEnable = [true, true]; this.gridLineColor = [ [0, 0, 0, 0.5], [0, 0, 0, 0.5] ]; this.gridLineWidth = [1, 1]; this.zeroLineEnable = [true, true]; this.zeroLineWidth = [1, 1]; this.zeroLineColor = [ [0, 0, 0, 1], [0, 0, 0, 1] ]; this.borderColor = [0, 0, 0, 0]; this.backgroundColor = [0, 0, 0, 0]; } var proto = Axes2DOptions.prototype; var AXES = ['xaxis', 'yaxis']; proto.merge = function(options) { // titles are rendered in SVG this.titleEnable = false; this.backgroundColor = str2RGBArray(options.plot_bgcolor); var axisName, ax, axTitle, axMirror; var hasAxisInDfltPos, hasAxisInAltrPos, hasSharedAxis, mirrorLines, mirrorTicks; var i, j; for(i = 0; i < 2; ++i) { axisName = AXES[i]; // get options relevant to this subplot, // '_name' is e.g. xaxis, xaxis2, yaxis, yaxis4 ... ax = options[this.scene[axisName]._name]; axTitle = /Click to enter .+ title/.test(ax.title) ? '' : ax.title; for(j = 0; j <= 2; j += 2) { this.labelEnable[i+j] = false; this.labels[i+j] = htmlToUnicode(axTitle); this.labelColor[i+j] = str2RGBArray(ax.titlefont.color); this.labelFont[i+j] = ax.titlefont.family; this.labelSize[i+j] = ax.titlefont.size; this.labelPad[i+j] = this.getLabelPad(axisName, ax); this.tickEnable[i+j] = false; this.tickColor[i+j] = str2RGBArray((ax.tickfont || {}).color); this.tickAngle[i+j] = (ax.tickangle === 'auto') ? 0 : Math.PI * -ax.tickangle / 180; this.tickPad[i+j] = this.getTickPad(ax); this.tickMarkLength[i+j] = 0; this.tickMarkWidth[i+j] = ax.tickwidth || 0; this.tickMarkColor[i+j] = str2RGBArray(ax.tickcolor); this.borderLineEnable[i+j] = false; this.borderLineColor[i+j] = str2RGBArray(ax.linecolor); this.borderLineWidth[i+j] = ax.linewidth || 0; } hasSharedAxis = this.hasSharedAxis(ax); hasAxisInDfltPos = this.hasAxisInDfltPos(axisName, ax) && !hasSharedAxis; hasAxisInAltrPos = this.hasAxisInAltrPos(axisName, ax) && !hasSharedAxis; axMirror = ax.mirror || false; mirrorLines = hasSharedAxis ? (String(axMirror).indexOf('all') !== -1) : // 'all' or 'allticks' !!axMirror; // all but false mirrorTicks = hasSharedAxis ? (axMirror === 'allticks') : (String(axMirror).indexOf('ticks') !== -1); // 'ticks' or 'allticks' // Axis titles and tick labels can only appear of one side of the scene // and are never show on subplots that share existing axes. if(hasAxisInDfltPos) this.labelEnable[i] = true; else if(hasAxisInAltrPos) this.labelEnable[i+2] = true; if(hasAxisInDfltPos) this.tickEnable[i] = ax.showticklabels; else if(hasAxisInAltrPos) this.tickEnable[i+2] = ax.showticklabels; // Grid lines and ticks can appear on both sides of the scene // and can appear on subplot that share existing axes via `ax.mirror`. if(hasAxisInDfltPos || mirrorLines) this.borderLineEnable[i] = ax.showline; if(hasAxisInAltrPos || mirrorLines) this.borderLineEnable[i+2] = ax.showline; if(hasAxisInDfltPos || mirrorTicks) this.tickMarkLength[i] = this.getTickMarkLength(ax); if(hasAxisInAltrPos || mirrorTicks) this.tickMarkLength[i+2] = this.getTickMarkLength(ax); this.gridLineEnable[i] = ax.showgrid; this.gridLineColor[i] = str2RGBArray(ax.gridcolor); this.gridLineWidth[i] = ax.gridwidth; this.zeroLineEnable[i] = ax.zeroline; this.zeroLineColor[i] = str2RGBArray(ax.zerolinecolor); this.zeroLineWidth[i] = ax.zerolinewidth; } }; // is an axis shared with an already-drawn subplot ? proto.hasSharedAxis = function(ax) { var scene = this.scene, subplotIds = Plotly.Plots.getSubplotIds(scene.fullLayout, 'gl2d'), list = Plotly.Axes.findSubplotsWithAxis(subplotIds, ax); // if index === 0, then the subplot is already drawn as subplots // are drawn in order. return (list.indexOf(scene.id) !== 0); }; // has an axis in default position (i.e. bottom/left) ? proto.hasAxisInDfltPos = function(axisName, ax) { var axSide = ax.side; if(axisName === 'xaxis') return (axSide === 'bottom'); else if(axisName === 'yaxis') return (axSide === 'left'); }; // has an axis in alternate position (i.e. top/right) ? proto.hasAxisInAltrPos = function(axisName, ax) { var axSide = ax.side; if(axisName === 'xaxis') return (axSide === 'top'); else if(axisName === 'yaxis') return (axSide === 'right'); }; proto.getLabelPad = function(axisName, ax) { var offsetBase = 1.5, fontSize = ax.titlefont.size, showticklabels = ax.showticklabels; if(axisName === 'xaxis') { return (ax.side === 'top') ? -10 + fontSize * (offsetBase + (showticklabels ? 1 : 0)) : -10 + fontSize * (offsetBase + (showticklabels ? 0.5 : 0)); } else if(axisName === 'yaxis') { return (ax.side === 'right') ? 10 + fontSize * (offsetBase + (showticklabels ? 1 : 0.5)) : 10 + fontSize * (offsetBase + (showticklabels ? 0.5 : 0)); } }; proto.getTickPad = function(ax) { return (ax.ticks === 'outside') ? 10 + ax.ticklen : 15; }; proto.getTickMarkLength = function(ax) { if(!ax.ticks) return 0; var ticklen = ax.ticklen; return (ax.ticks === 'inside') ? -ticklen : ticklen; }; function createAxes2D(scene) { return new Axes2DOptions(scene); } module.exports = createAxes2D; },{"../../lib/html2unicode":348,"../../lib/str2rgbarray":359,"../../plotly":366}],397:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../../plotly'); var Scene2D = require('./scene2d'); var Plots = Plotly.Plots; exports.name = 'gl2d'; exports.attr = ['xaxis', 'yaxis']; exports.idRoot = ['x', 'y']; exports.idRegex = { x: /^x([2-9]|[1-9][0-9]+)?$/, y: /^y([2-9]|[1-9][0-9]+)?$/ }; exports.attrRegex = { x: /^xaxis([2-9]|[1-9][0-9]+)?$/, y: /^yaxis([2-9]|[1-9][0-9]+)?$/ }; exports.attributes = require('../cartesian/attributes'); exports.plot = function plotGl2d(gd) { var fullLayout = gd._fullLayout, fullData = gd._fullData, subplotIds = Plots.getSubplotIds(fullLayout, 'gl2d'); for(var i = 0; i < subplotIds.length; i++) { var subplotId = subplotIds[i], subplotObj = fullLayout._plots[subplotId], fullSubplotData = Plots.getSubplotData(fullData, 'gl2d', subplotId); // ref. to corresp. Scene instance var scene = subplotObj._scene2d; // If Scene is not instantiated, create one! if(scene === undefined) { scene = new Scene2D({ container: gd.querySelector('.gl-container'), id: subplotId, staticPlot: gd._context.staticPlot, plotGlPixelRatio: gd._context.plotGlPixelRatio }, fullLayout ); // set ref to Scene instance subplotObj._scene2d = scene; } scene.plot(fullSubplotData, fullLayout, gd.layout); } }; },{"../../plotly":366,"../cartesian/attributes":368,"./scene2d":398}],398:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plots = require('../../plots/plots'); var Axes = require('../../plots/cartesian/axes'); var Fx = require('../../plots/cartesian/graph_interact'); var createPlot2D = require('gl-plot2d'); var createSpikes = require('gl-spikes2d'); var createSelectBox = require('gl-select-box'); var createOptions = require('./convert'); var createCamera = require('./camera'); var htmlToUnicode = require('../../lib/html2unicode'); var showNoWebGlMsg = require('../../lib/show_no_webgl_msg'); var AXES = ['xaxis', 'yaxis']; var STATIC_CANVAS, STATIC_CONTEXT; function Scene2D(options, fullLayout) { this.container = options.container; this.pixelRatio = options.plotGlPixelRatio || window.devicePixelRatio; this.id = options.id; this.staticPlot = !!options.staticPlot; this.fullLayout = fullLayout; this.updateAxes(fullLayout); this.makeFramework(); // update options this.glplotOptions = createOptions(this); this.glplotOptions.merge(fullLayout); // create the plot this.glplot = createPlot2D(this.glplotOptions); // create camera this.camera = createCamera(this); // trace set this.traces = {}; // create axes spikes this.spikes = createSpikes(this.glplot); this.selectBox = createSelectBox(this.glplot, { innerFill: false, outerFill: true }); // last pick result this.pickResult = null; this.bounds = [Infinity, Infinity, -Infinity, -Infinity]; // flag to stop render loop this.stopped = false; // redraw the plot this.redraw = this.draw.bind(this); this.redraw(); } module.exports = Scene2D; var proto = Scene2D.prototype; proto.makeFramework = function() { // create canvas and gl context if(this.staticPlot) { if(!STATIC_CONTEXT) { STATIC_CANVAS = document.createElement('canvas'); try { STATIC_CONTEXT = STATIC_CANVAS.getContext('webgl', { preserveDrawingBuffer: true, premultipliedAlpha: true, antialias: true }); } catch(e) { throw new Error([ 'Error creating static canvas/context for image server' ].join(' ')); } } this.canvas = STATIC_CANVAS; this.gl = STATIC_CONTEXT; } else { var liveCanvas = document.createElement('canvas'), glOpts = { premultipliedAlpha: true }; var gl; try { gl = liveCanvas.getContext('webgl', glOpts); } catch(e) { // } if(!gl) { try { gl = liveCanvas.getContext('experimental-webgl', glOpts); } catch(e) { // } } if(!gl) showNoWebGlMsg(this); this.canvas = liveCanvas; this.gl = gl; } // position the canvas var canvas = this.canvas, pixelRatio = this.pixelRatio, fullLayout = this.fullLayout; canvas.width = Math.ceil(pixelRatio * fullLayout.width) |0; canvas.height = Math.ceil(pixelRatio * fullLayout.height) |0; canvas.style.width = '100%'; canvas.style.height = '100%'; canvas.style.position = 'absolute'; canvas.style.top = '0px'; canvas.style.left = '0px'; canvas.style['pointer-events'] = 'none'; // create SVG container for hover text var svgContainer = this.svgContainer = document.createElementNS( 'http://www.w3.org/2000/svg', 'svg'); svgContainer.style.position = 'absolute'; svgContainer.style.top = svgContainer.style.left = '0px'; svgContainer.style.width = svgContainer.style.height = '100%'; svgContainer.style['z-index'] = 20; svgContainer.style['pointer-events'] = 'none'; // create div to catch the mouse event var mouseContainer = this.mouseContainer = document.createElement('div'); mouseContainer.style.position = 'absolute'; // append canvas, hover svg and mouse div to container var container = this.container; container.appendChild(canvas); container.appendChild(svgContainer); container.appendChild(mouseContainer); }; proto.toImage = function(format) { if(!format) format = 'png'; this.stopped = true; if(this.staticPlot) this.container.appendChild(STATIC_CANVAS); // force redraw this.glplot.setDirty(true); this.glplot.draw(); // grab context and yank out pixels var gl = this.glplot.gl, w = gl.drawingBufferWidth, h = gl.drawingBufferHeight; gl.bindFramebuffer(gl.FRAMEBUFFER, null); var pixels = new Uint8Array(w * h * 4); gl.readPixels(0, 0, w, h, gl.RGBA, gl.UNSIGNED_BYTE, pixels); // flip pixels for(var j=0,k=h-1; j bounds[i+2]) { bounds[i] = -1; bounds[i+2] = 1; } ax = this[AXES[i]]; ax._length = options.viewBox[i+2] - options.viewBox[i]; Axes.doAutoRange(ax); } options.ticks = this.computeTickMarks(); var xrange = this.xaxis.range; var yrange = this.yaxis.range; options.dataBox = [xrange[0], yrange[0], xrange[1], yrange[1]]; options.merge(fullLayout); glplot.update(options); }; proto.draw = function() { if(this.stopped) return; requestAnimationFrame(this.redraw); var glplot = this.glplot, camera = this.camera, mouseListener = camera.mouseListener, fullLayout = this.fullLayout; this.cameraChanged(); var x = mouseListener.x * glplot.pixelRatio; var y = this.canvas.height - glplot.pixelRatio * mouseListener.y; if(camera.boxEnabled && fullLayout.dragmode === 'zoom') { this.selectBox.enabled = true; this.selectBox.selectBox = [ Math.min(camera.boxStart[0], camera.boxEnd[0]), Math.min(camera.boxStart[1], camera.boxEnd[1]), Math.max(camera.boxStart[0], camera.boxEnd[0]), Math.max(camera.boxStart[1], camera.boxEnd[1]) ]; glplot.setDirty(); } else { this.selectBox.enabled = false; var size = fullLayout._size, domainX = this.xaxis.domain, domainY = this.yaxis.domain; var result = glplot.pick( (x / glplot.pixelRatio) + size.l + domainX[0] * size.w, (y / glplot.pixelRatio) - (size.t + (1-domainY[1]) * size.h) ); if(result && fullLayout.hovermode) { var nextSelection = result.object._trace.handlePick(result); if(nextSelection && ( !this.lastPickResult || this.lastPickResult.trace !== nextSelection.trace || this.lastPickResult.dataCoord[0] !== nextSelection.dataCoord[0] || this.lastPickResult.dataCoord[1] !== nextSelection.dataCoord[1]) ) { var selection = this.lastPickResult = nextSelection; this.spikes.update({ center: result.dataCoord }); selection.screenCoord = [ ((glplot.viewBox[2] - glplot.viewBox[0]) * (result.dataCoord[0] - glplot.dataBox[0]) / (glplot.dataBox[2] - glplot.dataBox[0]) + glplot.viewBox[0]) / glplot.pixelRatio, (this.canvas.height - (glplot.viewBox[3] - glplot.viewBox[1]) * (result.dataCoord[1] - glplot.dataBox[1]) / (glplot.dataBox[3] - glplot.dataBox[1]) - glplot.viewBox[1]) / glplot.pixelRatio ]; var hoverinfo = selection.hoverinfo; if(hoverinfo !== 'all') { var parts = hoverinfo.split('+'); if(parts.indexOf('x') === -1) selection.traceCoord[0] = undefined; if(parts.indexOf('y') === -1) selection.traceCoord[1] = undefined; if(parts.indexOf('text') === -1) selection.textLabel = undefined; if(parts.indexOf('name') === -1) selection.name = undefined; } Fx.loneHover({ x: selection.screenCoord[0], y: selection.screenCoord[1], xLabel: this.hoverFormatter('xaxis', selection.traceCoord[0]), yLabel: this.hoverFormatter('yaxis', selection.traceCoord[1]), text: selection.textLabel, name: selection.name, color: selection.color }, { container: this.svgContainer }); this.lastPickResult = { dataCoord: result.dataCoord }; } } else if(!result && this.lastPickResult) { this.spikes.update({}); this.lastPickResult = null; Fx.loneUnhover(this.svgContainer); } } glplot.draw(); }; proto.hoverFormatter = function(axisName, val) { if(val === undefined) return undefined; var axis = this[axisName]; return Axes.tickText(axis, axis.c2l(val), 'hover').text; }; },{"../../lib/html2unicode":348,"../../lib/show_no_webgl_msg":357,"../../plots/cartesian/axes":369,"../../plots/cartesian/graph_interact":374,"../../plots/plots":413,"./camera":395,"./convert":396,"gl-plot2d":122,"gl-select-box":152,"gl-spikes2d":178}],399:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = createCamera; var now = require('right-now'); var createView = require('3d-view'); var mouseChange = require('mouse-change'); var mouseWheel = require('mouse-wheel'); function createCamera(element, options) { element = element || document.body; options = options || {}; var limits = [ 0.01, Infinity ]; if('distanceLimits' in options) { limits[0] = options.distanceLimits[0]; limits[1] = options.distanceLimits[1]; } if('zoomMin' in options) { limits[0] = options.zoomMin; } if('zoomMax' in options) { limits[1] = options.zoomMax; } var view = createView({ center: options.center || [0, 0, 0], up: options.up || [0, 1, 0], eye: options.eye || [0, 0, 10], mode: options.mode || 'orbit', distanceLimits: limits }); var pmatrix = [0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0]; var distance = 0.0; var width = element.clientWidth; var height = element.clientHeight; var camera = { keyBindingMode: 'rotate', view: view, element: element, delay: options.delay || 16, rotateSpeed: options.rotateSpeed || 1, zoomSpeed: options.zoomSpeed || 1, translateSpeed: options.translateSpeed || 1, flipX: !!options.flipX, flipY: !!options.flipY, modes: view.modes, tick: function() { var t = now(); var delay = this.delay; var ctime = t - 2 * delay; view.idle(t-delay); view.recalcMatrix(ctime); view.flush(t - (100+delay * 2)); var allEqual = true; var matrix = view.computedMatrix; for(var i = 0; i < 16; ++i) { allEqual = allEqual && (pmatrix[i] === matrix[i]); pmatrix[i] = matrix[i]; } var sizeChanged = element.clientWidth === width && element.clientHeight === height; width = element.clientWidth; height = element.clientHeight; if(allEqual) return !sizeChanged; distance = Math.exp(view.computedRadius[0]); return true; }, lookAt: function(center, eye, up) { view.lookAt(view.lastT(), center, eye, up); }, rotate: function(pitch, yaw, roll) { view.rotate(view.lastT(), pitch, yaw, roll); }, pan: function(dx, dy, dz) { view.pan(view.lastT(), dx, dy, dz); }, translate: function(dx, dy, dz) { view.translate(view.lastT(), dx, dy, dz); } }; Object.defineProperties(camera, { matrix: { get: function() { return view.computedMatrix; }, set: function(mat) { view.setMatrix(view.lastT(), mat); return view.computedMatrix; }, enumerable: true }, mode: { get: function() { return view.getMode(); }, set: function(mode) { var curUp = view.computedUp.slice(); var curEye = view.computedEye.slice(); var curCenter = view.computedCenter.slice(); view.setMode(mode); if(mode === 'turntable') { //Hacky time warping stuff to generate smooth animation var t0 = now(); view._active.lookAt(t0, curEye, curCenter, curUp); view._active.lookAt(t0 + 500, curEye, curCenter, [0,0,1]); view._active.flush(t0); } return view.getMode(); }, enumerable: true }, center: { get: function() { return view.computedCenter; }, set: function(ncenter) { view.lookAt(view.lastT(), null, ncenter); return view.computedCenter; }, enumerable: true }, eye: { get: function() { return view.computedEye; }, set: function(neye) { view.lookAt(view.lastT(), neye); return view.computedEye; }, enumerable: true }, up: { get: function() { return view.computedUp; }, set: function(nup) { view.lookAt(view.lastT(), null, null, nup); return view.computedUp; }, enumerable: true }, distance: { get: function() { return distance; }, set: function(d) { view.setDistance(view.lastT(), d); return d; }, enumerable: true }, distanceLimits: { get: function() { return view.getDistanceLimits(limits); }, set: function(v) { view.setDistanceLimits(v); return v; }, enumerable: true } }); element.addEventListener('contextmenu', function(ev) { ev.preventDefault(); return false; }); var lastX = 0, lastY = 0; mouseChange(element, function(buttons, x, y, mods) { var rotate = camera.keyBindingMode === 'rotate'; var pan = camera.keyBindingMode === 'pan'; var zoom = camera.keyBindingMode === 'zoom'; var ctrl = !!mods.control; var alt = !!mods.alt; var shift = !!mods.shift; var left = !!(buttons&1); var right = !!(buttons&2); var middle = !!(buttons&4); var scale = 1.0 / element.clientHeight; var dx = scale * (x - lastX); var dy = scale * (y - lastY); var flipX = camera.flipX ? 1 : -1; var flipY = camera.flipY ? 1 : -1; var t = now(); var drot = Math.PI * camera.rotateSpeed; if((rotate && left && !ctrl && !alt && !shift) || (left && !ctrl && !alt && shift)) { //Rotate view.rotate(t, flipX * drot * dx, -flipY * drot * dy, 0); } if((pan && left && !ctrl && !alt && !shift) || right || (left && ctrl && !alt && !shift)) { //Pan view.pan(t, -camera.translateSpeed * dx * distance, camera.translateSpeed * dy * distance, 0); } if((zoom && left && !ctrl && !alt && !shift) || middle || (left && !ctrl && alt && !shift)) { //Zoom var kzoom = -camera.zoomSpeed * dy / window.innerHeight * (t - view.lastT()) * 100; view.pan(t, 0, 0, distance * (Math.exp(kzoom) - 1)); } lastX = x; lastY = y; return true; }); mouseWheel(element, function(dx, dy) { var flipX = camera.flipX ? 1 : -1; var flipY = camera.flipY ? 1 : -1; var t = now(); if(Math.abs(dx) > Math.abs(dy)) { view.rotate(t, 0, 0, -dx * flipX * Math.PI * camera.rotateSpeed / window.innerWidth); } else { var kzoom = -camera.zoomSpeed * flipY * dy / window.innerHeight * (t - view.lastT()) / 100.0; view.pan(t, 0, 0, distance * (Math.exp(kzoom) - 1)); } }, true); return camera; } },{"3d-view":38,"mouse-change":196,"mouse-wheel":200,"right-now":210}],400:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Scene = require('./scene'); var Plots = require('../plots'); var axesNames = ['xaxis', 'yaxis', 'zaxis']; exports.name = 'gl3d'; exports.attr = 'scene'; exports.idRoot = 'scene'; exports.idRegex = /^scene([2-9]|[1-9][0-9]+)?$/; exports.attrRegex = /^scene([2-9]|[1-9][0-9]+)?$/; exports.attributes = require('./layout/attributes'); exports.layoutAttributes = require('./layout/layout_attributes'); exports.supplyLayoutDefaults = require('./layout/defaults'); exports.plot = function plotGl3d(gd) { var fullLayout = gd._fullLayout, fullData = gd._fullData, sceneIds = Plots.getSubplotIds(fullLayout, 'gl3d'); fullLayout._paperdiv.style({ width: fullLayout.width + 'px', height: fullLayout.height + 'px' }); gd._context.setBackground(gd, fullLayout.paper_bgcolor); for(var i = 0; i < sceneIds.length; i++) { var sceneId = sceneIds[i], fullSceneData = Plots.getSubplotData(fullData, 'gl3d', sceneId), scene = fullLayout[sceneId]._scene; // ref. to corresp. Scene instance // If Scene is not instantiated, create one! if(scene === undefined) { scene = new Scene({ id: sceneId, graphDiv: gd, container: gd.querySelector('.gl-container'), staticPlot: gd._context.staticPlot, plotGlPixelRatio: gd._context.plotGlPixelRatio }, fullLayout ); fullLayout[sceneId]._scene = scene; // set ref to Scene instance } scene.plot(fullSceneData, fullLayout, gd.layout); // takes care of business } }; exports.clean = function(newFullData, newFullLayout, oldFullData, oldFullLayout) { var oldSceneKeys = Plots.getSubplotIds(oldFullLayout, 'gl3d'); for(var i = 0; i < oldSceneKeys.length; i++) { var oldSceneKey = oldSceneKeys[i]; if(!newFullLayout[oldSceneKey] && !!oldFullLayout[oldSceneKey]._scene) { oldFullLayout[oldSceneKey]._scene.destroy(); } } }; // clean scene ids, 'scene1' -> 'scene' exports.cleanId = function cleanId(id) { if(!id.match(/^scene[0-9]*$/)) return; var sceneNum = id.substr(5); if(sceneNum === '1') sceneNum = ''; return 'scene' + sceneNum; }; exports.setConvert = require('./set_convert'); exports.initAxes = function(gd) { var fullLayout = gd._fullLayout; var sceneIds = Plots.getSubplotIds(fullLayout, 'gl3d'); for(var i = 0; i < sceneIds.length; ++i) { var sceneId = sceneIds[i]; var sceneLayout = fullLayout[sceneId]; for(var j = 0; j < 3; ++j) { var axisName = axesNames[j]; var ax = sceneLayout[axisName]; ax._td = gd; } } }; },{"../plots":413,"./layout/attributes":401,"./layout/defaults":405,"./layout/layout_attributes":406,"./scene":410,"./set_convert":411}],401:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { scene: { valType: 'sceneid', dflt: 'scene', } }; },{}],402:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var axesAttrs = require('../../cartesian/layout_attributes'); var extendFlat = require('../../../lib/extend').extendFlat; module.exports = { showspikes: { valType: 'boolean', dflt: true, }, spikesides: { valType: 'boolean', dflt: true, }, spikethickness: { valType: 'number', min: 0, dflt: 2, }, spikecolor: { valType: 'color', dflt: 'rgb(0,0,0)', }, showbackground: { valType: 'boolean', dflt: false, }, backgroundcolor: { valType: 'color', dflt: 'rgba(204, 204, 204, 0.5)', }, showaxeslabels: { valType: 'boolean', dflt: true, }, title: axesAttrs.title, titlefont: axesAttrs.titlefont, type: axesAttrs.type, autorange: axesAttrs.autorange, rangemode: axesAttrs.rangemode, range: axesAttrs.range, fixedrange: axesAttrs.fixedrange, // ticks tickmode: axesAttrs.tickmode, nticks: axesAttrs.nticks, tick0: axesAttrs.tick0, dtick: axesAttrs.dtick, tickvals: axesAttrs.tickvals, ticktext: axesAttrs.ticktext, ticks: axesAttrs.ticks, mirror: axesAttrs.mirror, ticklen: axesAttrs.ticklen, tickwidth: axesAttrs.tickwidth, tickcolor: axesAttrs.tickcolor, showticklabels: axesAttrs.showticklabels, tickfont: axesAttrs.tickfont, tickangle: axesAttrs.tickangle, tickprefix: axesAttrs.tickprefix, showtickprefix: axesAttrs.showtickprefix, ticksuffix: axesAttrs.ticksuffix, showticksuffix: axesAttrs.showticksuffix, showexponent: axesAttrs.showexponent, exponentformat: axesAttrs.exponentformat, tickformat: axesAttrs.tickformat, hoverformat: axesAttrs.hoverformat, // lines and grids showline: axesAttrs.showline, linecolor: axesAttrs.linecolor, linewidth: axesAttrs.linewidth, showgrid: axesAttrs.showgrid, gridcolor: extendFlat({}, axesAttrs.gridcolor, // shouldn't this be on-par with 2D? {dflt: 'rgb(204, 204, 204)'}), gridwidth: axesAttrs.gridwidth, zeroline: axesAttrs.zeroline, zerolinecolor: axesAttrs.zerolinecolor, zerolinewidth: axesAttrs.zerolinewidth }; },{"../../../lib/extend":345,"../../cartesian/layout_attributes":376}],403:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../../lib'); var layoutAttributes = require('./axis_attributes'); var handleAxisDefaults = require('../../cartesian/axis_defaults'); var axesNames = ['xaxis', 'yaxis', 'zaxis']; var noop = function() {}; module.exports = function supplyLayoutDefaults(layoutIn, layoutOut, options) { var containerIn, containerOut; function coerce(attr, dflt) { return Lib.coerce(containerIn, containerOut, layoutAttributes, attr, dflt); } for(var j = 0; j < axesNames.length; j++) { var axName = axesNames[j]; containerIn = layoutIn[axName] || {}; containerOut = { _id: axName[0] + options.scene, _name: axName }; layoutOut[axName] = containerOut = handleAxisDefaults( containerIn, containerOut, coerce, { font: options.font, letter: axName[0], data: options.data, showGrid: true }); coerce('gridcolor'); coerce('title', axName[0]); // shouldn't this be on-par with 2D? containerOut.setScale = noop; if(coerce('showspikes')) { coerce('spikesides'); coerce('spikethickness'); coerce('spikecolor'); } if(coerce('showbackground')) coerce('backgroundcolor'); coerce('showaxeslabels'); } }; },{"../../../lib":349,"../../cartesian/axis_defaults":370,"./axis_attributes":402}],404:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var arrtools = require('arraytools'); var convertHTML = require('../../../lib/html2unicode'); var str2RgbaArray = require('../../../lib/str2rgbarray'); var arrayCopy1D = arrtools.copy1D; var AXES_NAMES = ['xaxis', 'yaxis', 'zaxis']; function AxesOptions() { this.bounds = [ [-10, -10, -10], [10, 10, 10] ]; this.ticks = [ [], [], [] ]; this.tickEnable = [ true, true, true ]; this.tickFont = [ 'sans-serif', 'sans-serif', 'sans-serif' ]; this.tickSize = [ 12, 12, 12 ]; this.tickAngle = [ 0, 0, 0 ]; this.tickColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ]; this.tickPad = [ 18, 18, 18 ]; this.labels = [ 'x', 'y', 'z' ]; this.labelEnable = [ true, true, true ]; this.labelFont = ['Open Sans','Open Sans','Open Sans']; this.labelSize = [ 20, 20, 20 ]; this.labelAngle = [ 0, 0, 0 ]; this.labelColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ]; this.labelPad = [ 30, 30, 30 ]; this.lineEnable = [ true, true, true ]; this.lineMirror = [ false, false, false ]; this.lineWidth = [ 1, 1, 1 ]; this.lineColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ]; this.lineTickEnable = [ true, true, true ]; this.lineTickMirror = [ false, false, false ]; this.lineTickLength = [ 10, 10, 10 ]; this.lineTickWidth = [ 1, 1, 1 ]; this.lineTickColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ]; this.gridEnable = [ true, true, true ]; this.gridWidth = [ 1, 1, 1 ]; this.gridColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ]; this.zeroEnable = [ true, true, true ]; this.zeroLineColor = [ [0,0,0,1], [0,0,0,1], [0,0,0,1] ]; this.zeroLineWidth = [ 2, 2, 2 ]; this.backgroundEnable = [ true, true, true ]; this.backgroundColor = [ [0.8, 0.8, 0.8, 0.5], [0.8, 0.8, 0.8, 0.5], [0.8, 0.8, 0.8, 0.5] ]; // some default values are stored for applying model transforms this._defaultTickPad = arrayCopy1D(this.tickPad); this._defaultLabelPad = arrayCopy1D(this.labelPad); this._defaultLineTickLength = arrayCopy1D(this.lineTickLength); } var proto = AxesOptions.prototype; proto.merge = function(sceneLayout) { var opts = this; for(var i = 0; i < 3; ++i) { var axes = sceneLayout[AXES_NAMES[i]]; /////// Axes labels // opts.labels[i] = convertHTML(axes.title); if('titlefont' in axes) { if(axes.titlefont.color) opts.labelColor[i] = str2RgbaArray(axes.titlefont.color); if(axes.titlefont.family) opts.labelFont[i] = axes.titlefont.family; if(axes.titlefont.size) opts.labelSize[i] = axes.titlefont.size; } /////// LINES //////// if('showline' in axes) opts.lineEnable[i] = axes.showline; if('linecolor' in axes) opts.lineColor[i] = str2RgbaArray(axes.linecolor); if('linewidth' in axes) opts.lineWidth[i] = axes.linewidth; if('showgrid' in axes) opts.gridEnable[i] = axes.showgrid; if('gridcolor' in axes) opts.gridColor[i] = str2RgbaArray(axes.gridcolor); if('gridwidth' in axes) opts.gridWidth[i] = axes.gridwidth; // Remove zeroline if axis type is log // otherwise the zeroline is incorrectly drawn at 1 on log axes if(axes.type === 'log') opts.zeroEnable[i] = false; else if('zeroline' in axes) opts.zeroEnable[i] = axes.zeroline; if('zerolinecolor' in axes) opts.zeroLineColor[i] = str2RgbaArray(axes.zerolinecolor); if('zerolinewidth' in axes) opts.zeroLineWidth[i] = axes.zerolinewidth; //////// TICKS ///////// /// tick lines if('ticks' in axes && !!axes.ticks) opts.lineTickEnable[i] = true; else opts.lineTickEnable[i] = false; if('ticklen' in axes) { opts.lineTickLength[i] = opts._defaultLineTickLength[i] = axes.ticklen; } if('tickcolor' in axes) opts.lineTickColor[i] = str2RgbaArray(axes.tickcolor); if('tickwidth' in axes) opts.lineTickWidth[i] = axes.tickwidth; if('tickangle' in axes) { opts.tickAngle[i] = (axes.tickangle === 'auto') ? 0 : Math.PI * -axes.tickangle / 180; } // tick labels if('showticklabels' in axes) opts.tickEnable[i] = axes.showticklabels; if('tickfont' in axes) { if(axes.tickfont.color) opts.tickColor[i] = str2RgbaArray(axes.tickfont.color); if(axes.tickfont.family) opts.tickFont[i] = axes.tickfont.family; if(axes.tickfont.size) opts.tickSize[i] = axes.tickfont.size; } if('mirror' in axes) { if(['ticks','all','allticks'].indexOf(axes.mirror) !== -1) { opts.lineTickMirror[i] = true; opts.lineMirror[i] = true; } else if(axes.mirror === true) { opts.lineTickMirror[i] = false; opts.lineMirror[i] = true; } else { opts.lineTickMirror[i] = false; opts.lineMirror[i] = false; } } else opts.lineMirror[i] = false; // grid background if('showbackground' in axes && axes.showbackground !== false) { opts.backgroundEnable[i] = true; opts.backgroundColor[i] = str2RgbaArray(axes.backgroundcolor); } else opts.backgroundEnable[i] = false; } }; function createAxesOptions(plotlyOptions) { var result = new AxesOptions(); result.merge(plotlyOptions); return result; } module.exports = createAxesOptions; },{"../../../lib/html2unicode":348,"../../../lib/str2rgbarray":359,"arraytools":48}],405:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../../lib'); var Plots = require('../../plots'); var layoutAttributes = require('./layout_attributes'); var supplyGl3dAxisLayoutDefaults = require('./axis_defaults'); module.exports = function supplyLayoutDefaults(layoutIn, layoutOut, fullData) { if(!layoutOut._hasGL3D) return; var scenes = Plots.findSubplotIds(fullData, 'gl3d'), scenesLength = scenes.length; var sceneLayoutIn, sceneLayoutOut; function coerce(attr, dflt) { return Lib.coerce(sceneLayoutIn, sceneLayoutOut, layoutAttributes, attr, dflt); } // some layout-wide attribute are used in all scenes // if 3D is the only visible plot type function getDfltFromLayout(attr) { var isOnlyGL3D = !( layoutOut._hasCartesian || layoutOut._hasGeo || layoutOut._hasGL2D || layoutOut._hasPie ); var isValid = layoutAttributes[attr].values.indexOf(layoutIn[attr]) !== -1; if(isOnlyGL3D && isValid) return layoutIn[attr]; } for(var i = 0; i < scenesLength; i++) { var scene = scenes[i]; /* * Scene numbering proceeds as follows * scene * scene2 * scene3 * * and d.scene will be undefined or some number or number string * * Also write back a blank scene object to user layout so that some * attributes like aspectratio can be written back dynamically. */ // gl3d traces get a layout scene for free! if(layoutIn[scene]) sceneLayoutIn = layoutIn[scene]; else layoutIn[scene] = sceneLayoutIn = {}; sceneLayoutOut = layoutOut[scene] || {}; coerce('bgcolor'); var cameraKeys = Object.keys(layoutAttributes.camera); for(var j = 0; j < cameraKeys.length; j++) { coerce('camera.' + cameraKeys[j] + '.x'); coerce('camera.' + cameraKeys[j] + '.y'); coerce('camera.' + cameraKeys[j] + '.z'); } coerce('domain.x', [i / scenesLength, (i+1) / scenesLength]); coerce('domain.y'); /* * coerce to positive number (min 0) but also do not accept 0 (>0 not >=0) * note that 0's go false with the !! call */ var hasAspect = !!coerce('aspectratio.x') && !!coerce('aspectratio.y') && !!coerce('aspectratio.z'); var defaultAspectMode = hasAspect ? 'manual' : 'auto'; var aspectMode = coerce('aspectmode', defaultAspectMode); /* * We need aspectratio object in all the Layouts as it is dynamically set * in the calculation steps, ie, we cant set the correct data now, it happens later. * We must also account for the case the user sends bad ratio data with 'manual' set * for the mode. In this case we must force change it here as the default coerce * misses it above. */ if(!hasAspect) { sceneLayoutIn.aspectratio = sceneLayoutOut.aspectratio = {x: 1, y: 1, z: 1}; if(aspectMode === 'manual') sceneLayoutOut.aspectmode = 'auto'; } /* * scene arrangements need to be implemented: For now just splice * along the horizontal direction. ie. * x:[0,1] -> x:[0,0.5], x:[0.5,1] -> * x:[0, 0.333] x:[0.333,0.666] x:[0.666, 1] */ supplyGl3dAxisLayoutDefaults(sceneLayoutIn, sceneLayoutOut, { font: layoutOut.font, scene: scene, data: fullData }); coerce('dragmode', getDfltFromLayout('dragmode')); coerce('hovermode', getDfltFromLayout('hovermode')); layoutOut[scene] = sceneLayoutOut; } }; },{"../../../lib":349,"../../plots":413,"./axis_defaults":403,"./layout_attributes":406}],406:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var gl3dAxisAttrs = require('./axis_attributes'); var extendFlat = require('../../../lib/extend').extendFlat; function makeVector(x, y, z) { return { x: { valType: 'number', dflt: x }, y: { valType: 'number', dflt: y }, z: { valType: 'number', dflt: z } }; } module.exports = { bgcolor: { valType: 'color', dflt: 'rgba(0,0,0,0)' }, camera: { up: extendFlat(makeVector(0, 0, 1), { }), center: extendFlat(makeVector(0, 0, 0), { }), eye: extendFlat(makeVector(1.25, 1.25, 1.25), { }) }, domain: { x: { valType: 'info_array', items: [ {valType: 'number', min: 0, max: 1}, {valType: 'number', min: 0, max: 1} ], dflt: [0, 1], }, y: { valType: 'info_array', items: [ {valType: 'number', min: 0, max: 1}, {valType: 'number', min: 0, max: 1} ], dflt: [0, 1], } }, aspectmode: { valType: 'enumerated', values: ['auto', 'cube', 'data', 'manual'], dflt: 'auto', }, aspectratio: { // must be positive (0's are coerced to 1) x: { valType: 'number', min: 0 }, y: { valType: 'number', min: 0 }, z: { valType: 'number', min: 0 }, }, xaxis: gl3dAxisAttrs, yaxis: gl3dAxisAttrs, zaxis: gl3dAxisAttrs, dragmode: { valType: 'enumerated', values: ['orbit', 'turntable', 'zoom', 'pan'], dflt: 'turntable', }, hovermode: { valType: 'enumerated', values: ['closest', false], dflt: 'closest', }, _deprecated: { cameraposition: { valType: 'info_array', } } }; },{"../../../lib/extend":345,"./axis_attributes":402}],407:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var str2RGBArray = require('../../../lib/str2rgbarray'); var AXES_NAMES = ['xaxis', 'yaxis', 'zaxis']; function SpikeOptions() { this.enabled = [true, true, true]; this.colors = [[0,0,0,1], [0,0,0,1], [0,0,0,1]]; this.drawSides = [true, true, true]; this.lineWidth = [1,1,1]; } var proto = SpikeOptions.prototype; proto.merge = function(sceneLayout) { for(var i = 0; i < 3; ++i) { var axes = sceneLayout[AXES_NAMES[i]]; this.enabled[i] = axes.showspikes; this.colors[i] = str2RGBArray(axes.spikecolor); this.drawSides[i] = axes.spikesides; this.lineWidth[i] = axes.spikethickness; } }; function createSpikeOptions(layout) { var result = new SpikeOptions(); result.merge(layout); return result; } module.exports = createSpikeOptions; },{"../../../lib/str2rgbarray":359}],408:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ /*eslint block-scoped-var: 0*/ /*eslint no-redeclare: 0*/ 'use strict'; module.exports = computeTickMarks; var Plotly = require('../../../plotly'); var convertHTML = require('../../../lib/html2unicode'); var AXES_NAMES = ['xaxis', 'yaxis', 'zaxis']; var centerPoint = [0,0,0]; function contourLevelsFromTicks(ticks) { var result = new Array(3); for(var i=0; i<3; ++i) { var tlevel = ticks[i]; var clevel = new Array(tlevel.length); for(var j=0; j dataBounds[1][j]) { dataScale[j] = 1.0; } else { if(dataBounds[1][j] === dataBounds[0][j]) { dataScale[j] = 1.0; } else { dataScale[j] = 1.0/(dataBounds[1][j] - dataBounds[0][j]); } } } //Save scale this.dataScale = dataScale; //Update traces for(var i = 0; i < sceneData.length; ++i) { data = sceneData[i]; if(data.visible!==true) { continue; } trace = this.traces[data.uid]; if(trace) { trace.update(data); } else { var traceModule = Plots.getModule(data.type); trace = traceModule.plot(this, data); this.traces[data.uid] = trace; } trace.name = data.name; } //Remove empty traces var traceIds = Object.keys(this.traces); trace_id_loop: for(i = 0; i sceneBounds[1][i]) { sceneBounds[0][i] = -1; sceneBounds[1][i] = 1; } else { var d = sceneBounds[1][i] - sceneBounds[0][i]; sceneBounds[0][i] -= d/32.0; sceneBounds[1][i] += d/32.0; } } else { var range = fullSceneLayout[axisProperties[i]].range; sceneBounds[0][i] = range[0]; sceneBounds[1][i] = range[1]; } if(sceneBounds[0][i] === sceneBounds[1][i]) { sceneBounds[0][i] -= 1; sceneBounds[1][i] += 1; } axisDataRange[i] = sceneBounds[1][i] - sceneBounds[0][i]; //Update plot bounds this.glplot.bounds[0][i] = sceneBounds[0][i] * dataScale[i]; this.glplot.bounds[1][i] = sceneBounds[1][i] * dataScale[i]; } var axesScaleRatio = [1, 1, 1]; //Compute axis scale per category for(var i=0; i<3; ++i) { var axis = fullSceneLayout[axisProperties[i]]; var axisType = axis.type; var axisRatio = axisTypeRatios[axisType]; axesScaleRatio[i] = Math.pow(axisRatio.acc, 1.0/axisRatio.count) / dataScale[i]; } /* * Dynamically set the aspect ratio depending on the users aspect settings */ var axisAutoScaleFactor = 4; var aspectRatio; if(fullSceneLayout.aspectmode === 'auto') { if(Math.max.apply(null, axesScaleRatio)/Math.min.apply(null, axesScaleRatio) <= axisAutoScaleFactor) { /* * USE DATA MODE WHEN AXIS RANGE DIMENSIONS ARE RELATIVELY EQUAL */ aspectRatio = axesScaleRatio; } else { /* * USE EQUAL MODE WHEN AXIS RANGE DIMENSIONS ARE HIGHLY UNEQUAL */ aspectRatio = [1, 1, 1]; } } else if(fullSceneLayout.aspectmode === 'cube') { aspectRatio = [1, 1, 1]; } else if(fullSceneLayout.aspectmode === 'data') { aspectRatio = axesScaleRatio; } else if(fullSceneLayout.aspectmode === 'manual') { var userRatio = fullSceneLayout.aspectratio; aspectRatio = [userRatio.x, userRatio.y, userRatio.z]; } else { throw new Error('scene.js aspectRatio was not one of the enumerated types'); } /* * Write aspect Ratio back to user data and fullLayout so that it is modifies as user * manipulates the aspectmode settings and the fullLayout is up-to-date. */ fullSceneLayout.aspectratio.x = sceneLayout.aspectratio.x = aspectRatio[0]; fullSceneLayout.aspectratio.y = sceneLayout.aspectratio.y = aspectRatio[1]; fullSceneLayout.aspectratio.z = sceneLayout.aspectratio.z = aspectRatio[2]; /* * Finally assign the computed aspecratio to the glplot module. This will have an effect * on the next render cycle. */ this.glplot.aspect = aspectRatio; //Update frame position for multi plots var domain = fullSceneLayout.domain || null, size = fullLayout._size || null; if(domain && size) { var containerStyle = this.container.style; containerStyle.position = 'absolute'; containerStyle.left = (size.l + domain.x[0] * size.w) + 'px'; containerStyle.top = (size.t + (1 - domain.y[1]) * size.h) + 'px'; containerStyle.width = (size.w * (domain.x[1] - domain.x[0])) + 'px'; containerStyle.height = (size.h * (domain.y[1] - domain.y[0])) + 'px'; } }; proto.destroy = function() { this.glplot.dispose(); this.container.parentNode.removeChild(this.container); //Remove reference to glplot this.glplot = null; }; // for reset camera button in mode bar proto.setCameraToDefault = function setCameraToDefault() { // as in Gl3d.layoutAttributes this.glplot.camera.lookAt( [1.25, 1.25, 1.25], [0, 0, 0], [0, 0, 1] ); }; // get camera position in plotly coords from 'orbit-camera' coords proto.getCamera = function getCamera() { this.glplot.camera.view.recalcMatrix(this.camera.view.lastT()); var up = this.glplot.camera.up; var center = this.glplot.camera.center; var eye = this.glplot.camera.eye; return { up: {x: up[0], y: up[1], z: up[2]}, center: {x: center[0], y: center[1], z: center[2]}, eye: {x: eye[0], y: eye[1], z: eye[2]} }; }; // set camera position with a set of plotly coords proto.setCamera = function setCamera(cameraData) { var up = cameraData.up; var center = cameraData.center; var eye = cameraData.eye; this.glplot.camera.lookAt( [eye.x, eye.y, eye.z], [center.x, center.y, center.z], [up.x, up.y, up.z] ); }; // save camera to user layout (i.e. gd.layout) proto.saveCamera = function saveCamera(layout) { var cameraData = this.getCamera(), cameraNestedProp = Lib.nestedProperty(layout, this.id + '.camera'), cameraDataLastSave = cameraNestedProp.get(), hasChanged = false; function same(x, y, i, j) { var vectors = ['up', 'center', 'eye'], components = ['x', 'y', 'z']; return x[vectors[i]][components[j]] === y[vectors[i]][components[j]]; } if(cameraDataLastSave === undefined) hasChanged = true; else { for(var i = 0; i < 3; i++) { for(var j = 0; j < 3; j++) { if(!same(cameraData, cameraDataLastSave, i, j)) { hasChanged = true; break; } } } } if(hasChanged) cameraNestedProp.set(cameraData); return hasChanged; }; proto.updateFx = function(dragmode, hovermode) { var camera = this.camera; if(camera) { // rotate and orbital are synonymous if(dragmode === 'orbit') { camera.mode = 'orbit'; camera.keyBindingMode = 'rotate'; } else if(dragmode === 'turntable') { camera.up = [0, 0, 1]; camera.mode = 'turntable'; camera.keyBindingMode = 'rotate'; } else { // none rotation modes [pan or zoom] camera.keyBindingMode = dragmode; } } // to put dragmode and hovermode on the same grounds from relayout this.fullSceneLayout.hovermode = hovermode; }; proto.toImage = function(format) { if(!format) format = 'png'; if(this.staticMode) this.container.appendChild(STATIC_CANVAS); //Force redraw this.glplot.redraw(); //Grab context and yank out pixels var gl = this.glplot.gl; var w = gl.drawingBufferWidth; var h = gl.drawingBufferHeight; gl.bindFramebuffer(gl.FRAMEBUFFER, null); var pixels = new Uint8Array(w * h * 4); gl.readPixels(0, 0, w, h, gl.RGBA, gl.UNSIGNED_BYTE, pixels); //Flip pixels for(var j=0,k=h-1; j= (fullLayout.width - 20)) { // Align the text at the left attrs['text-anchor'] = 'start'; attrs.x = 5; } else { // Align the text at the right attrs['text-anchor'] = 'end'; attrs.x = fullLayout._paper.attr('width') - 7; } linkContainer.attr(attrs); var toolspan = linkContainer.select('.js-link-to-tool'), spacespan = linkContainer.select('.js-link-spacer'), sourcespan = linkContainer.select('.js-sourcelinks'); if(gd._context.showSources) gd._context.showSources(gd); // 'view in plotly' link for embedded plots if(gd._context.showLink) positionPlayWithData(gd, toolspan); // separator if we have both sources and tool link spacespan.text((toolspan.text() && sourcespan.text()) ? ' - ' : ''); }; // note that now this function is only adding the brand in // iframes and 3rd-party apps function positionPlayWithData(gd, container) { container.text(''); var link = container.append('a') .attr({ 'xlink:xlink:href': '#', 'class': 'link--impt link--embedview', 'font-weight': 'bold' }) .text(gd._context.linkText + ' ' + String.fromCharCode(187)); if(gd._context.sendData) { link.on('click', function() { plots.sendDataToCloud(gd); }); } else { var path = window.location.pathname.split('/'); var query = window.location.search; link.attr({ 'xlink:xlink:show': 'new', 'xlink:xlink:href': '/' + path[2].split('.')[0] + '/' + path[1] + query }); } } plots.sendDataToCloud = function(gd) { gd.emit('plotly_beforeexport'); var baseUrl = (window.PLOTLYENV && window.PLOTLYENV.BASE_URL) || 'https://plot.ly'; var hiddenformDiv = d3.select(gd) .append('div') .attr('id', 'hiddenform') .style('display', 'none'); var hiddenform = hiddenformDiv .append('form') .attr({ action: baseUrl + '/external', method: 'post', target: '_blank' }); var hiddenformInput = hiddenform .append('input') .attr({ type: 'text', name: 'data' }); hiddenformInput.node().value = plots.graphJson(gd, false, 'keepdata'); hiddenform.node().submit(); hiddenformDiv.remove(); gd.emit('plotly_afterexport'); return false; }; plots.supplyDefaults = function(gd) { // fill in default values: // gd.data, gd.layout: // are precisely what the user specified // gd._fullData, gd._fullLayout: // are complete descriptions of how to draw the plot var oldFullLayout = gd._fullLayout || {}, newFullLayout = gd._fullLayout = {}, newLayout = gd.layout || {}, oldFullData = gd._fullData || [], newFullData = gd._fullData = [], newData = gd.data || [], modules = gd._modules = []; var i, trace, fullTrace, _module, axList, ax; // first fill in what we can of layout without looking at data // because fullData needs a few things from layout plots.supplyLayoutGlobalDefaults(newLayout, newFullLayout); // keep track of how many traces are inputted newFullLayout._dataLength = newData.length; // then do the data for(i = 0; i < newData.length; i++) { trace = newData[i]; fullTrace = plots.supplyDataDefaults(trace, i, newFullLayout); newFullData.push(fullTrace); // detect plot type if(plots.traceIs(fullTrace, 'cartesian')) newFullLayout._hasCartesian = true; else if(plots.traceIs(fullTrace, 'gl3d')) newFullLayout._hasGL3D = true; else if(plots.traceIs(fullTrace, 'geo')) newFullLayout._hasGeo = true; else if(plots.traceIs(fullTrace, 'pie')) newFullLayout._hasPie = true; else if(plots.traceIs(fullTrace, 'gl2d')) newFullLayout._hasGL2D = true; else if('r' in fullTrace) newFullLayout._hasPolar = true; _module = fullTrace._module; if(_module && modules.indexOf(_module)===-1) modules.push(_module); } // special cases that introduce interactions between traces for(i = 0; i < modules.length; i++) { _module = modules[i]; if(_module.cleanData) _module.cleanData(newFullData); } if(oldFullData.length === newData.length) { for(i = 0; i < newFullData.length; i++) { relinkPrivateKeys(newFullData[i], oldFullData[i]); } } // finally, fill in the pieces of layout that may need to look at data plots.supplyLayoutModuleDefaults(newLayout, newFullLayout, newFullData); // clean subplots and other artifacts from previous plot calls cleanPlot(newFullData, newFullLayout, oldFullData, oldFullLayout); /* * Relink functions and underscore attributes to promote consistency between * plots. */ relinkPrivateKeys(newFullLayout, oldFullLayout); plots.doAutoMargin(gd); // can't quite figure out how to get rid of this... each axis needs // a reference back to the DOM object for just a few purposes axList = Plotly.Axes.list(gd); for(i = 0; i < axList.length; i++) { ax = axList[i]; ax._td = gd; ax.setScale(); } // update object references in calcdata if((gd.calcdata || []).length === newFullData.length) { for(i = 0; i < newFullData.length; i++) { trace = newFullData[i]; (gd.calcdata[i][0] || {}).trace = trace; } } }; function cleanPlot(newFullData, newFullLayout, oldFullData, oldFullLayout) { var i, j; var plotTypes = Object.keys(subplotsRegistry); for(i = 0; i < plotTypes.length; i++) { var _module = subplotsRegistry[plotTypes[i]]; if(_module.clean) { _module.clean(newFullData, newFullLayout, oldFullData, oldFullLayout); } } var hasPaper = !!oldFullLayout._paper; var hasInfoLayer = !!oldFullLayout._infolayer; oldLoop: for(i = 0; i < oldFullData.length; i++) { var oldTrace = oldFullData[i], oldUid = oldTrace.uid; for(j = 0; j < newFullData.length; j++) { var newTrace = newFullData[j]; if(oldUid === newTrace.uid) continue oldLoop; } // clean old heatmap and contour traces if(hasPaper) { oldFullLayout._paper.selectAll( '.hm' + oldUid + ',.contour' + oldUid + ',#clip' + oldUid ).remove(); } // clean old colorbars if(hasInfoLayer) { oldFullLayout._infolayer.selectAll('.cb' + oldUid).remove(); } } } /** * Relink private _keys and keys with a function value from one layout * (usually cached) to the new fullLayout. * relink means copying if object is pass-by-value and adding a reference * if object is pass-by-ref. This prevents deepCopying massive structures like * a webgl context. */ function relinkPrivateKeys(toLayout, fromLayout) { var keys = Object.keys(fromLayout); var j; for(var i = 0; i < keys.length; ++i) { var k = keys[i]; if(k.charAt(0)==='_' || typeof fromLayout[k]==='function') { // if it already exists at this point, it's something // that we recreate each time around, so ignore it if(k in toLayout) continue; toLayout[k] = fromLayout[k]; } else if(Array.isArray(fromLayout[k]) && Array.isArray(toLayout[k]) && fromLayout[k].length && Lib.isPlainObject(fromLayout[k][0])) { if(fromLayout[k].length !== toLayout[k].length) { // this should be handled elsewhere, it causes // ambiguity if we try to deal with it here. throw new Error('relinkPrivateKeys needs equal ' + 'length arrays'); } for(j = 0; j < fromLayout[k].length; j++) { relinkPrivateKeys(toLayout[k][j], fromLayout[k][j]); } } else if(Lib.isPlainObject(fromLayout[k]) && Lib.isPlainObject(toLayout[k])) { // recurse into objects, but only if they still exist relinkPrivateKeys(toLayout[k], fromLayout[k]); if(!Object.keys(toLayout[k]).length) delete toLayout[k]; } } } plots.supplyDataDefaults = function(traceIn, i, layout) { var traceOut = {}, defaultColor = Plotly.Color.defaults[i % Plotly.Color.defaults.length]; function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, plots.attributes, attr, dflt); } function coerceSubplotAttr(subplotType, subplotAttr) { if(!plots.traceIs(traceOut, subplotType)) return; return Lib.coerce(traceIn, traceOut, plots.subplotsRegistry[subplotType].attributes, subplotAttr); } // module-independent attributes traceOut.index = i; var visible = coerce('visible'), scene, _module; coerce('type'); coerce('uid'); // this is necessary otherwise we lose references to scene objects when // the traces of a scene are invisible. Also we handle visible/unvisible // differently for 3D cases. coerceSubplotAttr('gl3d', 'scene'); coerceSubplotAttr('geo', 'geo'); // module-specific attributes --- note: we need to send a trace into // the 3D modules to have it removed from the webgl context. if(visible || scene) { _module = plots.getModule(traceOut); traceOut._module = _module; } // gets overwritten in pie and geo if(visible) coerce('hoverinfo', (layout._dataLength === 1) ? 'x+y+z+text' : undefined); if(_module && visible) _module.supplyDefaults(traceIn, traceOut, defaultColor, layout); if(visible) { coerce('name', 'trace ' + i); if(!plots.traceIs(traceOut, 'noOpacity')) coerce('opacity'); coerceSubplotAttr('cartesian', 'xaxis'); coerceSubplotAttr('cartesian', 'yaxis'); coerceSubplotAttr('gl2d', 'xaxis'); coerceSubplotAttr('gl2d', 'yaxis'); if(plots.traceIs(traceOut, 'showLegend')) { coerce('showlegend'); coerce('legendgroup'); } } // NOTE: I didn't include fit info at all... for now I think it can stay // just in gd.data, as this info isn't involved in creating plots at all, // only in pulling back up the fit popover // reference back to the input object for convenience traceOut._input = traceIn; return traceOut; }; plots.supplyLayoutGlobalDefaults = function(layoutIn, layoutOut) { function coerce(attr, dflt) { return Lib.coerce(layoutIn, layoutOut, plots.layoutAttributes, attr, dflt); } var globalFont = Lib.coerceFont(coerce, 'font'); coerce('title'); Lib.coerceFont(coerce, 'titlefont', { family: globalFont.family, size: Math.round(globalFont.size * 1.4), color: globalFont.color }); var autosize = coerce('autosize', (layoutIn.width && layoutIn.height) ? false : 'initial'); coerce('width'); coerce('height'); coerce('margin.l'); coerce('margin.r'); coerce('margin.t'); coerce('margin.b'); coerce('margin.pad'); coerce('margin.autoexpand'); // called in plotAutoSize otherwise if(autosize!=='initial') plots.sanitizeMargins(layoutOut); coerce('paper_bgcolor'); coerce('separators'); coerce('hidesources'); coerce('smith'); coerce('_hasCartesian'); coerce('_hasGL3D'); coerce('_hasGeo'); coerce('_hasPie'); coerce('_hasGL2D'); }; plots.supplyLayoutModuleDefaults = function(layoutIn, layoutOut, fullData) { var i, _module; // TODO incorporate into subplotRegistry Plotly.Axes.supplyLayoutDefaults(layoutIn, layoutOut, fullData); // plot module layout defaults var plotTypes = Object.keys(subplotsRegistry); for(i = 0; i < plotTypes.length; i++) { _module = subplotsRegistry[plotTypes[i]]; // e.g. gl2d does not have a layout-defaults step if(_module.supplyLayoutDefaults) { _module.supplyLayoutDefaults(layoutIn, layoutOut, fullData); } } // trace module layout defaults var traceTypes = Object.keys(modules); for(i = 0; i < traceTypes.length; i++) { _module = modules[allTypes[i]]._module; if(_module.supplyLayoutDefaults) { _module.supplyLayoutDefaults(layoutIn, layoutOut, fullData); } } // TODO register these // Legend must come after traces (e.g. it depends on 'barmode') var moduleLayoutDefaults = ['Fx', 'Annotations', 'Shapes', 'Legend']; for(i = 0; i < moduleLayoutDefaults.length; i++) { _module = moduleLayoutDefaults[i]; if(Plotly[_module]) { Plotly[_module].supplyLayoutDefaults(layoutIn, layoutOut, fullData); } } }; plots.purge = function(gd) { // remove all plotly attributes from a div so it can be replotted fresh // TODO: these really need to be encapsulated into a much smaller set... // note: we DO NOT remove _context because it doesn't change when we insert // a new plot, and may have been set outside of our scope. // clean up the gl and geo containers // TODO unify subplot creation/update with d3.selection.order // and/or subplot ids var fullLayout = gd._fullLayout || {}; if(fullLayout._glcontainer !== undefined) fullLayout._glcontainer.remove(); if(fullLayout._geocontainer !== undefined) fullLayout._geocontainer.remove(); // remove modebar if(fullLayout._modeBar) fullLayout._modeBar.destroy(); // data and layout delete gd.data; delete gd.layout; delete gd._fullData; delete gd._fullLayout; delete gd.calcdata; delete gd.framework; delete gd.empty; delete gd.fid; delete gd.undoqueue; // action queue delete gd.undonum; delete gd.autoplay; // are we doing an action that doesn't go in undo queue? delete gd.changed; // these get recreated on Plotly.plot anyway, but just to be safe // (and to have a record of them...) delete gd._modules; delete gd._tester; delete gd._testref; delete gd._promises; delete gd._redrawTimer; delete gd._replotting; delete gd.firstscatter; delete gd.hmlumcount; delete gd.hmpixcount; delete gd.numboxes; delete gd._hoverTimer; delete gd._lastHoverTime; // remove all event listeners if(gd.removeAllListeners) gd.removeAllListeners(); }; plots.style = function(gd) { var modulesWithErrorBars = gd._modules.concat(Plotly.ErrorBars); for(var i = 0; i < modulesWithErrorBars.length; i++) { var _module = modulesWithErrorBars[i]; if(_module.style) _module.style(gd); } }; plots.sanitizeMargins = function(fullLayout) { // polar doesn't do margins... if(!fullLayout || !fullLayout.margin) return; var width = fullLayout.width, height = fullLayout.height, margin = fullLayout.margin, plotWidth = width - (margin.l + margin.r), plotHeight = height - (margin.t + margin.b), correction; // if margin.l + margin.r = 0 then plotWidth > 0 // as width >= 10 by supplyDefaults // similarly for margin.t + margin.b if(plotWidth < 0) { correction = (width - 1) / (margin.l + margin.r); margin.l = Math.floor(correction * margin.l); margin.r = Math.floor(correction * margin.r); } if(plotHeight < 0) { correction = (height - 1) / (margin.t + margin.b); margin.t = Math.floor(correction * margin.t); margin.b = Math.floor(correction * margin.b); } }; // called by legend and colorbar routines to see if we need to // expand the margins to show them // o is {x,l,r,y,t,b} where x and y are plot fractions, // the rest are pixels in each direction // or leave o out to delete this entry (like if it's hidden) plots.autoMargin = function(gd,id,o) { var fullLayout = gd._fullLayout; if(!fullLayout._pushmargin) fullLayout._pushmargin = {}; if(fullLayout.margin.autoexpand!==false) { if(!o) delete fullLayout._pushmargin[id]; else { var pad = o.pad||12; // if the item is too big, just give it enough automargin to // make sure you can still grab it and bring it back if(o.l+o.r > fullLayout.width*0.5) o.l = o.r = 0; if(o.b+o.t > fullLayout.height*0.5) o.b = o.t = 0; fullLayout._pushmargin[id] = { l: {val: o.x, size: o.l+pad}, r: {val: o.x, size: o.r+pad}, b: {val: o.y, size: o.b+pad}, t: {val: o.y, size: o.t+pad} }; } if(!gd._replotting) plots.doAutoMargin(gd); } }; plots.doAutoMargin = function(gd) { var fullLayout = gd._fullLayout; if(!fullLayout._size) fullLayout._size = {}; if(!fullLayout._pushmargin) fullLayout._pushmargin = {}; var gs = fullLayout._size, oldmargins = JSON.stringify(gs); // adjust margins for outside legends and colorbars // fullLayout.margin is the requested margin, // fullLayout._size has margins and plotsize after adjustment var ml = Math.max(fullLayout.margin.l||0,0), mr = Math.max(fullLayout.margin.r||0,0), mt = Math.max(fullLayout.margin.t||0,0), mb = Math.max(fullLayout.margin.b||0,0), pm = fullLayout._pushmargin; if(fullLayout.margin.autoexpand!==false) { // fill in the requested margins pm.base = { l: {val: 0, size: ml}, r: {val: 1, size: mr}, t: {val: 1, size: mt}, b: {val: 0, size: mb} }; // now cycle through all the combinations of l and r // (and t and b) to find the required margins Object.keys(pm).forEach(function(k1) { var pushleft = pm[k1].l||{}, pushbottom = pm[k1].b||{}, fl = pushleft.val, pl = pushleft.size, fb = pushbottom.val, pb = pushbottom.size; Object.keys(pm).forEach(function(k2) { if(isNumeric(pl) && pm[k2].r) { var fr = pm[k2].r.val, pr = pm[k2].r.size; if(fr>fl) { var newl = (pl*fr + (pr-fullLayout.width)*fl) / (fr-fl), newr = (pr*(1-fl) + (pl-fullLayout.width)*(1-fr)) / (fr-fl); if(newl>=0 && newr>=0 && newl+newr>ml+mr) { ml = newl; mr = newr; } } } if(isNumeric(pb) && pm[k2].t) { var ft = pm[k2].t.val, pt = pm[k2].t.size; if(ft>fb) { var newb = (pb*ft + (pt-fullLayout.height)*fb) / (ft-fb), newt = (pt*(1-fb) + (pb-fullLayout.height)*(1-ft)) / (ft-fb); if(newb>=0 && newt>=0 && newb+newt>mb+mt) { mb = newb; mt = newt; } } } }); }); } gs.l = Math.round(ml); gs.r = Math.round(mr); gs.t = Math.round(mt); gs.b = Math.round(mb); gs.p = Math.round(fullLayout.margin.pad); gs.w = Math.round(fullLayout.width)-gs.l-gs.r; gs.h = Math.round(fullLayout.height)-gs.t-gs.b; // if things changed and we're not already redrawing, trigger a redraw if(!gd._replotting && oldmargins!=='{}' && oldmargins!==JSON.stringify(fullLayout._size)) { return Plotly.plot(gd); } }; /** * JSONify the graph data and layout * * This function needs to recurse because some src can be inside * sub-objects. * * It also strips out functions and private (starts with _) elements. * Therefore, we can add temporary things to data and layout that don't * get saved. * * @param gd The graphDiv * @param {Boolean} dataonly If true, don't return layout. * @param {'keepref'|'keepdata'|'keepall'} [mode='keepref'] Filter what's kept * keepref: remove data for which there's a src present * eg if there's xsrc present (and xsrc is well-formed, * ie has : and some chars before it), strip out x * keepdata: remove all src tags, don't remove the data itself * keepall: keep data and src * @param {String} output If you specify 'object', the result will not be stringified * @param {Boolean} useDefaults If truthy, use _fullLayout and _fullData * @returns {Object|String} */ plots.graphJson = function(gd, dataonly, mode, output, useDefaults) { // if the defaults aren't supplied yet, we need to do that... if((useDefaults && dataonly && !gd._fullData) || (useDefaults && !dataonly && !gd._fullLayout)) { plots.supplyDefaults(gd); } var data = (useDefaults) ? gd._fullData : gd.data, layout = (useDefaults) ? gd._fullLayout : gd.layout; function stripObj(d) { if(typeof d === 'function') { return null; } if(Lib.isPlainObject(d)) { var o={}, v, src; for(v in d) { // remove private elements and functions // _ is for private, [ is a mistake ie [object Object] if(typeof d[v]==='function' || ['_','['].indexOf(v.charAt(0))!==-1) { continue; } // look for src/data matches and remove the appropriate one if(mode==='keepdata') { // keepdata: remove all ...src tags if(v.substr(v.length-3)==='src') { continue; } } else if(mode==='keepstream') { // keep sourced data if it's being streamed. // similar to keepref, but if the 'stream' object exists // in a trace, we will keep the data array. src = d[v+'src']; if(typeof src==='string' && src.indexOf(':')>0) { if(!Lib.isPlainObject(d.stream)) { continue; } } } else if(mode!=='keepall') { // keepref: remove sourced data but only // if the source tag is well-formed src = d[v+'src']; if(typeof src==='string' && src.indexOf(':')>0) { continue; } } // OK, we're including this... recurse into it o[v] = stripObj(d[v]); } return o; } if(Array.isArray(d)) { return d.map(stripObj); } // convert native dates to date strings... // mostly for external users exporting to plotly if(d && d.getTime) { return Lib.ms2DateTime(d); } return d; } var obj = { data: (data || []).map(function(v) { var d = stripObj(v); // fit has some little arrays in it that don't contain data, // just fit params and meta if(dataonly) { delete d.fit; } return d; }) }; if(!dataonly) { obj.layout = stripObj(layout); } if(gd.framework && gd.framework.isPolar) obj = gd.framework.getConfig(); return (output==='object') ? obj : JSON.stringify(obj); }; },{"../lib":349,"../plotly":366,"./attributes":367,"./font_attributes":383,"./layout_attributes":412,"d3":70,"fast-isnumeric":74}],414:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var scatterAttrs = require('../../traces/scatter/attributes'); var scatterMarkerAttrs = scatterAttrs.marker; module.exports = { r: scatterAttrs.r, t: scatterAttrs.t, marker: { color: scatterMarkerAttrs.color, size: scatterMarkerAttrs.size, symbol: scatterMarkerAttrs.symbol, opacity: scatterMarkerAttrs.opacity } }; },{"../../traces/scatter/attributes":502}],415:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var axesAttrs = require('../cartesian/layout_attributes'); var extendFlat = require('../../lib/extend').extendFlat; var domainAttr = extendFlat({}, axesAttrs.domain, { }); function mergeAttrs(axisName, nonCommonAttrs) { var commonAttrs = { showline: { valType: 'boolean', }, showticklabels: { valType: 'boolean', }, tickorientation: { valType: 'enumerated', values: ['horizontal', 'vertical'], }, ticklen: { valType: 'number', min: 0, }, tickcolor: { valType: 'color', }, ticksuffix: { valType: 'string', }, endpadding: { valType: 'number', }, visible: { valType: 'boolean', } }; return extendFlat({}, nonCommonAttrs, commonAttrs); } module.exports = { radialaxis: mergeAttrs('radial', { range: { valType: 'info_array', items: [ { valType: 'number' }, { valType: 'number' } ], }, domain: domainAttr, orientation: { valType: 'number', } }), angularaxis: mergeAttrs('angular', { range: { valType: 'info_array', items: [ { valType: 'number', dflt: 0 }, { valType: 'number', dflt: 360 } ], }, domain: domainAttr }), // attributes that appear at layout root layout: { direction: { valType: 'enumerated', values: ['clockwise', 'counterclockwise'], }, orientation: { valType: 'angle', } } }; },{"../../lib/extend":345,"../cartesian/layout_attributes":376}],416:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ var Plotly = require('../../plotly'); var d3 = require('d3'); var µ = module.exports = { version: '0.2.2', manager: require('./micropolar_manager') }; var extendDeepAll = Plotly.Lib.extendDeepAll; µ.Axis = function module() { var config = { data: [], layout: {} }, inputConfig = {}, liveConfig = {}; var svg, container, dispatch = d3.dispatch('hover'), radialScale, angularScale; var exports = {}; function render(_container) { container = _container || container; var data = config.data; var axisConfig = config.layout; if (typeof container == 'string' || container.nodeName) container = d3.select(container); container.datum(data).each(function(_data, _index) { var dataOriginal = _data.slice(); liveConfig = { data: µ.util.cloneJson(dataOriginal), layout: µ.util.cloneJson(axisConfig) }; var colorIndex = 0; dataOriginal.forEach(function(d, i) { if (!d.color) { d.color = axisConfig.defaultColorRange[colorIndex]; colorIndex = (colorIndex + 1) % axisConfig.defaultColorRange.length; } if (!d.strokeColor) { d.strokeColor = d.geometry === 'LinePlot' ? d.color : d3.rgb(d.color).darker().toString(); } liveConfig.data[i].color = d.color; liveConfig.data[i].strokeColor = d.strokeColor; liveConfig.data[i].strokeDash = d.strokeDash; liveConfig.data[i].strokeSize = d.strokeSize; }); var data = dataOriginal.filter(function(d, i) { var visible = d.visible; return typeof visible === 'undefined' || visible === true; }); var isStacked = false; var dataWithGroupId = data.map(function(d, i) { isStacked = isStacked || typeof d.groupId !== 'undefined'; return d; }); if (isStacked) { var grouped = d3.nest().key(function(d, i) { return typeof d.groupId != 'undefined' ? d.groupId : 'unstacked'; }).entries(dataWithGroupId); var dataYStack = []; var stacked = grouped.map(function(d, i) { if (d.key === 'unstacked') return d.values; else { var prevArray = d.values[0].r.map(function(d, i) { return 0; }); d.values.forEach(function(d, i, a) { d.yStack = [ prevArray ]; dataYStack.push(prevArray); prevArray = µ.util.sumArrays(d.r, prevArray); }); return d.values; } }); data = d3.merge(stacked); } data.forEach(function(d, i) { d.t = Array.isArray(d.t[0]) ? d.t : [ d.t ]; d.r = Array.isArray(d.r[0]) ? d.r : [ d.r ]; }); var radius = Math.min(axisConfig.width - axisConfig.margin.left - axisConfig.margin.right, axisConfig.height - axisConfig.margin.top - axisConfig.margin.bottom) / 2; radius = Math.max(10, radius); var chartCenter = [ axisConfig.margin.left + radius, axisConfig.margin.top + radius ]; var extent; if (isStacked) { var highestStackedValue = d3.max(µ.util.sumArrays(µ.util.arrayLast(data).r[0], µ.util.arrayLast(dataYStack))); extent = [ 0, highestStackedValue ]; } else extent = d3.extent(µ.util.flattenArray(data.map(function(d, i) { return d.r; }))); if (axisConfig.radialAxis.domain != µ.DATAEXTENT) extent[0] = 0; radialScale = d3.scale.linear().domain(axisConfig.radialAxis.domain != µ.DATAEXTENT && axisConfig.radialAxis.domain ? axisConfig.radialAxis.domain : extent).range([ 0, radius ]); liveConfig.layout.radialAxis.domain = radialScale.domain(); var angularDataMerged = µ.util.flattenArray(data.map(function(d, i) { return d.t; })); var isOrdinal = typeof angularDataMerged[0] === 'string'; var ticks; if (isOrdinal) { angularDataMerged = µ.util.deduplicate(angularDataMerged); ticks = angularDataMerged.slice(); angularDataMerged = d3.range(angularDataMerged.length); data = data.map(function(d, i) { var result = d; d.t = [ angularDataMerged ]; if (isStacked) result.yStack = d.yStack; return result; }); } var hasOnlyLineOrDotPlot = data.filter(function(d, i) { return d.geometry === 'LinePlot' || d.geometry === 'DotPlot'; }).length === data.length; var needsEndSpacing = axisConfig.needsEndSpacing === null ? isOrdinal || !hasOnlyLineOrDotPlot : axisConfig.needsEndSpacing; var useProvidedDomain = axisConfig.angularAxis.domain && axisConfig.angularAxis.domain != µ.DATAEXTENT && !isOrdinal && axisConfig.angularAxis.domain[0] >= 0; var angularDomain = useProvidedDomain ? axisConfig.angularAxis.domain : d3.extent(angularDataMerged); var angularDomainStep = Math.abs(angularDataMerged[1] - angularDataMerged[0]); if (hasOnlyLineOrDotPlot && !isOrdinal) angularDomainStep = 0; var angularDomainWithPadding = angularDomain.slice(); if (needsEndSpacing && isOrdinal) angularDomainWithPadding[1] += angularDomainStep; var tickCount = axisConfig.angularAxis.ticksCount || 4; if (tickCount > 8) tickCount = tickCount / (tickCount / 8) + tickCount % 8; if (axisConfig.angularAxis.ticksStep) { tickCount = (angularDomainWithPadding[1] - angularDomainWithPadding[0]) / tickCount; } var angularTicksStep = axisConfig.angularAxis.ticksStep || (angularDomainWithPadding[1] - angularDomainWithPadding[0]) / (tickCount * (axisConfig.minorTicks + 1)); if (ticks) angularTicksStep = Math.max(Math.round(angularTicksStep), 1); if (!angularDomainWithPadding[2]) angularDomainWithPadding[2] = angularTicksStep; var angularAxisRange = d3.range.apply(this, angularDomainWithPadding); angularAxisRange = angularAxisRange.map(function(d, i) { return parseFloat(d.toPrecision(12)); }); angularScale = d3.scale.linear().domain(angularDomainWithPadding.slice(0, 2)).range(axisConfig.direction === 'clockwise' ? [ 0, 360 ] : [ 360, 0 ]); liveConfig.layout.angularAxis.domain = angularScale.domain(); liveConfig.layout.angularAxis.endPadding = needsEndSpacing ? angularDomainStep : 0; svg = d3.select(this).select('svg.chart-root'); if (typeof svg === 'undefined' || svg.empty()) { var skeleton = "' + '' + '' + '' + '' + '' + '' + '' + '' + '' + '' + '' + '' + '' + '' + '"; var doc = new DOMParser().parseFromString(skeleton, 'application/xml'); var newSvg = this.appendChild(this.ownerDocument.importNode(doc.documentElement, true)); svg = d3.select(newSvg); } svg.select('.guides-group').style({ 'pointer-events': 'none' }); svg.select('.angular.axis-group').style({ 'pointer-events': 'none' }); svg.select('.radial.axis-group').style({ 'pointer-events': 'none' }); var chartGroup = svg.select('.chart-group'); var lineStyle = { fill: 'none', stroke: axisConfig.tickColor }; var fontStyle = { 'font-size': axisConfig.font.size, 'font-family': axisConfig.font.family, fill: axisConfig.font.color, 'text-shadow': [ '-1px 0px', '1px -1px', '-1px 1px', '1px 1px' ].map(function(d, i) { return ' ' + d + ' 0 ' + axisConfig.font.outlineColor; }).join(',') }; var legendContainer; if (axisConfig.showLegend) { legendContainer = svg.select('.legend-group').attr({ transform: 'translate(' + [ radius, axisConfig.margin.top ] + ')' }).style({ display: 'block' }); var elements = data.map(function(d, i) { var datumClone = µ.util.cloneJson(d); datumClone.symbol = d.geometry === 'DotPlot' ? d.dotType || 'circle' : d.geometry != 'LinePlot' ? 'square' : 'line'; datumClone.visibleInLegend = typeof d.visibleInLegend === 'undefined' || d.visibleInLegend; datumClone.color = d.geometry === 'LinePlot' ? d.strokeColor : d.color; return datumClone; }); µ.Legend().config({ data: data.map(function(d, i) { return d.name || 'Element' + i; }), legendConfig: extendDeepAll({}, µ.Legend.defaultConfig().legendConfig, { container: legendContainer, elements: elements, reverseOrder: axisConfig.legend.reverseOrder } ) })(); var legendBBox = legendContainer.node().getBBox(); radius = Math.min(axisConfig.width - legendBBox.width - axisConfig.margin.left - axisConfig.margin.right, axisConfig.height - axisConfig.margin.top - axisConfig.margin.bottom) / 2; radius = Math.max(10, radius); chartCenter = [ axisConfig.margin.left + radius, axisConfig.margin.top + radius ]; radialScale.range([ 0, radius ]); liveConfig.layout.radialAxis.domain = radialScale.domain(); legendContainer.attr('transform', 'translate(' + [ chartCenter[0] + radius, chartCenter[1] - radius ] + ')'); } else { legendContainer = svg.select('.legend-group').style({ display: 'none' }); } svg.attr({ width: axisConfig.width, height: axisConfig.height }).style({ opacity: axisConfig.opacity }); chartGroup.attr('transform', 'translate(' + chartCenter + ')').style({ cursor: 'crosshair' }); var centeringOffset = [ (axisConfig.width - (axisConfig.margin.left + axisConfig.margin.right + radius * 2 + (legendBBox ? legendBBox.width : 0))) / 2, (axisConfig.height - (axisConfig.margin.top + axisConfig.margin.bottom + radius * 2)) / 2 ]; centeringOffset[0] = Math.max(0, centeringOffset[0]); centeringOffset[1] = Math.max(0, centeringOffset[1]); svg.select('.outer-group').attr('transform', 'translate(' + centeringOffset + ')'); if (axisConfig.title) { var title = svg.select('g.title-group text').style(fontStyle).text(axisConfig.title); var titleBBox = title.node().getBBox(); title.attr({ x: chartCenter[0] - titleBBox.width / 2, y: chartCenter[1] - radius - 20 }); } var radialAxis = svg.select('.radial.axis-group'); if (axisConfig.radialAxis.gridLinesVisible) { var gridCircles = radialAxis.selectAll('circle.grid-circle').data(radialScale.ticks(5)); gridCircles.enter().append('circle').attr({ 'class': 'grid-circle' }).style(lineStyle); gridCircles.attr('r', radialScale); gridCircles.exit().remove(); } radialAxis.select('circle.outside-circle').attr({ r: radius }).style(lineStyle); var backgroundCircle = svg.select('circle.background-circle').attr({ r: radius }).style({ fill: axisConfig.backgroundColor, stroke: axisConfig.stroke }); function currentAngle(d, i) { return angularScale(d) % 360 + axisConfig.orientation; } if (axisConfig.radialAxis.visible) { var axis = d3.svg.axis().scale(radialScale).ticks(5).tickSize(5); radialAxis.call(axis).attr({ transform: 'rotate(' + axisConfig.radialAxis.orientation + ')' }); radialAxis.selectAll('.domain').style(lineStyle); radialAxis.selectAll('g>text').text(function(d, i) { return this.textContent + axisConfig.radialAxis.ticksSuffix; }).style(fontStyle).style({ 'text-anchor': 'start' }).attr({ x: 0, y: 0, dx: 0, dy: 0, transform: function(d, i) { if (axisConfig.radialAxis.tickOrientation === 'horizontal') { return 'rotate(' + -axisConfig.radialAxis.orientation + ') translate(' + [ 0, fontStyle['font-size'] ] + ')'; } else return 'translate(' + [ 0, fontStyle['font-size'] ] + ')'; } }); radialAxis.selectAll('g>line').style({ stroke: 'black' }); } var angularAxis = svg.select('.angular.axis-group').selectAll('g.angular-tick').data(angularAxisRange); var angularAxisEnter = angularAxis.enter().append('g').classed('angular-tick', true); angularAxis.attr({ transform: function(d, i) { return 'rotate(' + currentAngle(d, i) + ')'; } }).style({ display: axisConfig.angularAxis.visible ? 'block' : 'none' }); angularAxis.exit().remove(); angularAxisEnter.append('line').classed('grid-line', true).classed('major', function(d, i) { return i % (axisConfig.minorTicks + 1) == 0; }).classed('minor', function(d, i) { return !(i % (axisConfig.minorTicks + 1) == 0); }).style(lineStyle); angularAxisEnter.selectAll('.minor').style({ stroke: axisConfig.minorTickColor }); angularAxis.select('line.grid-line').attr({ x1: axisConfig.tickLength ? radius - axisConfig.tickLength : 0, x2: radius }).style({ display: axisConfig.angularAxis.gridLinesVisible ? 'block' : 'none' }); angularAxisEnter.append('text').classed('axis-text', true).style(fontStyle); var ticksText = angularAxis.select('text.axis-text').attr({ x: radius + axisConfig.labelOffset, dy: '.35em', transform: function(d, i) { var angle = currentAngle(d, i); var rad = radius + axisConfig.labelOffset; var orient = axisConfig.angularAxis.tickOrientation; if (orient == 'horizontal') return 'rotate(' + -angle + ' ' + rad + ' 0)'; else if (orient == 'radial') return angle < 270 && angle > 90 ? 'rotate(180 ' + rad + ' 0)' : null; else return 'rotate(' + (angle <= 180 && angle > 0 ? -90 : 90) + ' ' + rad + ' 0)'; } }).style({ 'text-anchor': 'middle', display: axisConfig.angularAxis.labelsVisible ? 'block' : 'none' }).text(function(d, i) { if (i % (axisConfig.minorTicks + 1) != 0) return ''; if (ticks) { return ticks[d] + axisConfig.angularAxis.ticksSuffix; } else return d + axisConfig.angularAxis.ticksSuffix; }).style(fontStyle); if (axisConfig.angularAxis.rewriteTicks) ticksText.text(function(d, i) { if (i % (axisConfig.minorTicks + 1) != 0) return ''; return axisConfig.angularAxis.rewriteTicks(this.textContent, i); }); var rightmostTickEndX = d3.max(chartGroup.selectAll('.angular-tick text')[0].map(function(d, i) { return d.getCTM().e + d.getBBox().width; })); legendContainer.attr({ transform: 'translate(' + [ radius + rightmostTickEndX, axisConfig.margin.top ] + ')' }); var hasGeometry = svg.select('g.geometry-group').selectAll('g').size() > 0; var geometryContainer = svg.select('g.geometry-group').selectAll('g.geometry').data(data); geometryContainer.enter().append('g').attr({ 'class': function(d, i) { return 'geometry geometry' + i; } }); geometryContainer.exit().remove(); if (data[0] || hasGeometry) { var geometryConfigs = []; data.forEach(function(d, i) { var geometryConfig = {}; geometryConfig.radialScale = radialScale; geometryConfig.angularScale = angularScale; geometryConfig.container = geometryContainer.filter(function(dB, iB) { return iB == i; }); geometryConfig.geometry = d.geometry; geometryConfig.orientation = axisConfig.orientation; geometryConfig.direction = axisConfig.direction; geometryConfig.index = i; geometryConfigs.push({ data: d, geometryConfig: geometryConfig }); }); var geometryConfigsGrouped = d3.nest().key(function(d, i) { return typeof d.data.groupId != 'undefined' || 'unstacked'; }).entries(geometryConfigs); var geometryConfigsGrouped2 = []; geometryConfigsGrouped.forEach(function(d, i) { if (d.key === 'unstacked') geometryConfigsGrouped2 = geometryConfigsGrouped2.concat(d.values.map(function(d, i) { return [ d ]; })); else geometryConfigsGrouped2.push(d.values); }); geometryConfigsGrouped2.forEach(function(d, i) { var geometry; if (Array.isArray(d)) geometry = d[0].geometryConfig.geometry; else geometry = d.geometryConfig.geometry; var finalGeometryConfig = d.map(function(dB, iB) { return extendDeepAll(µ[geometry].defaultConfig(), dB); }); µ[geometry]().config(finalGeometryConfig)(); }); } var guides = svg.select('.guides-group'); var tooltipContainer = svg.select('.tooltips-group'); var angularTooltip = µ.tooltipPanel().config({ container: tooltipContainer, fontSize: 8 })(); var radialTooltip = µ.tooltipPanel().config({ container: tooltipContainer, fontSize: 8 })(); var geometryTooltip = µ.tooltipPanel().config({ container: tooltipContainer, hasTick: true })(); var angularValue, radialValue; if (!isOrdinal) { var angularGuideLine = guides.select('line').attr({ x1: 0, y1: 0, y2: 0 }).style({ stroke: 'grey', 'pointer-events': 'none' }); chartGroup.on('mousemove.angular-guide', function(d, i) { var mouseAngle = µ.util.getMousePos(backgroundCircle).angle; angularGuideLine.attr({ x2: -radius, transform: 'rotate(' + mouseAngle + ')' }).style({ opacity: .5 }); var angleWithOriginOffset = (mouseAngle + 180 + 360 - axisConfig.orientation) % 360; angularValue = angularScale.invert(angleWithOriginOffset); var pos = µ.util.convertToCartesian(radius + 12, mouseAngle + 180); angularTooltip.text(µ.util.round(angularValue)).move([ pos[0] + chartCenter[0], pos[1] + chartCenter[1] ]); }).on('mouseout.angular-guide', function(d, i) { guides.select('line').style({ opacity: 0 }); }); } var angularGuideCircle = guides.select('circle').style({ stroke: 'grey', fill: 'none' }); chartGroup.on('mousemove.radial-guide', function(d, i) { var r = µ.util.getMousePos(backgroundCircle).radius; angularGuideCircle.attr({ r: r }).style({ opacity: .5 }); radialValue = radialScale.invert(µ.util.getMousePos(backgroundCircle).radius); var pos = µ.util.convertToCartesian(r, axisConfig.radialAxis.orientation); radialTooltip.text(µ.util.round(radialValue)).move([ pos[0] + chartCenter[0], pos[1] + chartCenter[1] ]); }).on('mouseout.radial-guide', function(d, i) { angularGuideCircle.style({ opacity: 0 }); geometryTooltip.hide(); angularTooltip.hide(); radialTooltip.hide(); }); svg.selectAll('.geometry-group .mark').on('mouseover.tooltip', function(d, i) { var el = d3.select(this); var color = el.style('fill'); var newColor = 'black'; var opacity = el.style('opacity') || 1; el.attr({ 'data-opacity': opacity }); if (color != 'none') { el.attr({ 'data-fill': color }); newColor = d3.hsl(color).darker().toString(); el.style({ fill: newColor, opacity: 1 }); var textData = { t: µ.util.round(d[0]), r: µ.util.round(d[1]) }; if (isOrdinal) textData.t = ticks[d[0]]; var text = 't: ' + textData.t + ', r: ' + textData.r; var bbox = this.getBoundingClientRect(); var svgBBox = svg.node().getBoundingClientRect(); var pos = [ bbox.left + bbox.width / 2 - centeringOffset[0] - svgBBox.left, bbox.top + bbox.height / 2 - centeringOffset[1] - svgBBox.top ]; geometryTooltip.config({ color: newColor }).text(text); geometryTooltip.move(pos); } else { color = el.style('stroke'); el.attr({ 'data-stroke': color }); newColor = d3.hsl(color).darker().toString(); el.style({ stroke: newColor, opacity: 1 }); } }).on('mousemove.tooltip', function(d, i) { if (d3.event.which != 0) return false; if (d3.select(this).attr('data-fill')) geometryTooltip.show(); }).on('mouseout.tooltip', function(d, i) { geometryTooltip.hide(); var el = d3.select(this); var fillColor = el.attr('data-fill'); if (fillColor) el.style({ fill: fillColor, opacity: el.attr('data-opacity') }); else el.style({ stroke: el.attr('data-stroke'), opacity: el.attr('data-opacity') }); }); }); return exports; } exports.render = function(_container) { render(_container); return this; }; exports.config = function(_x) { if (!arguments.length) return config; var xClone = µ.util.cloneJson(_x); xClone.data.forEach(function(d, i) { if (!config.data[i]) config.data[i] = {}; extendDeepAll(config.data[i], µ.Axis.defaultConfig().data[0]); extendDeepAll(config.data[i], d); }); extendDeepAll(config.layout, µ.Axis.defaultConfig().layout); extendDeepAll(config.layout, xClone.layout); return this; }; exports.getLiveConfig = function() { return liveConfig; }; exports.getinputConfig = function() { return inputConfig; }; exports.radialScale = function(_x) { return radialScale; }; exports.angularScale = function(_x) { return angularScale; }; exports.svg = function() { return svg; }; d3.rebind(exports, dispatch, 'on'); return exports; }; µ.Axis.defaultConfig = function(d, i) { var config = { data: [ { t: [ 1, 2, 3, 4 ], r: [ 10, 11, 12, 13 ], name: 'Line1', geometry: 'LinePlot', color: null, strokeDash: 'solid', strokeColor: null, strokeSize: '1', visibleInLegend: true, opacity: 1 } ], layout: { defaultColorRange: d3.scale.category10().range(), title: null, height: 450, width: 500, margin: { top: 40, right: 40, bottom: 40, left: 40 }, font: { size: 12, color: 'gray', outlineColor: 'white', family: 'Tahoma, sans-serif' }, direction: 'clockwise', orientation: 0, labelOffset: 10, radialAxis: { domain: null, orientation: -45, ticksSuffix: '', visible: true, gridLinesVisible: true, tickOrientation: 'horizontal', rewriteTicks: null }, angularAxis: { domain: [ 0, 360 ], ticksSuffix: '', visible: true, gridLinesVisible: true, labelsVisible: true, tickOrientation: 'horizontal', rewriteTicks: null, ticksCount: null, ticksStep: null }, minorTicks: 0, tickLength: null, tickColor: 'silver', minorTickColor: '#eee', backgroundColor: 'none', needsEndSpacing: null, showLegend: true, legend: { reverseOrder: false }, opacity: 1 } }; return config; }; µ.util = {}; µ.DATAEXTENT = 'dataExtent'; µ.AREA = 'AreaChart'; µ.LINE = 'LinePlot'; µ.DOT = 'DotPlot'; µ.BAR = 'BarChart'; µ.util._override = function(_objA, _objB) { for (var x in _objA) if (x in _objB) _objB[x] = _objA[x]; }; µ.util._extend = function(_objA, _objB) { for (var x in _objA) _objB[x] = _objA[x]; }; µ.util._rndSnd = function() { return Math.random() * 2 - 1 + (Math.random() * 2 - 1) + (Math.random() * 2 - 1); }; µ.util.dataFromEquation2 = function(_equation, _step) { var step = _step || 6; var data = d3.range(0, 360 + step, step).map(function(deg, index) { var theta = deg * Math.PI / 180; var radius = _equation(theta); return [ deg, radius ]; }); return data; }; µ.util.dataFromEquation = function(_equation, _step, _name) { var step = _step || 6; var t = [], r = []; d3.range(0, 360 + step, step).forEach(function(deg, index) { var theta = deg * Math.PI / 180; var radius = _equation(theta); t.push(deg); r.push(radius); }); var result = { t: t, r: r }; if (_name) result.name = _name; return result; }; µ.util.ensureArray = function(_val, _count) { if (typeof _val === 'undefined') return null; var arr = [].concat(_val); return d3.range(_count).map(function(d, i) { return arr[i] || arr[0]; }); }; µ.util.fillArrays = function(_obj, _valueNames, _count) { _valueNames.forEach(function(d, i) { _obj[d] = µ.util.ensureArray(_obj[d], _count); }); return _obj; }; µ.util.cloneJson = function(json) { return JSON.parse(JSON.stringify(json)); }; µ.util.validateKeys = function(obj, keys) { if (typeof keys === 'string') keys = keys.split('.'); var next = keys.shift(); return obj[next] && (!keys.length || objHasKeys(obj[next], keys)); }; µ.util.sumArrays = function(a, b) { return d3.zip(a, b).map(function(d, i) { return d3.sum(d); }); }; µ.util.arrayLast = function(a) { return a[a.length - 1]; }; µ.util.arrayEqual = function(a, b) { var i = Math.max(a.length, b.length, 1); while (i-- >= 0 && a[i] === b[i]) ; return i === -2; }; µ.util.flattenArray = function(arr) { var r = []; while (!µ.util.arrayEqual(r, arr)) { r = arr; arr = [].concat.apply([], arr); } return arr; }; µ.util.deduplicate = function(arr) { return arr.filter(function(v, i, a) { return a.indexOf(v) == i; }); }; µ.util.convertToCartesian = function(radius, theta) { var thetaRadians = theta * Math.PI / 180; var x = radius * Math.cos(thetaRadians); var y = radius * Math.sin(thetaRadians); return [ x, y ]; }; µ.util.round = function(_value, _digits) { var digits = _digits || 2; var mult = Math.pow(10, digits); return Math.round(_value * mult) / mult; }; µ.util.getMousePos = function(_referenceElement) { var mousePos = d3.mouse(_referenceElement.node()); var mouseX = mousePos[0]; var mouseY = mousePos[1]; var mouse = {}; mouse.x = mouseX; mouse.y = mouseY; mouse.pos = mousePos; mouse.angle = (Math.atan2(mouseY, mouseX) + Math.PI) * 180 / Math.PI; mouse.radius = Math.sqrt(mouseX * mouseX + mouseY * mouseY); return mouse; }; µ.util.duplicatesCount = function(arr) { var uniques = {}, val; var dups = {}; for (var i = 0, len = arr.length; i < len; i++) { val = arr[i]; if (val in uniques) { uniques[val]++; dups[val] = uniques[val]; } else { uniques[val] = 1; } } return dups; }; µ.util.duplicates = function(arr) { return Object.keys(µ.util.duplicatesCount(arr)); }; µ.util.translator = function(obj, sourceBranch, targetBranch, reverse) { if (reverse) { var targetBranchCopy = targetBranch.slice(); targetBranch = sourceBranch; sourceBranch = targetBranchCopy; } var value = sourceBranch.reduce(function(previousValue, currentValue) { if (typeof previousValue != 'undefined') return previousValue[currentValue]; }, obj); if (typeof value === 'undefined') return; sourceBranch.reduce(function(previousValue, currentValue, index) { if (typeof previousValue == 'undefined') return; if (index === sourceBranch.length - 1) delete previousValue[currentValue]; return previousValue[currentValue]; }, obj); targetBranch.reduce(function(previousValue, currentValue, index) { if (typeof previousValue[currentValue] === 'undefined') previousValue[currentValue] = {}; if (index === targetBranch.length - 1) previousValue[currentValue] = value; return previousValue[currentValue]; }, obj); }; µ.PolyChart = function module() { var config = [ µ.PolyChart.defaultConfig() ]; var dispatch = d3.dispatch('hover'); var dashArray = { solid: 'none', dash: [ 5, 2 ], dot: [ 2, 5 ] }; var colorScale; function exports() { var geometryConfig = config[0].geometryConfig; var container = geometryConfig.container; if (typeof container == 'string') container = d3.select(container); container.datum(config).each(function(_config, _index) { var isStack = !!_config[0].data.yStack; var data = _config.map(function(d, i) { if (isStack) return d3.zip(d.data.t[0], d.data.r[0], d.data.yStack[0]); else return d3.zip(d.data.t[0], d.data.r[0]); }); var angularScale = geometryConfig.angularScale; var domainMin = geometryConfig.radialScale.domain()[0]; var generator = {}; generator.bar = function(d, i, pI) { var dataConfig = _config[pI].data; var h = geometryConfig.radialScale(d[1]) - geometryConfig.radialScale(0); var stackTop = geometryConfig.radialScale(d[2] || 0); var w = dataConfig.barWidth; d3.select(this).attr({ 'class': 'mark bar', d: 'M' + [ [ h + stackTop, -w / 2 ], [ h + stackTop, w / 2 ], [ stackTop, w / 2 ], [ stackTop, -w / 2 ] ].join('L') + 'Z', transform: function(d, i) { return 'rotate(' + (geometryConfig.orientation + angularScale(d[0])) + ')'; } }); }; generator.dot = function(d, i, pI) { var stackedData = d[2] ? [ d[0], d[1] + d[2] ] : d; var symbol = d3.svg.symbol().size(_config[pI].data.dotSize).type(_config[pI].data.dotType)(d, i); d3.select(this).attr({ 'class': 'mark dot', d: symbol, transform: function(d, i) { var coord = convertToCartesian(getPolarCoordinates(stackedData)); return 'translate(' + [ coord.x, coord.y ] + ')'; } }); }; var line = d3.svg.line.radial().interpolate(_config[0].data.lineInterpolation).radius(function(d) { return geometryConfig.radialScale(d[1]); }).angle(function(d) { return geometryConfig.angularScale(d[0]) * Math.PI / 180; }); generator.line = function(d, i, pI) { var lineData = d[2] ? data[pI].map(function(d, i) { return [ d[0], d[1] + d[2] ]; }) : data[pI]; d3.select(this).each(generator['dot']).style({ opacity: function(dB, iB) { return +_config[pI].data.dotVisible; }, fill: markStyle.stroke(d, i, pI) }).attr({ 'class': 'mark dot' }); if (i > 0) return; var lineSelection = d3.select(this.parentNode).selectAll('path.line').data([ 0 ]); lineSelection.enter().insert('path'); lineSelection.attr({ 'class': 'line', d: line(lineData), transform: function(dB, iB) { return 'rotate(' + (geometryConfig.orientation + 90) + ')'; }, 'pointer-events': 'none' }).style({ fill: function(dB, iB) { return markStyle.fill(d, i, pI); }, 'fill-opacity': 0, stroke: function(dB, iB) { return markStyle.stroke(d, i, pI); }, 'stroke-width': function(dB, iB) { return markStyle['stroke-width'](d, i, pI); }, 'stroke-dasharray': function(dB, iB) { return markStyle['stroke-dasharray'](d, i, pI); }, opacity: function(dB, iB) { return markStyle.opacity(d, i, pI); }, display: function(dB, iB) { return markStyle.display(d, i, pI); } }); }; var angularRange = geometryConfig.angularScale.range(); var triangleAngle = Math.abs(angularRange[1] - angularRange[0]) / data[0].length * Math.PI / 180; var arc = d3.svg.arc().startAngle(function(d) { return -triangleAngle / 2; }).endAngle(function(d) { return triangleAngle / 2; }).innerRadius(function(d) { return geometryConfig.radialScale(domainMin + (d[2] || 0)); }).outerRadius(function(d) { return geometryConfig.radialScale(domainMin + (d[2] || 0)) + geometryConfig.radialScale(d[1]); }); generator.arc = function(d, i, pI) { d3.select(this).attr({ 'class': 'mark arc', d: arc, transform: function(d, i) { return 'rotate(' + (geometryConfig.orientation + angularScale(d[0]) + 90) + ')'; } }); }; var markStyle = { fill: function(d, i, pI) { return _config[pI].data.color; }, stroke: function(d, i, pI) { return _config[pI].data.strokeColor; }, 'stroke-width': function(d, i, pI) { return _config[pI].data.strokeSize + 'px'; }, 'stroke-dasharray': function(d, i, pI) { return dashArray[_config[pI].data.strokeDash]; }, opacity: function(d, i, pI) { return _config[pI].data.opacity; }, display: function(d, i, pI) { return typeof _config[pI].data.visible === 'undefined' || _config[pI].data.visible ? 'block' : 'none'; } }; var geometryLayer = d3.select(this).selectAll('g.layer').data(data); geometryLayer.enter().append('g').attr({ 'class': 'layer' }); var geometry = geometryLayer.selectAll('path.mark').data(function(d, i) { return d; }); geometry.enter().append('path').attr({ 'class': 'mark' }); geometry.style(markStyle).each(generator[geometryConfig.geometryType]); geometry.exit().remove(); geometryLayer.exit().remove(); function getPolarCoordinates(d, i) { var r = geometryConfig.radialScale(d[1]); var t = (geometryConfig.angularScale(d[0]) + geometryConfig.orientation) * Math.PI / 180; return { r: r, t: t }; } function convertToCartesian(polarCoordinates) { var x = polarCoordinates.r * Math.cos(polarCoordinates.t); var y = polarCoordinates.r * Math.sin(polarCoordinates.t); return { x: x, y: y }; } }); } exports.config = function(_x) { if (!arguments.length) return config; _x.forEach(function(d, i) { if (!config[i]) config[i] = {}; extendDeepAll(config[i], µ.PolyChart.defaultConfig()); extendDeepAll(config[i], d); }); return this; }; exports.getColorScale = function() { return colorScale; }; d3.rebind(exports, dispatch, 'on'); return exports; }; µ.PolyChart.defaultConfig = function() { var config = { data: { name: 'geom1', t: [ [ 1, 2, 3, 4 ] ], r: [ [ 1, 2, 3, 4 ] ], dotType: 'circle', dotSize: 64, dotVisible: false, barWidth: 20, color: '#ffa500', strokeSize: 1, strokeColor: 'silver', strokeDash: 'solid', opacity: 1, index: 0, visible: true, visibleInLegend: true }, geometryConfig: { geometry: 'LinePlot', geometryType: 'arc', direction: 'clockwise', orientation: 0, container: 'body', radialScale: null, angularScale: null, colorScale: d3.scale.category20() } }; return config; }; µ.BarChart = function module() { return µ.PolyChart(); }; µ.BarChart.defaultConfig = function() { var config = { geometryConfig: { geometryType: 'bar' } }; return config; }; µ.AreaChart = function module() { return µ.PolyChart(); }; µ.AreaChart.defaultConfig = function() { var config = { geometryConfig: { geometryType: 'arc' } }; return config; }; µ.DotPlot = function module() { return µ.PolyChart(); }; µ.DotPlot.defaultConfig = function() { var config = { geometryConfig: { geometryType: 'dot', dotType: 'circle' } }; return config; }; µ.LinePlot = function module() { return µ.PolyChart(); }; µ.LinePlot.defaultConfig = function() { var config = { geometryConfig: { geometryType: 'line' } }; return config; }; µ.Legend = function module() { var config = µ.Legend.defaultConfig(); var dispatch = d3.dispatch('hover'); function exports() { var legendConfig = config.legendConfig; var flattenData = config.data.map(function(d, i) { return [].concat(d).map(function(dB, iB) { var element = extendDeepAll({}, legendConfig.elements[i]); element.name = dB; element.color = [].concat(legendConfig.elements[i].color)[iB]; return element; }); }); var data = d3.merge(flattenData); data = data.filter(function(d, i) { return legendConfig.elements[i] && (legendConfig.elements[i].visibleInLegend || typeof legendConfig.elements[i].visibleInLegend === 'undefined'); }); if (legendConfig.reverseOrder) data = data.reverse(); var container = legendConfig.container; if (typeof container == 'string' || container.nodeName) container = d3.select(container); var colors = data.map(function(d, i) { return d.color; }); var lineHeight = legendConfig.fontSize; var isContinuous = legendConfig.isContinuous == null ? typeof data[0] === 'number' : legendConfig.isContinuous; var height = isContinuous ? legendConfig.height : lineHeight * data.length; var legendContainerGroup = container.classed('legend-group', true); var svg = legendContainerGroup.selectAll('svg').data([ 0 ]); var svgEnter = svg.enter().append('svg').attr({ width: 300, height: height + lineHeight, xmlns: 'http://www.w3.org/2000/svg', 'xmlns:xlink': 'http://www.w3.org/1999/xlink', version: '1.1' }); svgEnter.append('g').classed('legend-axis', true); svgEnter.append('g').classed('legend-marks', true); var dataNumbered = d3.range(data.length); var colorScale = d3.scale[isContinuous ? 'linear' : 'ordinal']().domain(dataNumbered).range(colors); var dataScale = d3.scale[isContinuous ? 'linear' : 'ordinal']().domain(dataNumbered)[isContinuous ? 'range' : 'rangePoints']([ 0, height ]); var shapeGenerator = function(_type, _size) { var squareSize = _size * 3; if (_type === 'line') { return 'M' + [ [ -_size / 2, -_size / 12 ], [ _size / 2, -_size / 12 ], [ _size / 2, _size / 12 ], [ -_size / 2, _size / 12 ] ] + 'Z'; } else if (d3.svg.symbolTypes.indexOf(_type) != -1) return d3.svg.symbol().type(_type).size(squareSize)(); else return d3.svg.symbol().type('square').size(squareSize)(); }; if (isContinuous) { var gradient = svg.select('.legend-marks').append('defs').append('linearGradient').attr({ id: 'grad1', x1: '0%', y1: '0%', x2: '0%', y2: '100%' }).selectAll('stop').data(colors); gradient.enter().append('stop'); gradient.attr({ offset: function(d, i) { return i / (colors.length - 1) * 100 + '%'; } }).style({ 'stop-color': function(d, i) { return d; } }); svg.append('rect').classed('legend-mark', true).attr({ height: legendConfig.height, width: legendConfig.colorBandWidth, fill: 'url(#grad1)' }); } else { var legendElement = svg.select('.legend-marks').selectAll('path.legend-mark').data(data); legendElement.enter().append('path').classed('legend-mark', true); legendElement.attr({ transform: function(d, i) { return 'translate(' + [ lineHeight / 2, dataScale(i) + lineHeight / 2 ] + ')'; }, d: function(d, i) { var symbolType = d.symbol; return shapeGenerator(symbolType, lineHeight); }, fill: function(d, i) { return colorScale(i); } }); legendElement.exit().remove(); } var legendAxis = d3.svg.axis().scale(dataScale).orient('right'); var axis = svg.select('g.legend-axis').attr({ transform: 'translate(' + [ isContinuous ? legendConfig.colorBandWidth : lineHeight, lineHeight / 2 ] + ')' }).call(legendAxis); axis.selectAll('.domain').style({ fill: 'none', stroke: 'none' }); axis.selectAll('line').style({ fill: 'none', stroke: isContinuous ? legendConfig.textColor : 'none' }); axis.selectAll('text').style({ fill: legendConfig.textColor, 'font-size': legendConfig.fontSize }).text(function(d, i) { return data[i].name; }); return exports; } exports.config = function(_x) { if (!arguments.length) return config; extendDeepAll(config, _x); return this; }; d3.rebind(exports, dispatch, 'on'); return exports; }; µ.Legend.defaultConfig = function(d, i) { var config = { data: [ 'a', 'b', 'c' ], legendConfig: { elements: [ { symbol: 'line', color: 'red' }, { symbol: 'square', color: 'yellow' }, { symbol: 'diamond', color: 'limegreen' } ], height: 150, colorBandWidth: 30, fontSize: 12, container: 'body', isContinuous: null, textColor: 'grey', reverseOrder: false } }; return config; }; µ.tooltipPanel = function() { var tooltipEl, tooltipTextEl, backgroundEl; var config = { container: null, hasTick: false, fontSize: 12, color: 'white', padding: 5 }; var id = 'tooltip-' + µ.tooltipPanel.uid++; var tickSize = 10; var exports = function() { tooltipEl = config.container.selectAll('g.' + id).data([ 0 ]); var tooltipEnter = tooltipEl.enter().append('g').classed(id, true).style({ 'pointer-events': 'none', display: 'none' }); backgroundEl = tooltipEnter.append('path').style({ fill: 'white', 'fill-opacity': .9 }).attr({ d: 'M0 0' }); tooltipTextEl = tooltipEnter.append('text').attr({ dx: config.padding + tickSize, dy: +config.fontSize * .3 }); return exports; }; exports.text = function(_text) { var l = d3.hsl(config.color).l; var strokeColor = l >= .5 ? '#aaa' : 'white'; var fillColor = l >= .5 ? 'black' : 'white'; var text = _text || ''; tooltipTextEl.style({ fill: fillColor, 'font-size': config.fontSize + 'px' }).text(text); var padding = config.padding; var bbox = tooltipTextEl.node().getBBox(); var boxStyle = { fill: config.color, stroke: strokeColor, 'stroke-width': '2px' }; var backGroundW = bbox.width + padding * 2 + tickSize; var backGroundH = bbox.height + padding * 2; backgroundEl.attr({ d: 'M' + [ [ tickSize, -backGroundH / 2 ], [ tickSize, -backGroundH / 4 ], [ config.hasTick ? 0 : tickSize, 0 ], [ tickSize, backGroundH / 4 ], [ tickSize, backGroundH / 2 ], [ backGroundW, backGroundH / 2 ], [ backGroundW, -backGroundH / 2 ] ].join('L') + 'Z' }).style(boxStyle); tooltipEl.attr({ transform: 'translate(' + [ tickSize, -backGroundH / 2 + padding * 2 ] + ')' }); tooltipEl.style({ display: 'block' }); return exports; }; exports.move = function(_pos) { if (!tooltipEl) return; tooltipEl.attr({ transform: 'translate(' + [ _pos[0], _pos[1] ] + ')' }).style({ display: 'block' }); return exports; }; exports.hide = function() { if (!tooltipEl) return; tooltipEl.style({ display: 'none' }); return exports; }; exports.show = function() { if (!tooltipEl) return; tooltipEl.style({ display: 'block' }); return exports; }; exports.config = function(_x) { extendDeepAll(config, _x); return exports; }; return exports; }; µ.tooltipPanel.uid = 1; µ.adapter = {}; µ.adapter.plotly = function module() { var exports = {}; exports.convert = function(_inputConfig, reverse) { var outputConfig = {}; if (_inputConfig.data) { outputConfig.data = _inputConfig.data.map(function(d, i) { var r = extendDeepAll({}, d); var toTranslate = [ [ r, [ 'marker', 'color' ], [ 'color' ] ], [ r, [ 'marker', 'opacity' ], [ 'opacity' ] ], [ r, [ 'marker', 'line', 'color' ], [ 'strokeColor' ] ], [ r, [ 'marker', 'line', 'dash' ], [ 'strokeDash' ] ], [ r, [ 'marker', 'line', 'width' ], [ 'strokeSize' ] ], [ r, [ 'marker', 'symbol' ], [ 'dotType' ] ], [ r, [ 'marker', 'size' ], [ 'dotSize' ] ], [ r, [ 'marker', 'barWidth' ], [ 'barWidth' ] ], [ r, [ 'line', 'interpolation' ], [ 'lineInterpolation' ] ], [ r, [ 'showlegend' ], [ 'visibleInLegend' ] ] ]; toTranslate.forEach(function(d, i) { µ.util.translator.apply(null, d.concat(reverse)); }); if (!reverse) delete r.marker; if (reverse) delete r.groupId; if (!reverse) { if (r.type === 'scatter') { if (r.mode === 'lines') r.geometry = 'LinePlot'; else if (r.mode === 'markers') r.geometry = 'DotPlot'; else if (r.mode === 'lines+markers') { r.geometry = 'LinePlot'; r.dotVisible = true; } } else if (r.type === 'area') r.geometry = 'AreaChart'; else if (r.type === 'bar') r.geometry = 'BarChart'; delete r.mode; delete r.type; } else { if (r.geometry === 'LinePlot') { r.type = 'scatter'; if (r.dotVisible === true) { delete r.dotVisible; r.mode = 'lines+markers'; } else r.mode = 'lines'; } else if (r.geometry === 'DotPlot') { r.type = 'scatter'; r.mode = 'markers'; } else if (r.geometry === 'AreaChart') r.type = 'area'; else if (r.geometry === 'BarChart') r.type = 'bar'; delete r.geometry; } return r; }); if (!reverse && _inputConfig.layout && _inputConfig.layout.barmode === 'stack') { var duplicates = µ.util.duplicates(outputConfig.data.map(function(d, i) { return d.geometry; })); outputConfig.data.forEach(function(d, i) { var idx = duplicates.indexOf(d.geometry); if (idx != -1) outputConfig.data[i].groupId = idx; }); } } if (_inputConfig.layout) { var r = extendDeepAll({}, _inputConfig.layout); var toTranslate = [ [ r, [ 'plot_bgcolor' ], [ 'backgroundColor' ] ], [ r, [ 'showlegend' ], [ 'showLegend' ] ], [ r, [ 'radialaxis' ], [ 'radialAxis' ] ], [ r, [ 'angularaxis' ], [ 'angularAxis' ] ], [ r.angularaxis, [ 'showline' ], [ 'gridLinesVisible' ] ], [ r.angularaxis, [ 'showticklabels' ], [ 'labelsVisible' ] ], [ r.angularaxis, [ 'nticks' ], [ 'ticksCount' ] ], [ r.angularaxis, [ 'tickorientation' ], [ 'tickOrientation' ] ], [ r.angularaxis, [ 'ticksuffix' ], [ 'ticksSuffix' ] ], [ r.angularaxis, [ 'range' ], [ 'domain' ] ], [ r.angularaxis, [ 'endpadding' ], [ 'endPadding' ] ], [ r.radialaxis, [ 'showline' ], [ 'gridLinesVisible' ] ], [ r.radialaxis, [ 'tickorientation' ], [ 'tickOrientation' ] ], [ r.radialaxis, [ 'ticksuffix' ], [ 'ticksSuffix' ] ], [ r.radialaxis, [ 'range' ], [ 'domain' ] ], [ r.angularAxis, [ 'showline' ], [ 'gridLinesVisible' ] ], [ r.angularAxis, [ 'showticklabels' ], [ 'labelsVisible' ] ], [ r.angularAxis, [ 'nticks' ], [ 'ticksCount' ] ], [ r.angularAxis, [ 'tickorientation' ], [ 'tickOrientation' ] ], [ r.angularAxis, [ 'ticksuffix' ], [ 'ticksSuffix' ] ], [ r.angularAxis, [ 'range' ], [ 'domain' ] ], [ r.angularAxis, [ 'endpadding' ], [ 'endPadding' ] ], [ r.radialAxis, [ 'showline' ], [ 'gridLinesVisible' ] ], [ r.radialAxis, [ 'tickorientation' ], [ 'tickOrientation' ] ], [ r.radialAxis, [ 'ticksuffix' ], [ 'ticksSuffix' ] ], [ r.radialAxis, [ 'range' ], [ 'domain' ] ], [ r.font, [ 'outlinecolor' ], [ 'outlineColor' ] ], [ r.legend, [ 'traceorder' ], [ 'reverseOrder' ] ], [ r, [ 'labeloffset' ], [ 'labelOffset' ] ], [ r, [ 'defaultcolorrange' ], [ 'defaultColorRange' ] ] ]; toTranslate.forEach(function(d, i) { µ.util.translator.apply(null, d.concat(reverse)); }); if (!reverse) { if (r.angularAxis && typeof r.angularAxis.ticklen !== 'undefined') r.tickLength = r.angularAxis.ticklen; if (r.angularAxis && typeof r.angularAxis.tickcolor !== 'undefined') r.tickColor = r.angularAxis.tickcolor; } else { if (typeof r.tickLength !== 'undefined') { r.angularaxis.ticklen = r.tickLength; delete r.tickLength; } if (r.tickColor) { r.angularaxis.tickcolor = r.tickColor; delete r.tickColor; } } if (r.legend && typeof r.legend.reverseOrder != 'boolean') { r.legend.reverseOrder = r.legend.reverseOrder != 'normal'; } if (r.legend && typeof r.legend.traceorder == 'boolean') { r.legend.traceorder = r.legend.traceorder ? 'reversed' : 'normal'; delete r.legend.reverseOrder; } if (r.margin && typeof r.margin.t != 'undefined') { var source = [ 't', 'r', 'b', 'l', 'pad' ]; var target = [ 'top', 'right', 'bottom', 'left', 'pad' ]; var margin = {}; d3.entries(r.margin).forEach(function(dB, iB) { margin[target[source.indexOf(dB.key)]] = dB.value; }); r.margin = margin; } if (reverse) { delete r.needsEndSpacing; delete r.minorTickColor; delete r.minorTicks; delete r.angularaxis.ticksCount; delete r.angularaxis.ticksCount; delete r.angularaxis.ticksStep; delete r.angularaxis.rewriteTicks; delete r.angularaxis.nticks; delete r.radialaxis.ticksCount; delete r.radialaxis.ticksCount; delete r.radialaxis.ticksStep; delete r.radialaxis.rewriteTicks; delete r.radialaxis.nticks; } outputConfig.layout = r; } return outputConfig; }; return exports; }; },{"../../plotly":366,"./micropolar_manager":417,"d3":70}],417:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../../plotly'); var d3 = require('d3'); var UndoManager = require('./undo_manager'); var manager = module.exports = {}; var extendDeepAll = Plotly.Lib.extendDeepAll; manager.framework = function(_gd) { var config, previousConfigClone, plot, convertedInput, container; var undoManager = new UndoManager(); function exports(_inputConfig, _container) { if(_container) container = _container; d3.select(d3.select(container).node().parentNode).selectAll('.svg-container>*:not(.chart-root)').remove(); config = (!config) ? _inputConfig : extendDeepAll(config, _inputConfig); if(!plot) plot = Plotly.micropolar.Axis(); convertedInput = Plotly.micropolar.adapter.plotly().convert(config); plot.config(convertedInput).render(container); _gd.data = config.data; _gd.layout = config.layout; manager.fillLayout(_gd); return config; } exports.isPolar = true; exports.svg = function() { return plot.svg(); }; exports.getConfig = function() { return config; }; exports.getLiveConfig = function() { return Plotly.micropolar.adapter.plotly().convert(plot.getLiveConfig(), true); }; exports.getLiveScales = function() { return {t: plot.angularScale(), r: plot.radialScale()}; }; exports.setUndoPoint = function() { var that = this; var configClone = Plotly.micropolar.util.cloneJson(config); (function(_configClone, _previousConfigClone) { undoManager.add({ undo: function() { //console.log('undo', _previousConfigClone); if(_previousConfigClone) that(_previousConfigClone); }, redo: function() { //console.log('redo', _configClone); that(_configClone); } }); })(configClone, previousConfigClone); previousConfigClone = Plotly.micropolar.util.cloneJson(configClone); }; exports.undo = function() { undoManager.undo(); }; exports.redo = function() { undoManager.redo(); }; return exports; }; manager.fillLayout = function(_gd) { var container = d3.select(_gd).selectAll('.plot-container'), paperDiv = container.selectAll('.svg-container'), paper = _gd.framework && _gd.framework.svg && _gd.framework.svg(), dflts = { width: 800, height: 600, paper_bgcolor: Plotly.Color.background, _container: container, _paperdiv: paperDiv, _paper: paper }; _gd._fullLayout = extendDeepAll(dflts, _gd.layout); }; },{"../../plotly":366,"./undo_manager":418,"d3":70}],418:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; //Modified from https://github.com/ArthurClemens/Javascript-Undo-Manager //Copyright (c) 2010-2013 Arthur Clemens, arthur@visiblearea.com module.exports = function UndoManager() { var undoCommands = [], index = -1, isExecuting = false, callback; function execute(command, action) { if(!command) return this; isExecuting = true; command[action](); isExecuting = false; return this; } return { add: function(command) { if(isExecuting) return this; undoCommands.splice(index + 1, undoCommands.length - index); undoCommands.push(command); index = undoCommands.length - 1; return this; }, setCallback: function(callbackFunc) { callback = callbackFunc; }, undo: function() { var command = undoCommands[index]; if(!command) return this; execute(command, 'undo'); index -= 1; if(callback) callback(command.undo); return this; }, redo: function() { var command = undoCommands[index + 1]; if(!command) return this; execute(command, 'redo'); index += 1; if(callback) callback(command.redo); return this; }, clear: function() { undoCommands = []; index = -1; }, hasUndo: function() { return index !== -1; }, hasRedo: function() { return index < (undoCommands.length - 1); }, getCommands: function() { return undoCommands; }, getPreviousCommand: function() { return undoCommands[index-1]; }, getIndex: function() { return index; } }; }; },{}],419:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../plotly'); var extendFlat = Plotly.Lib.extendFlat; var extendDeep = Plotly.Lib.extendDeep; // Put default plotTile layouts here function cloneLayoutOverride(tileClass) { var override; switch(tileClass) { case 'themes__thumb': override = { autosize: true, width: 150, height: 150, title: '', showlegend: false, margin: {l: 5, r: 5, t: 5, b: 5, pad: 0}, annotations: [] }; break; case 'thumbnail': override = { title: '', hidesources: true, showlegend: false, borderwidth: 0, bordercolor: '', margin: {l: 1, r: 1, t: 1, b: 1, pad: 0}, annotations: [] }; break; default: override = {}; } return override; } function keyIsAxis(keyName) { var types = ['xaxis', 'yaxis', 'zaxis']; return (types.indexOf(keyName.slice(0, 5)) > -1); } module.exports = function clonePlot(graphObj, options) { // Polar plot compatibility if(graphObj.framework && graphObj.framework.isPolar) { graphObj = graphObj.framework.getConfig(); } var i; var oldData = graphObj.data; var oldLayout = graphObj.layout; var newData = extendDeep([], oldData); var newLayout = extendDeep({}, oldLayout, cloneLayoutOverride(options.tileClass)); if(options.width) newLayout.width = options.width; if(options.height) newLayout.height = options.height; if(options.tileClass === 'thumbnail' || options.tileClass === 'themes__thumb') { // kill annotations newLayout.annotations = []; var keys = Object.keys(newLayout); for(i = 0; i < keys.length; i++) { if(keyIsAxis(keys[i])) { newLayout[keys[i]].title = ''; } } // kill colorbar and pie labels for(i = 0; i < newData.length; i++) { var trace = newData[i]; trace.showscale = false; if(trace.marker) trace.marker.showscale = false; if(trace.type === 'pie') trace.textposition = 'none'; } } if(Array.isArray(options.annotations)) { for(i = 0; i < options.annotations.length; i++) { newLayout.annotations.push(options.annotations[i]); } } var sceneIds = Plotly.Plots.getSubplotIds(newLayout, 'gl3d'); if(sceneIds.length) { var axesImageOverride = {}; if(options.tileClass === 'thumbnail') { axesImageOverride = { title: '', showaxeslabels: false, showticklabels: false, linetickenable: false }; } for(i = 0; i < sceneIds.length; i++) { var sceneId = sceneIds[i]; extendFlat(newLayout[sceneId].xaxis, axesImageOverride); extendFlat(newLayout[sceneId].yaxis, axesImageOverride); extendFlat(newLayout[sceneId].zaxis, axesImageOverride); // TODO what does this do? newLayout[sceneId]._scene = null; } } var td = document.createElement('div'); if(options.tileClass) td.className = options.tileClass; var plotTile = { td: td, layout: newLayout, data: newData, config: { staticPlot: (options.staticPlot === undefined) ? true : options.staticPlot, plotGlPixelRatio: (options.plotGlPixelRatio === undefined) ? 2 : options.plotGlPixelRatio, displaylogo: options.displaylogo || false, showLink: options.showLink || false, showTips: options.showTips || false } }; if(options.setBackground !== 'transparent') { plotTile.config.setBackground = options.setBackground || 'opaque'; } // attaching the default Layout the td, so you can grab it later plotTile.td.defaultLayout = cloneLayoutOverride(options.tileClass); return plotTile; }; },{"../plotly":366}],420:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; function getDelay(fullLayout) { return (fullLayout._hasGL3D || fullLayout._hasGL2D) ? 500 : 0; } function getRedrawFunc(gd) { return function() { var fullLayout = gd._fullLayout; // doesn't work presently (and not needed) for polar or gl if(fullLayout._hasGL3D || fullLayout._hasGL2D || (gd.data && gd.data[0] && gd.data[0].r) ) return; (gd.calcdata || []).forEach(function(d) { if(d[0] && d[0].t && d[0].t.cb) d[0].t.cb(); }); }; } var Snapshot = { getDelay: getDelay, getRedrawFunc: getRedrawFunc, clone: require('./cloneplot'), toSVG: require('./tosvg'), svgToImg: require('./svgtoimg'), toImage: require('./toimage') }; module.exports = Snapshot; },{"./cloneplot":419,"./svgtoimg":421,"./toimage":422,"./tosvg":423}],421:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var EventEmitter = require('events').EventEmitter; function svgToImg(opts) { var ev = opts.emitter ? opts.emitter : new EventEmitter(); var Image = window.Image; var Blob = window.Blob; var svg = opts.svg; var format = opts.format || 'png'; var canvas = opts.canvas; var ctx = canvas.getContext('2d'); var img = new Image(); var DOMURL = window.URL || window.webkitURL; var svgBlob = new Blob([svg], {type: 'image/svg+xml;charset=utf-8'}); var url = DOMURL.createObjectURL(svgBlob); canvas.height = opts.height || 150; canvas.width = opts.width || 300; img.onload = function() { var imgData; DOMURL.revokeObjectURL(url); ctx.drawImage(img, 0, 0); switch(format) { case 'jpeg': imgData = canvas.toDataURL('image/jpeg'); break; case 'png': imgData = canvas.toDataURL('image/png'); break; case 'webp': imgData = canvas.toDataURL('image/webp'); break; case 'svg': imgData = svg; break; default: return ev.emit('error', 'Image format is not jpeg, png or svg'); } ev.emit('success', imgData); }; img.onerror = function(err) { DOMURL.revokeObjectURL(url); return ev.emit('error', err); }; img.src = url; return ev; } module.exports = svgToImg; },{"events":54}],422:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ /*eslint dot-notation: [2, {"allowPattern": "^catch$"}]*/ 'use strict'; var EventEmitter = require('events').EventEmitter; var Plotly = require('../plotly'); /** * @param {object} gd figure Object * @param {object} opts option object * @param opts.format 'jpeg' | 'png' | 'webp' | 'svg' */ function toImage(gd, opts) { // first clone the GD so we can operate in a clean environment var Snapshot = Plotly.Snapshot; var ev = new EventEmitter(); var clone = Snapshot.clone(gd, {format: 'png'}); var clonedGd = clone.td; // put the cloned div somewhere off screen before attaching to DOM clonedGd.style.position = 'absolute'; clonedGd.style.left = '-5000px'; document.body.appendChild(clonedGd); function wait() { var delay = Snapshot.getDelay(clonedGd._fullLayout); setTimeout(function() { var svg = Plotly.Snapshot.toSVG(clonedGd); var canvasContainer = window.document.createElement('div'); var canvas = window.document.createElement('canvas'); // window.document.body.appendChild(canvasContainer); canvasContainer.appendChild(canvas); canvasContainer.id = Plotly.Lib.randstr(); canvas.id = Plotly.Lib.randstr(); ev = Plotly.Snapshot.svgToImg({ format: opts.format, width: clonedGd._fullLayout.width, height: clonedGd._fullLayout.height, canvas: canvas, emitter: ev, svg: svg }); ev.clean = function() { if(clonedGd) clonedGd.remove(); }; }, delay); } var redrawFunc = Snapshot.getRedrawFunc(clonedGd); Plotly.plot(clonedGd, clone.data, clone.layout, clone.config) // TODO: the following is Plotly.Plots.redrawText but without the waiting. // we shouldn't need to do this, but in *occasional* cases we do. Figure // out why and take it out. .then(redrawFunc) .then(wait) .catch(function(err) { ev.emit('error', err); }); return ev; } module.exports = toImage; },{"../plotly":366,"events":54}],423:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plotly = require('../plotly'); var d3 = require('d3'); var xmlnsNamespaces = require('../constants/xmlns_namespaces'); module.exports = function toSVG(gd, format) { // make background color a rect in the svg, then revert after scraping // all other alterations have been dealt with by properly preparing the svg // in the first place... like setting cursors with css classes so we don't // have to remove them, and providing the right namespaces in the svg to // begin with var fullLayout = gd._fullLayout, svg = fullLayout._paper, size = fullLayout._size, domain, i; svg.insert('rect', ':first-child') .call(Plotly.Drawing.setRect, 0, 0, fullLayout.width, fullLayout.height) .call(Plotly.Color.fill, fullLayout.paper_bgcolor); /* Grab the 3d scenes and rasterize em. Calculate their positions, * then insert them into the SVG element as images */ var sceneIds = Plotly.Plots.getSubplotIds(fullLayout, 'gl3d'), scene; for(i = 0; i < sceneIds.length; i++) { scene = fullLayout[sceneIds[i]]; domain = scene.domain; insertGlImage(fullLayout, scene._scene, { x: size.l + size.w * domain.x[0], y: size.t + size.h * (1 - domain.y[1]), width: size.w * (domain.x[1] - domain.x[0]), height: size.h * (domain.y[1] - domain.y[0]) }); } // similarly for 2d scenes var subplotIds = Plotly.Plots.getSubplotIds(fullLayout, 'gl2d'), subplot; for(i = 0; i < subplotIds.length; i++) { subplot = fullLayout._plots[subplotIds[i]]; insertGlImage(fullLayout, subplot._scene2d, { x: size.l, y: size.t, width: size.w, height: size.h }); } // Grab the geos off the geo-container and place them in geoimages var geoIds = Plotly.Plots.getSubplotIds(fullLayout, 'geo'), geoLayout, geoFramework; for(i = 0; i < geoIds.length; i++) { geoLayout = fullLayout[geoIds[i]]; domain = geoLayout.domain; geoFramework = geoLayout._geo.framework; geoFramework.attr('style', null); geoFramework .attr({ x: size.l + size.w * domain.x[0] + geoLayout._marginX, y: size.t + size.h * (1 - domain.y[1]) + geoLayout._marginY, width: geoLayout._width, height: geoLayout._height }); fullLayout._geoimages.node() .appendChild(geoFramework.node()); } // now that we've got the 3d images in the right layer, add top items above them // assumes everything in toppaper is a group, and if it's empty (like hoverlayer) // we can ignore it if(fullLayout._toppaper) { var topGroups = fullLayout._toppaper.node().childNodes, topGroup; for(i = 0; i < topGroups.length; i++) { topGroup = topGroups[i]; if(topGroup.childNodes.length) svg.node().appendChild(topGroup); } } // in case the svg element had an explicit background color, remove this // we want the rect to get the color so it's the right size; svg bg will // fill whatever container it's displayed in regardless of plot size. svg.node().style.background = ''; svg.selectAll('text') .attr({'data-unformatted': null}) .style({ '-webkit-user-select': null, '-moz-user-select': null, '-ms-user-select': null }) .each(function() { // hidden text is pre-formatting mathjax, the browser ignores it but it can still confuse batik var txt = d3.select(this); if(txt.style('visibility') === 'hidden') { txt.remove(); return; } // I've seen font-family styles with non-escaped double quotes in them - breaks the // serialized svg because the style attribute itself is double-quoted! // Is this an IE thing? Any other attributes or style elements that can have quotes in them? // TODO: this looks like a noop right now - what happened to it? /* * Font-family styles with double quotes in them breaks the to-image * step in FF42 because the style attribute itself is wrapped in * double quotes. See: * * - http://codepen.io/etpinard/pen/bEdQWK * - https://github.com/plotly/plotly.js/pull/104 * * for more info. */ var ff = txt.style('font-family'); if(ff && ff.indexOf('"') !== -1) { txt.style('font-family', ff.replace(/"/g, '\\\'')); } }); if(format === 'pdf' || format === 'eps') { // these formats make the extra line MathJax adds around symbols look super thick in some cases // it looks better if this is removed entirely. svg.selectAll('#MathJax_SVG_glyphs path') .attr('stroke-width', 0); } // fix for IE namespacing quirk? // http://stackoverflow.com/questions/19610089/unwanted-namespaces-on-svg-markup-when-using-xmlserializer-in-javascript-with-ie svg.node().setAttributeNS(xmlnsNamespaces.xmlns, 'xmlns', xmlnsNamespaces.svg); svg.node().setAttributeNS(xmlnsNamespaces.xmlns, 'xmlns:xlink', xmlnsNamespaces.xlink); var s = new window.XMLSerializer().serializeToString(svg.node()); s = Plotly.util.html_entity_decode(s); s = Plotly.util.xml_entity_encode(s); return s; }; function insertGlImage(fullLayout, scene, opts) { var imageData = scene.toImage('png'); fullLayout._glimages.append('svg:image') .attr({ xmlns: xmlnsNamespaces.svg, 'xlink:href': imageData, x: opts.x, y: opts.y, width: opts.width, height: opts.height, preserveAspectRatio: 'none' }); scene.destroy(); } },{"../constants/xmlns_namespaces":338,"../plotly":366,"d3":70}],424:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var mergeArray = require('../../lib').mergeArray; // arrayOk attributes, merge them into calcdata array module.exports = function arraysToCalcdata(cd) { var trace = cd[0].trace, marker = trace.marker, markerLine = marker.line; mergeArray(trace.text, cd, 'tx'); mergeArray(marker.opacity, cd, 'mo'); mergeArray(marker.color, cd, 'mc'); mergeArray(markerLine.color, cd, 'mlc'); mergeArray(markerLine.width, cd, 'mlw'); }; },{"../../lib":349}],425:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var scatterAttrs = require('../scatter/attributes'), scatterMarkerAttrs = scatterAttrs.marker, scatterMarkerLineAttrs = scatterMarkerAttrs.line; module.exports = { x: scatterAttrs.x, x0: scatterAttrs.x0, dx: scatterAttrs.dx, y: scatterAttrs.y, y0: scatterAttrs.y0, dy: scatterAttrs.dy, text: scatterAttrs.text, orientation: { valType: 'enumerated', values: ['v', 'h'], }, marker: { color: scatterMarkerAttrs.color, colorscale: scatterMarkerAttrs.colorscale, cauto: scatterMarkerAttrs.cauto, cmax: scatterMarkerAttrs.cmax, cmin: scatterMarkerAttrs.cmin, autocolorscale: scatterMarkerAttrs.autocolorscale, reversescale: scatterMarkerAttrs.reversescale, showscale: scatterMarkerAttrs.showscale, line: { color: scatterMarkerLineAttrs.color, colorscale: scatterMarkerLineAttrs.colorscale, cauto: scatterMarkerLineAttrs.cauto, cmax: scatterMarkerLineAttrs.cmax, cmin: scatterMarkerLineAttrs.cmin, width: scatterMarkerLineAttrs.width, autocolorscale: scatterMarkerLineAttrs.autocolorscale, reversescale: scatterMarkerLineAttrs.reversescale } }, r: scatterAttrs.r, t: scatterAttrs.t, _nestedModules: { // nested module coupling 'error_y': 'ErrorBars', 'error_x': 'ErrorBars', 'marker.colorbar': 'Colorbar' }, _deprecated: { bardir: { valType: 'enumerated', values: ['v', 'h'], } } }; },{"../scatter/attributes":502}],426:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Axes = require('../../plots/cartesian/axes'); var hasColorscale = require('../../components/colorscale/has_colorscale'); var colorscaleCalc = require('../../components/colorscale/calc'); module.exports = function calc(gd, trace) { // depending on bar direction, set position and size axes // and data ranges // note: this logic for choosing orientation is // duplicated in graph_obj->setstyles var xa = Axes.getFromId(gd, trace.xaxis||'x'), ya = Axes.getFromId(gd, trace.yaxis||'y'), orientation = trace.orientation || ((trace.x && !trace.y) ? 'h' : 'v'), pos, size, i; if(orientation==='h') { size = xa.makeCalcdata(trace, 'x'); pos = ya.makeCalcdata(trace, 'y'); } else { size = ya.makeCalcdata(trace, 'y'); pos = xa.makeCalcdata(trace, 'x'); } // create the "calculated data" to plot var serieslen = Math.min(pos.length, size.length), cd = []; for(i=0; i=2 ? roundWithLine(v) : // but if it's very thin, expand it so it's // necessarily visible, even if it might overlap // its neighbor (v>vc ? Math.ceil(v) : Math.floor(v)); } if(!gd._context.staticPlot) { // if bars are not fully opaque or they have a line // around them, round to integer pixels, mainly for // safari so we prevent overlaps from its expansive // pixelation. if the bars ARE fully opaque and have // no line, expand to a full pixel to make sure we // can see them var op = Color.opacity(di.mc || trace.marker.color), fixpx = (op<1 || lw>0.01) ? roundWithLine : expandToVisible; x0 = fixpx(x0,x1); x1 = fixpx(x1,x0); y0 = fixpx(y0,y1); y1 = fixpx(y1,y0); } d3.select(this).attr('d', 'M'+x0+','+y0+'V'+y1+'H'+x1+'V'+y0+'Z'); }); }); }; },{"../../components/color":299,"../../lib":349,"./arrays_to_calcdata":424,"d3":70,"fast-isnumeric":74}],433:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Plots = require('../../plots/plots'); var Axes = require('../../plots/cartesian/axes'); var Lib = require('../../lib'); /* * Bar chart stacking/grouping positioning and autoscaling calculations * for each direction separately calculate the ranges and positions * note that this handles histograms too * now doing this one subplot at a time */ module.exports = function setPositions(gd, plotinfo) { var fullLayout = gd._fullLayout, xa = plotinfo.x(), ya = plotinfo.y(), i, j; ['v', 'h'].forEach(function(dir) { var bl = [], pLetter = {v: 'x', h: 'y'}[dir], sLetter = {v: 'y', h: 'x'}[dir], pa = plotinfo[pLetter](), sa = plotinfo[sLetter](); gd._fullData.forEach(function(trace,i) { if(trace.visible === true && Plots.traceIs(trace, 'bar') && trace.orientation === dir && trace.xaxis === xa._id && trace.yaxis === ya._id) { bl.push(i); } }); if(!bl.length) return; // bar position offset and width calculation // bl1 is a list of traces (in calcdata) to look at together // to find the maximum size bars that won't overlap // for stacked or grouped bars, this is all vertical or horizontal // bars for overlaid bars, call this individually on each trace. function barposition(bl1) { // find the min. difference between any points // in any traces in bl1 var pvals = []; bl1.forEach(function(i) { gd.calcdata[i].forEach(function(v) { pvals.push(v.p); }); }); var dv = Lib.distinctVals(pvals), pv2 = dv.vals, barDiff = dv.minDiff; // check if all the traces have only independent positions // if so, let them have full width even if mode is group var overlap = false, comparelist = []; if(fullLayout.barmode === 'group') { bl1.forEach(function(i) { if(overlap) return; gd.calcdata[i].forEach(function(v) { if(overlap) return; comparelist.forEach(function(cp) { if(Math.abs(v.p-cp) < barDiff) overlap = true; }); }); if(overlap) return; gd.calcdata[i].forEach(function(v) { comparelist.push(v.p); }); }); } // check forced minimum dtick Axes.minDtick(pa, barDiff, pv2[0], overlap); // position axis autorange - always tight fitting Axes.expand(pa, pv2, {vpad: barDiff / 2}); // bar widths and position offsets barDiff *= 1 - fullLayout.bargap; if(overlap) barDiff /= bl.length; var barCenter; function setBarCenter(v) { v[pLetter] = v.p + barCenter; } for(var i = 0; i < bl1.length; i++) { var t = gd.calcdata[bl1[i]][0].t; t.barwidth = barDiff * (1 - fullLayout.bargroupgap); t.poffset = ((overlap ? (2 * i + 1 - bl1.length) * barDiff : 0) - t.barwidth) / 2; t.dbar = dv.minDiff; // store the bar center in each calcdata item barCenter = t.poffset + t.barwidth / 2; gd.calcdata[bl1[i]].forEach(setBarCenter); } } if(fullLayout.barmode === 'overlay') { bl.forEach(function(bli) { barposition([bli]); }); } else barposition(bl); var stack = (fullLayout.barmode === 'stack'), norm = fullLayout.barnorm; // bar size range and stacking calculation if(stack || norm) { // for stacked bars, we need to evaluate every step in every // stack, because negative bars mean the extremes could be // anywhere // also stores the base (b) of each bar in calcdata // so we don't have to redo this later var sMax = sa.l2c(sa.c2l(0)), sMin = sMax, sums={}, // make sure if p is different only by rounding, // we still stack sumround = gd.calcdata[bl[0]][0].t.barwidth / 100, sv = 0, padded = true, barEnd, ti, scale; for(i = 0; i < bl.length; i++) { // trace index ti = gd.calcdata[bl[i]]; for(j = 0; j < ti.length; j++) { sv = Math.round(ti[j].p / sumround); var previousSum = sums[sv] || 0; if(stack) ti[j].b = previousSum; barEnd = ti[j].b + ti[j].s; sums[sv] = previousSum + ti[j].s; // store the bar top in each calcdata item if(stack) { ti[j][sLetter] = barEnd; if(!norm && isNumeric(sa.c2l(barEnd))) { sMax = Math.max(sMax,barEnd); sMin = Math.min(sMin,barEnd); } } } } if(norm) { padded = false; var top = norm==='fraction' ? 1 : 100, tiny = top/1e9; // in case of rounding error in sum sMin = 0; sMax = stack ? top : 0; for(i = 0; i < bl.length; i++) { // trace index ti = gd.calcdata[bl[i]]; for(j = 0; j < ti.length; j++) { scale = top / sums[Math.round(ti[j].p/sumround)]; ti[j].b *= scale; ti[j].s *= scale; barEnd = ti[j].b + ti[j].s; ti[j][sLetter] = barEnd; if(isNumeric(sa.c2l(barEnd))) { if(barEnd < sMin - tiny) { padded = true; sMin = barEnd; } if(barEnd > sMax + tiny) { padded = true; sMax = barEnd; } } } } } Axes.expand(sa, [sMin, sMax], {tozero: true, padded: padded}); } else { // for grouped or overlaid bars, just make sure zero is // included, along with the tops of each bar, and store // these bar tops in calcdata var fs = function(v) { v[sLetter] = v.s; return v.s; }; for(i = 0; i < bl.length; i++) { Axes.expand(sa, gd.calcdata[bl[i]].map(fs), {tozero: true, padded: true}); } } }); }; },{"../../lib":349,"../../plots/cartesian/axes":369,"../../plots/plots":413,"fast-isnumeric":74}],434:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Color = require('../../components/color'); var Drawing = require('../../components/drawing'); module.exports = function style(gd) { var s = d3.select(gd).selectAll('g.trace.bars'), barcount = s.size(), fullLayout = gd._fullLayout; // trace styling s.style('opacity', function(d) { return d[0].trace.opacity; }) // for gapless (either stacked or neighboring grouped) bars use // crispEdges to turn off antialiasing so an artificial gap // isn't introduced. .each(function(d) { if((fullLayout.barmode==='stack' && barcount>1) || (fullLayout.bargap===0 && fullLayout.bargroupgap===0 && !d[0].trace.marker.line.width)) { d3.select(this).attr('shape-rendering','crispEdges'); } }); // then style the individual bars s.selectAll('g.points').each(function(d) { var trace = d[0].trace, marker = trace.marker, markerLine = marker.line, markerIn = (trace._input||{}).marker||{}, markerScale = Drawing.tryColorscale(marker, markerIn, ''), lineScale = Drawing.tryColorscale(marker, markerIn, 'line.'); d3.select(this).selectAll('path').each(function(d) { // allow all marker and marker line colors to be scaled // by given max and min to colorscales var fillColor, lineColor, lineWidth = (d.mlw+1 || markerLine.width+1) - 1, p = d3.select(this); if('mc' in d) fillColor = d.mcc = markerScale(d.mc); else if(Array.isArray(marker.color)) fillColor = Color.defaultLine; else fillColor = marker.color; p.style('stroke-width', lineWidth + 'px') .call(Color.fill, fillColor); if(lineWidth) { if('mlc' in d) lineColor = d.mlcc = lineScale(d.mlc); // weird case: array wasn't long enough to apply to every point else if(Array.isArray(markerLine.color)) lineColor = Color.defaultLine; else lineColor = markerLine.color; p.call(Color.stroke, lineColor); } }); // TODO: text markers on bars, either extra text or just bar values // d3.select(this).selectAll('text') // .call(Plotly.Drawing.textPointStyle,d.t||d[0].t); }); }; },{"../../components/color":299,"../../components/drawing":317,"d3":70}],435:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Color = require('../../components/color'); var hasColorscale = require('../../components/colorscale/has_colorscale'); var colorscaleDefaults = require('../../components/colorscale/defaults'); module.exports = function handleStyleDefaults(traceIn, traceOut, coerce, defaultColor, layout) { coerce('marker.color', defaultColor); if(hasColorscale(traceIn, 'marker')) { colorscaleDefaults( traceIn, traceOut, layout, coerce, {prefix: 'marker.', cLetter: 'c'} ); } coerce('marker.line.color', Color.defaultLine); if(hasColorscale(traceIn, 'marker.line')) { colorscaleDefaults( traceIn, traceOut, layout, coerce, {prefix: 'marker.line.', cLetter: 'c'} ); } coerce('marker.line.width'); }; },{"../../components/color":299,"../../components/colorscale/defaults":308,"../../components/colorscale/has_colorscale":311}],436:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var scatterAttrs = require('../scatter/attributes'); var colorAttrs = require('../../components/color/attributes'); var extendFlat = require('../../lib/extend').extendFlat; var scatterMarkerAttrs = scatterAttrs.marker, scatterMarkerLineAttrs = scatterMarkerAttrs.line; module.exports = { y: { valType: 'data_array', }, x: { valType: 'data_array', }, x0: { valType: 'any', }, y0: { valType: 'any', }, whiskerwidth: { valType: 'number', min: 0, max: 1, dflt: 0.5, }, boxpoints: { valType: 'enumerated', values: ['all', 'outliers', 'suspectedoutliers', false], dflt: 'outliers', }, boxmean: { valType: 'enumerated', values: [true, 'sd', false], dflt: false, }, jitter: { valType: 'number', min: 0, max: 1, }, pointpos: { valType: 'number', min: -2, max: 2, }, orientation: { valType: 'enumerated', values: ['v', 'h'], }, marker: { outliercolor: { valType: 'color', dflt: 'rgba(0, 0, 0, 0)', }, symbol: extendFlat({}, scatterMarkerAttrs.symbol, {arrayOk: false}), opacity: extendFlat({}, scatterMarkerAttrs.opacity, {arrayOk: false, dflt: 1}), size: extendFlat({}, scatterMarkerAttrs.size, {arrayOk: false}), color: extendFlat({}, scatterMarkerAttrs.color, {arrayOk: false}), line: { color: extendFlat({}, scatterMarkerLineAttrs.color, {arrayOk: false, dflt: colorAttrs.defaultLine}), width: extendFlat({}, scatterMarkerLineAttrs.width, {arrayOk: false, dflt: 0}), outliercolor: { valType: 'color', }, outlierwidth: { valType: 'number', min: 0, dflt: 1, } } }, line: { color: { valType: 'color', }, width: { valType: 'number', min: 0, dflt: 2, } }, fillcolor: scatterAttrs.fillcolor }; },{"../../components/color/attributes":298,"../../lib/extend":345,"../scatter/attributes":502}],437:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var Axes = require('../../plots/cartesian/axes'); // outlier definition based on http://www.physics.csbsju.edu/stats/box2.html module.exports = function calc(gd, trace) { var xa = Axes.getFromId(gd, trace.xaxis || 'x'), ya = Axes.getFromId(gd, trace.yaxis || 'y'), orientation = trace.orientation, cd = [], valAxis, valLetter, val, valBinned, posAxis, posLetter, pos, posDistinct, dPos; // Set value (val) and position (pos) keys via orientation if(orientation==='h') { valAxis = xa; valLetter = 'x'; posAxis = ya; posLetter = 'y'; } else { valAxis = ya; valLetter = 'y'; posAxis = xa; posLetter = 'x'; } val = valAxis.makeCalcdata(trace, valLetter); // get val // size autorange based on all source points // position happens afterward when we know all the pos Axes.expand(valAxis, val, {padded: true}); // In vertical (horizontal) box plots: // if no x (y) data, use x0 (y0), or name // so if you want one box // per trace, set x0 (y0) to the x (y) value or category for this trace // (or set x (y) to a constant array matching y (x)) function getPos(gd, trace, posLetter, posAxis, val) { var pos0; if(posLetter in trace) pos = posAxis.makeCalcdata(trace, posLetter); else { if(posLetter+'0' in trace) pos0 = trace[posLetter+'0']; else if('name' in trace && ( posAxis.type==='category' || (isNumeric(trace.name) && ['linear','log'].indexOf(posAxis.type)!==-1) || (Lib.isDateTime(trace.name) && posAxis.type==='date') )) { pos0 = trace.name; } else pos0 = gd.numboxes; pos0 = posAxis.d2c(pos0); pos = val.map(function() { return pos0; }); } return pos; } pos = getPos(gd, trace, posLetter, posAxis, val); // get distinct positions and min difference var dv = Lib.distinctVals(pos); posDistinct = dv.vals; dPos = dv.minDiff/2; function binVal(cd, val, pos, posDistinct, dPos) { var posDistinctLength = posDistinct.length, valLength = val.length, valBinned = [], bins = [], i, p, n, v; // store distinct pos in cd, find bins, init. valBinned for(i = 0; i < posDistinctLength; ++i) { p = posDistinct[i]; cd[i] = {pos: p}; bins[i] = p - dPos; valBinned[i] = []; } bins.push(posDistinct[posDistinctLength-1] + dPos); // bin the values for(i = 0; i < valLength; ++i) { v = val[i]; if(!isNumeric(v)) continue; n = Lib.findBin(pos[i], bins); if(n>=0 && n1), // box half width bdPos = t.dPos*(1-fullLayout.boxgap)*(1-fullLayout.boxgroupgap)/(group ? gd.numboxes : 1), // box center offset bPos = group ? 2*t.dPos*(-0.5+(t.boxnum+0.5)/gd.numboxes)*(1-fullLayout.boxgap) : 0, // whisker width wdPos = bdPos*trace.whiskerwidth; if(trace.visible !== true || t.emptybox) { d3.select(this).remove(); return; } // set axis via orientation if(trace.orientation==='h') { posAxis = ya; valAxis = xa; } else { posAxis = xa; valAxis = ya; } // save the box size and box position for use by hover t.bPos = bPos; t.bdPos = bdPos; // repeatable pseudorandom number generator seed(); // boxes and whiskers d3.select(this).selectAll('path.box') .data(Lib.identity) .enter().append('path') .attr('class','box') .each(function(d) { var posc = posAxis.c2p(d.pos + bPos, true), pos0 = posAxis.c2p(d.pos + bPos - bdPos, true), pos1 = posAxis.c2p(d.pos + bPos + bdPos, true), posw0 = posAxis.c2p(d.pos + bPos - wdPos, true), posw1 = posAxis.c2p(d.pos + bPos + wdPos, true), q1 = valAxis.c2p(d.q1, true), q3 = valAxis.c2p(d.q3, true), // make sure median isn't identical to either of the // quartiles, so we can see it m = Lib.constrain(valAxis.c2p(d.med, true), Math.min(q1, q3)+1, Math.max(q1, q3)-1), lf = valAxis.c2p(trace.boxpoints===false ? d.min : d.lf, true), uf = valAxis.c2p(trace.boxpoints===false ? d.max : d.uf, true); if(trace.orientation === 'h') { d3.select(this).attr('d', 'M'+m+','+pos0+'V'+pos1+ // median line 'M'+q1+','+pos0+'V'+pos1+'H'+q3+'V'+pos0+'Z'+ // box 'M'+q1+','+posc+'H'+lf+'M'+q3+','+posc+'H'+uf+ // whiskers ((trace.whiskerwidth===0) ? '' : // whisker caps 'M'+lf+','+posw0+'V'+posw1+'M'+uf+','+posw0+'V'+posw1)); } else { d3.select(this).attr('d', 'M'+pos0+','+m+'H'+pos1+ // median line 'M'+pos0+','+q1+'H'+pos1+'V'+q3+'H'+pos0+'Z'+ // box 'M'+posc+','+q1+'V'+lf+'M'+posc+','+q3+'V'+uf+ // whiskers ((trace.whiskerwidth===0) ? '' : // whisker caps 'M'+posw0+','+lf+'H'+posw1+'M'+posw0+','+uf+'H'+posw1)); } }); // draw points, if desired if(trace.boxpoints) { d3.select(this).selectAll('g.points') // since box plot points get an extra level of nesting, each // box needs the trace styling info .data(function(d) { d.forEach(function(v) { v.t = t; v.trace = trace; }); return d; }) .enter().append('g') .attr('class','points') .selectAll('path') .data(function(d) { var pts = (trace.boxpoints==='all') ? d.val : d.val.filter(function(v) { return (vd.uf); }), spreadLimit = (d.q3 - d.q1) * JITTERSPREAD, jitterFactors = [], maxJitterFactor = 0, i, i0, i1, pmin, pmax, jitterFactor, newJitter; // dynamic jitter if(trace.jitter) { for(i=0; id.lo) { p.so=true; } return p; }); }) .enter().append('path') .call(Drawing.translatePoints, xa, ya); } // draw mean (and stdev diamond) if desired if(trace.boxmean) { d3.select(this).selectAll('path.mean') .data(Lib.identity) .enter().append('path') .attr('class','mean') .style('fill','none') .each(function(d) { var posc = posAxis.c2p(d.pos + bPos, true), pos0 = posAxis.c2p(d.pos + bPos - bdPos, true), pos1 = posAxis.c2p(d.pos + bPos + bdPos, true), m = valAxis.c2p(d.mean, true), sl = valAxis.c2p(d.mean-d.sd, true), sh = valAxis.c2p(d.mean+d.sd, true); if(trace.orientation==='h') { d3.select(this).attr('d', 'M'+m+','+pos0+'V'+pos1+ ((trace.boxmean!=='sd') ? '' : 'm0,0L'+sl+','+posc+'L'+m+','+pos0+'L'+sh+','+posc+'Z')); } else { d3.select(this).attr('d', 'M'+pos0+','+m+'H'+pos1+ ((trace.boxmean!=='sd') ? '' : 'm0,0L'+posc+','+sl+'L'+pos0+','+m+'L'+posc+','+sh+'Z')); } }); } }); }; },{"../../components/drawing":317,"../../lib":349,"d3":70}],444:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Plots = require('../../plots/plots'); var Axes = require('../../plots/cartesian/axes'); var Lib = require('../../lib'); module.exports = function setPositions(gd, plotinfo) { var fullLayout = gd._fullLayout, xa = plotinfo.x(), ya = plotinfo.y(), orientations = ['v', 'h']; var posAxis, i, j, k; for(i = 0; i < orientations.length; ++i) { var orientation = orientations[i], boxlist = [], boxpointlist = [], minPad = 0, maxPad = 0, cd, t, trace; // set axis via orientation if(orientation === 'h') posAxis = ya; else posAxis = xa; // make list of boxes for(j = 0; j < gd.calcdata.length; ++j) { cd = gd.calcdata[j]; t = cd[0].t; trace = cd[0].trace; if(trace.visible === true && Plots.traceIs(trace, 'box') && !t.emptybox && trace.orientation === orientation && trace.xaxis === xa._id && trace.yaxis === ya._id) { boxlist.push(j); if(trace.boxpoints !== false) { minPad = Math.max(minPad, trace.jitter-trace.pointpos-1); maxPad = Math.max(maxPad, trace.jitter+trace.pointpos-1); } } } // make list of box points for(j = 0; j < boxlist.length; j++) { cd = gd.calcdata[boxlist[j]]; for(k = 0; k < cd.length; k++) boxpointlist.push(cd[k].pos); } if(!boxpointlist.length) continue; // box plots - update dPos based on multiple traces // and then use for posAxis autorange var boxdv = Lib.distinctVals(boxpointlist), dPos = boxdv.minDiff/2; // if there's no duplication of x points, // disable 'group' mode by setting numboxes=1 if(boxpointlist.length===boxdv.vals.length) gd.numboxes = 1; // check for forced minimum dtick Axes.minDtick(posAxis, boxdv.minDiff, boxdv.vals[0], true); // set the width of all boxes for(i = 0; i < boxlist.length; ++i) { gd.calcdata[i][0].t.dPos = dPos; } // autoscale the x axis - including space for points if they're off the side // TODO: this will overdo it if the outermost boxes don't have // their points as far out as the other boxes var padfactor = (1-fullLayout.boxgap) * (1-fullLayout.boxgroupgap) * dPos / gd.numboxes; Axes.expand(posAxis, boxdv.vals, { vpadminus: dPos+minPad*padfactor, vpadplus: dPos+maxPad*padfactor }); } }; },{"../../lib":349,"../../plots/cartesian/axes":369,"../../plots/plots":413}],445:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Color = require('../../components/color'); var Drawing = require('../../components/drawing'); module.exports = function style(gd) { var s = d3.select(gd).selectAll('g.trace.boxes'); s.style('opacity', function(d) { return d[0].trace.opacity; }) .each(function(d) { var trace = d[0].trace, lineWidth = trace.line.width; d3.select(this).selectAll('path.box') .style('stroke-width', lineWidth+'px') .call(Color.stroke, trace.line.color) .call(Color.fill, trace.fillcolor); d3.select(this).selectAll('path.mean') .style({ 'stroke-width': lineWidth, 'stroke-dasharray': (2*lineWidth)+'px,'+lineWidth+'px' }) .call(Color.stroke, trace.line.color); d3.select(this).selectAll('g.points path') .call(Drawing.pointStyle, trace); }); }; },{"../../components/color":299,"../../components/drawing":317,"d3":70}],446:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var ScatterGeoAttrs = require('../scattergeo/attributes'); var colorscaleAttrs = require('../../components/colorscale/attributes'); var plotAttrs = require('../../plots/attributes'); var extendFlat = require('../../lib/extend').extendFlat; var ScatterGeoMarkerLineAttrs = ScatterGeoAttrs.marker.line; module.exports = { locations: { valType: 'data_array', }, locationmode: ScatterGeoAttrs.locationmode, z: { valType: 'data_array', }, text: { valType: 'data_array', }, marker: { line: { color: ScatterGeoMarkerLineAttrs.color, width: ScatterGeoMarkerLineAttrs.width } }, zauto: colorscaleAttrs.zauto, zmin: colorscaleAttrs.zmin, zmax: colorscaleAttrs.zmax, colorscale: colorscaleAttrs.colorscale, autocolorscale: colorscaleAttrs.autocolorscale, reversescale: colorscaleAttrs.reversescale, showscale: colorscaleAttrs.showscale, hoverinfo: extendFlat({}, plotAttrs.hoverinfo, { flags: ['location', 'z', 'text', 'name'] }), _nestedModules: { 'colorbar': 'Colorbar' } }; },{"../../components/colorscale/attributes":305,"../../lib/extend":345,"../../plots/attributes":367,"../scattergeo/attributes":529}],447:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var colorscaleDefaults = require('../../components/colorscale/defaults'); var attributes = require('./attributes'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } var locations = coerce('locations'); var len; if(locations) len = locations.length; if(!locations || !len) { traceOut.visible = false; return; } var z = coerce('z'); if(!Array.isArray(z)) { traceOut.visible = false; return; } if(z.length > len) traceOut.z = z.slice(0, len); coerce('locationmode'); coerce('text'); coerce('marker.line.color'); coerce('marker.line.width'); colorscaleDefaults( traceIn, traceOut, layout, coerce, {prefix: '', cLetter: 'z'} ); coerce('hoverinfo', (layout._dataLength === 1) ? 'location+z+text' : undefined); }; },{"../../components/colorscale/defaults":308,"../../lib":349,"./attributes":446}],448:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Choropleth = {}; Choropleth.attributes = require('./attributes'); Choropleth.supplyDefaults = require('./defaults'); Choropleth.colorbar = require('../heatmap/colorbar'); Choropleth.calc = require('../surface/calc'); Choropleth.plot = require('./plot').plot; Choropleth.moduleType = 'trace'; Choropleth.name = 'choropleth'; Choropleth.basePlotModule = require('../../plots/geo'); Choropleth.categories = ['geo', 'noOpacity']; Choropleth.meta = { }; module.exports = Choropleth; },{"../../plots/geo":385,"../heatmap/colorbar":461,"../surface/calc":539,"./attributes":446,"./defaults":447,"./plot":449}],449:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Axes = require('../../plots/cartesian/axes'); var Fx = require('../../plots/cartesian/graph_interact'); var Color = require('../../components/color'); var Drawing = require('../../components/drawing'); var getColorscale = require('../../components/colorscale/get_scale'); var makeScaleFunction = require('../../components/colorscale/make_scale_function'); var getTopojsonFeatures = require('../../lib/topojson_utils').getTopojsonFeatures; var locationToFeature = require('../../lib/geo_location_utils').locationToFeature; var arrayToCalcItem = require('../../lib/array_to_calc_item'); var constants = require('../../constants/geo_constants'); var attributes = require('./attributes'); var plotChoropleth = module.exports = {}; plotChoropleth.calcGeoJSON = function(trace, topojson) { var cdi = [], locations = trace.locations, len = locations.length, features = getTopojsonFeatures(trace, topojson), markerLine = (trace.marker || {}).line || {}; var feature; for(var i = 0; i < len; i++) { feature = locationToFeature(trace.locationmode, locations[i], features); if(feature === undefined) continue; // filter the blank features here // 'data_array' attributes feature.z = trace.z[i]; if(trace.text !== undefined) feature.tx = trace.text[i]; // 'arrayOk' attributes arrayToCalcItem(markerLine.color, feature, 'mlc', i); arrayToCalcItem(markerLine.width, feature, 'mlw', i); cdi.push(feature); } if(cdi.length > 0) cdi[0].trace = trace; return cdi; }; plotChoropleth.plot = function(geo, choroplethData, geoLayout) { var framework = geo.framework, gChoropleth = framework.select('g.choroplethlayer'), gBaseLayer = framework.select('g.baselayer'), gBaseLayerOverChoropleth = framework.select('g.baselayeroverchoropleth'), baseLayersOverChoropleth = constants.baseLayersOverChoropleth, layerName; var gChoroplethTraces = gChoropleth .selectAll('g.trace.choropleth') .data(choroplethData, function(trace) { return trace.uid; }); gChoroplethTraces.enter().append('g') .attr('class', 'trace choropleth'); gChoroplethTraces.exit().remove(); gChoroplethTraces .each(function(trace) { var cdi = plotChoropleth.calcGeoJSON(trace, geo.topojson), cleanHoverLabelsFunc = makeCleanHoverLabelsFunc(geo, trace), eventDataFunc = makeEventDataFunc(trace); function handleMouseOver(pt, ptIndex) { if(!geo.showHover) return; var xy = geo.projection(pt.properties.ct); cleanHoverLabelsFunc(pt); Fx.loneHover({ x: xy[0], y: xy[1], name: pt.nameLabel, text: pt.textLabel }, { container: geo.hoverContainer.node() }); geo.graphDiv.emit('plotly_hover', eventDataFunc(pt, ptIndex)); } function handleClick(pt, ptIndex) { geo.graphDiv.emit('plotly_click', eventDataFunc(pt, ptIndex)); } d3.select(this) .selectAll('path.choroplethlocation') .data(cdi) .enter().append('path') .attr('class', 'choroplethlocation') .on('mouseover', handleMouseOver) .on('click', handleClick) .on('mouseout', function() { Fx.loneUnhover(geo.hoverContainer); }) .on('mousedown', function() { // to simulate the 'zoomon' event Fx.loneUnhover(geo.hoverContainer); }) .on('mouseup', handleMouseOver); // ~ 'zoomend' }); // some baselayers are drawn over choropleth gBaseLayerOverChoropleth.selectAll('*').remove(); for(var i = 0; i < baseLayersOverChoropleth.length; i++) { layerName = baseLayersOverChoropleth[i]; gBaseLayer.select('g.' + layerName).remove(); geo.drawTopo(gBaseLayerOverChoropleth, layerName, geoLayout); geo.styleLayer(gBaseLayerOverChoropleth, layerName, geoLayout); } plotChoropleth.style(geo); }; plotChoropleth.style = function(geo) { geo.framework.selectAll('g.trace.choropleth') .each(function(trace) { var s = d3.select(this), marker = trace.marker || {}, markerLine = marker.line || {}, zmin = trace.zmin, zmax = trace.zmax, scl = getColorscale(trace.colorscale), sclFunc = makeScaleFunction(scl, zmin, zmax); s.selectAll('path.choroplethlocation') .each(function(pt) { d3.select(this) .attr('fill', function(pt) { return sclFunc(pt.z); }) .call(Color.stroke, pt.mlc || markerLine.color) .call(Drawing.dashLine, '', pt.mlw || markerLine.width); }); }); }; function makeCleanHoverLabelsFunc(geo, trace) { var hoverinfo = trace.hoverinfo; if(hoverinfo === 'none') { return function cleanHoverLabelsFunc(pt) { delete pt.nameLabel; delete pt.textLabel; }; } var hoverinfoParts = (hoverinfo === 'all') ? attributes.hoverinfo.flags : hoverinfo.split('+'); var hasName = (hoverinfoParts.indexOf('name') !== -1), hasLocation = (hoverinfoParts.indexOf('location') !== -1), hasZ = (hoverinfoParts.indexOf('z') !== -1), hasText = (hoverinfoParts.indexOf('text') !== -1), hasIdAsNameLabel = !hasName && hasLocation; function formatter(val) { var axis = geo.mockAxis; return Axes.tickText(axis, axis.c2l(val), 'hover').text; } return function cleanHoverLabelsFunc(pt) { // put location id in name label container // if name isn't part of hoverinfo var thisText = []; if(hasIdAsNameLabel) pt.nameLabel = pt.id; else { if(hasName) pt.nameLabel = trace.name; if(hasLocation) thisText.push(pt.id); } if(hasZ) thisText.push(formatter(pt.z)); if(hasText) thisText.push(pt.tx); pt.textLabel = thisText.join('
'); }; } function makeEventDataFunc(trace) { return function(pt, ptIndex) { return {points: [{ data: trace._input, fullData: trace, curveNumber: trace.index, pointNumber: ptIndex, location: pt.id, z: pt.z }]}; }; } },{"../../components/color":299,"../../components/colorscale/get_scale":310,"../../components/colorscale/make_scale_function":315,"../../components/drawing":317,"../../constants/geo_constants":334,"../../lib/array_to_calc_item":341,"../../lib/geo_location_utils":346,"../../lib/topojson_utils":361,"../../plots/cartesian/axes":369,"../../plots/cartesian/graph_interact":374,"./attributes":446,"d3":70}],450:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var heatmapAttrs = require('../heatmap/attributes'); var scatterAttrs = require('../scatter/attributes'); var extendFlat = require('../../lib/extend').extendFlat; var scatterLineAttrs = scatterAttrs.line; module.exports = { z: heatmapAttrs.z, x: heatmapAttrs.x, x0: heatmapAttrs.x0, dx: heatmapAttrs.dx, y: heatmapAttrs.y, y0: heatmapAttrs.y0, dy: heatmapAttrs.dy, text: heatmapAttrs.text, transpose: heatmapAttrs.transpose, xtype: heatmapAttrs.xtype, ytype: heatmapAttrs.ytype, zauto: heatmapAttrs.zauto, zmin: heatmapAttrs.zmin, zmax: heatmapAttrs.zmax, colorscale: heatmapAttrs.colorscale, autocolorscale: heatmapAttrs.autocolorscale, reversescale: heatmapAttrs.reversescale, showscale: heatmapAttrs.showscale, connectgaps: heatmapAttrs.connectgaps, autocontour: { valType: 'boolean', dflt: true, }, ncontours: { valType: 'integer', dflt: 0, }, contours: { start: { valType: 'number', dflt: null, }, end: { valType: 'number', dflt: null, }, size: { valType: 'number', dflt: null, }, coloring: { valType: 'enumerated', values: ['fill', 'heatmap', 'lines', 'none'], dflt: 'fill', }, showlines: { valType: 'boolean', dflt: true, } }, line: { color: extendFlat({}, scatterLineAttrs.color, { }), width: scatterLineAttrs.width, dash: scatterLineAttrs.dash, smoothing: extendFlat({}, scatterLineAttrs.smoothing, { }) }, _nestedModules: { 'colorbar': 'Colorbar' } }; },{"../../lib/extend":345,"../heatmap/attributes":459,"../scatter/attributes":502}],451:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Axes = require('../../plots/cartesian/axes'); var heatmapCalc = require('../heatmap/calc'); module.exports = function calc(gd, trace) { // most is the same as heatmap calc, then adjust it // though a few things inside heatmap calc still look for // contour maps, because the makeBoundArray calls are too entangled var cd = heatmapCalc(gd, trace), contours = trace.contours; // check if we need to auto-choose contour levels if(trace.autocontour!==false) { var dummyAx = { type: 'linear', range: [trace.zmin, trace.zmax] }; Axes.autoTicks(dummyAx, (trace.zmax - trace.zmin) / (trace.ncontours||15)); contours.start = Axes.tickFirst(dummyAx); contours.size = dummyAx.dtick; dummyAx.range.reverse(); contours.end = Axes.tickFirst(dummyAx); if(contours.start === trace.zmin) contours.start += contours.size; if(contours.end === trace.zmax) contours.end -= contours.size; // so rounding errors don't cause us to miss the last contour contours.end += contours.size/100; // copy auto-contour info back to the source data. trace._input.contours = contours; } return cd; }; },{"../../plots/cartesian/axes":369,"../heatmap/calc":460}],452:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Plots = require('../../plots/plots'); var getColorscale = require('../../components/colorscale/get_scale'); var drawColorbar = require('../../components/colorbar/draw'); module.exports = function colorbar(gd, cd) { var trace = cd[0].trace, cbId = 'cb' + trace.uid; gd._fullLayout._infolayer.selectAll('.' + cbId).remove(); if(trace.showscale === false) { Plots.autoMargin(gd, cbId); return; } var cb = drawColorbar(gd, cbId); cd[0].t.cb = cb; var contours = trace.contours, line = trace.line, cs = contours.size||1, nc = Math.floor((contours.end + cs/10 - contours.start)/cs)+1, scl = getColorscale(trace.colorscale), extraLevel = contours.coloring==='lines' ? 0 : 1, colormap = d3.scale.linear().interpolate(d3.interpolateRgb), colorDomain = scl.map(function(si) { return (si[0]*(nc+extraLevel-1)-(extraLevel/2)) * cs + contours.start; }), colorRange = scl.map(function(si) { return si[1]; }); // colorbar fill and lines if(contours.coloring==='heatmap') { if(trace.zauto && trace.autocontour===false) { trace.zmin = contours.start-cs/2; trace.zmax = trace.zmin+nc*cs; } cb.filllevels({ start: trace.zmin, end: trace.zmax, size: (trace.zmax-trace.zmin)/254 }); colorDomain = scl.map(function(si) { return si[0]*(trace.zmax-trace.zmin) + trace.zmin; }); // do the contours extend beyond the colorscale? // if so, extend the colorscale with constants var zRange = d3.extent([trace.zmin, trace.zmax, contours.start, contours.start + cs*(nc-1)]), zmin = zRange[trace.zmin0 CHOOSESADDLE = { 104: [4, 1], 208: [2, 8], 713: [7, 13], 1114: [11, 14] }, // after one index has been used for a saddle, which do we // substitute to be used up later? SADDLEREMAINDER = {1: 4, 2: 8, 4: 1, 7: 13, 8: 2, 11: 14, 13: 7, 14: 11}; function plotOne(gd, plotinfo, cd) { Lib.markTime('in Contour.plot'); var trace = cd[0].trace, x = cd[0].x, y = cd[0].y, contours = trace.contours, uid = trace.uid, xa = plotinfo.x(), ya = plotinfo.y(), fullLayout = gd._fullLayout, id = 'contour' + uid, pathinfo = emptyPathinfo(contours, plotinfo, cd[0]); if(trace.visible !== true) { fullLayout._paper.selectAll('.' + id + ',.hm' + uid).remove(); fullLayout._infolayer.selectAll('.cb' + uid).remove(); return; } // use a heatmap to fill - draw it behind the lines if(contours.coloring === 'heatmap') { if(trace.zauto && (trace.autocontour === false)) { trace._input.zmin = trace.zmin = contours.start - contours.size / 2; trace._input.zmax = trace.zmax = trace.zmin + pathinfo.length * contours.size; } heatmapPlot(gd, plotinfo, [cd]); } // in case this used to be a heatmap (or have heatmap fill) else fullLayout._paper.selectAll('.hm' + uid).remove(); makeCrossings(pathinfo); findAllPaths(pathinfo); var leftedge = xa.c2p(x[0], true), rightedge = xa.c2p(x[x.length-1], true), bottomedge = ya.c2p(y[0], true), topedge = ya.c2p(y[y.length-1], true), perimeter = [ [leftedge, topedge], [rightedge, topedge], [rightedge, bottomedge], [leftedge, bottomedge] ]; // draw everything var plotGroup = makeContourGroup(plotinfo, cd, id); makeBackground(plotGroup, perimeter, contours); makeFills(plotGroup, pathinfo, perimeter, contours); makeLines(plotGroup, pathinfo, contours); clipGaps(plotGroup, plotinfo, cd[0], perimeter); Lib.markTime('done Contour.plot'); } function emptyPathinfo(contours, plotinfo, cd0) { var cs = contours.size || 1, pathinfo = []; for(var ci = contours.start; ci < contours.end + cs/10; ci += cs) { pathinfo.push({ level: ci, // all the cells with nontrivial marching index crossings: {}, // starting points on the edges of the lattice for each contour starts: [], // all unclosed paths (may have less items than starts, // if a path is closed by rounding) edgepaths: [], // all closed paths paths: [], // store axes so we can convert to px xaxis: plotinfo.x(), yaxis: plotinfo.y(), // full data arrays to use for interpolation x: cd0.x, y: cd0.y, z: cd0.z, smoothing: cd0.trace.line.smoothing }); } return pathinfo; } // modified marching squares algorithm, // so we disambiguate the saddle points from the start // and we ignore the cases with no crossings // the index I'm using is based on: // http://en.wikipedia.org/wiki/Marching_squares // except that the saddles bifurcate and I represent them // as the decimal combination of the two appropriate // non-saddle indices function getMarchingIndex(val,corners) { var mi = (corners[0][0] > val ? 0 : 1) + (corners[0][1] > val ? 0 : 2) + (corners[1][1] > val ? 0 : 4) + (corners[1][0] > val ? 0 : 8); if(mi === 5 || mi === 10) { var avg = (corners[0][0] + corners[0][1] + corners[1][0] + corners[1][1]) / 4; // two peaks with a big valley if(val > avg) return (mi === 5) ? 713 : 1114; // two valleys with a big ridge return (mi === 5) ? 104 : 208; } return (mi === 15) ? 0 : mi; } // Calculate all the marching indices, for ALL levels at once. // since we want to be exhaustive we'll check for contour crossings // at every intersection, rather than just following a path // TODO: shorten the inner loop to only the relevant levels function makeCrossings(pathinfo) { var z = pathinfo[0].z, m = z.length, n = z[0].length, // we already made sure z isn't ragged in interp2d twoWide = m===2 || n===2, xi, yi, startIndices, ystartIndices, label, corners, mi, pi, i; for(yi = 0; yi20) { mi = CHOOSESADDLE[mi][(marchStep[0]||marchStep[1])<0 ? 0 : 1]; pi.crossings[locStr] = SADDLEREMAINDER[mi]; } else { delete pi.crossings[locStr]; } marchStep = NEWDELTA[mi]; if(!marchStep) { console.log('found bad marching index', mi, loc, pi.level); break; } // find the crossing a half step forward, and then take the full step pts.push(getInterpPx(pi, loc, marchStep)); loc[0] += marchStep[0]; loc[1] += marchStep[1]; // don't include the same point multiple times if(equalPts(pts[pts.length-1], pts[pts.length-2])) pts.pop(); locStr = loc.join(','); // have we completed a loop, or reached an edge? if((locStr===startLocStr && marchStep.join(',')===startStepStr) || (edgeflag && ( (marchStep[0] && (loc[0]<0 || loc[0]>n-2)) || (marchStep[1] && (loc[1]<0 || loc[1]>m-2))))) { break; } mi = pi.crossings[locStr]; } if(cnt===10000) { console.log('Infinite loop in contour?'); } var closedpath = equalPts(pts[0], pts[pts.length-1]), totaldist = 0, distThresholdFactor = 0.2 * pi.smoothing, alldists = [], cropstart = 0, distgroup, cnt2, cnt3, newpt, ptcnt, ptavg, thisdist; // check for points that are too close together (<1/5 the average dist, // less if less smoothed) and just take the center (or avg of center 2) // this cuts down on funny behavior when a point is very close to a contour level for(cnt=1; cnt=cropstart; cnt--) { distgroup = alldists[cnt]; if(distgroup=cropstart; cnt2--) { if(distgroup+alldists[cnt2]20 && edgeflag) { // these saddles start at +/- x if(mi===208 || mi===1114) { // if we're starting at the left side, we must be going right dx = loc[0]===0 ? 1 : -1; } else { // if we're starting at the bottom, we must be going up dy = loc[1]===0 ? 1 : -1; } } else if(BOTTOMSTART.indexOf(mi)!==-1) dy = 1; else if(LEFTSTART.indexOf(mi)!==-1) dx = 1; else if(TOPSTART.indexOf(mi)!==-1) dy = -1; else dx = -1; return [dx, dy]; } function equalPts(pt1, pt2) { return Math.abs(pt1[0] - pt2[0]) < 0.01 && Math.abs(pt1[1] - pt2[1]) < 0.01; } function ptDist(pt1, pt2) { var dx = pt1[0] - pt2[0], dy = pt1[1] - pt2[1]; return Math.sqrt(dx*dx + dy*dy); } function getInterpPx(pi, loc, step) { var locx = loc[0] + Math.max(step[0], 0), locy = loc[1] + Math.max(step[1], 0), zxy = pi.z[locy][locx], xa = pi.xaxis, ya = pi.yaxis; if(step[1]) { var dx = (pi.level - zxy) / (pi.z[locy][locx+1] - zxy); return [xa.c2p((1-dx) * pi.x[locx] + dx * pi.x[locx+1], true), ya.c2p(pi.y[locy], true)]; } else { var dy = (pi.level - zxy) / (pi.z[locy+1][locx] - zxy); return [xa.c2p(pi.x[locx], true), ya.c2p((1-dy) * pi.y[locy] + dy * pi.y[locy+1], true)]; } } function makeContourGroup(plotinfo, cd, id) { var plotgroup = plotinfo.plot.select('.maplayer') .selectAll('g.contour.' + id) .data(cd); plotgroup.enter().append('g') .classed('contour', true) .classed(id, true); plotgroup.exit().remove(); return plotgroup; } function makeBackground(plotgroup, perimeter, contours) { var bggroup = plotgroup.selectAll('g.contourbg').data([0]); bggroup.enter().append('g').classed('contourbg',true); var bgfill = bggroup.selectAll('path') .data(contours.coloring==='fill' ? [0] : []); bgfill.enter().append('path'); bgfill.exit().remove(); bgfill .attr('d','M'+perimeter.join('L')+'Z') .style('stroke','none'); } function makeFills(plotgroup, pathinfo, perimeter, contours) { var fillgroup = plotgroup.selectAll('g.contourfill') .data([0]); fillgroup.enter().append('g') .classed('contourfill',true); var fillitems = fillgroup.selectAll('path') .data(contours.coloring==='fill' ? pathinfo : []); fillitems.enter().append('path'); fillitems.exit().remove(); fillitems.each(function(pi) { // join all paths for this level together into a single path // first follow clockwise around the perimeter to close any open paths // if the whole perimeter is above this level, start with a path // enclosing the whole thing. With all that, the parity should mean // that we always fill everything above the contour, nothing below var fullpath = joinAllPaths(pi, perimeter); if(!fullpath) d3.select(this).remove(); else d3.select(this).attr('d',fullpath).style('stroke', 'none'); }); } function joinAllPaths(pi, perimeter) { var fullpath = (pi.edgepaths.length || pi.z[0][0] < pi.level) ? '' : ('M'+perimeter.join('L')+'Z'), i = 0, startsleft = pi.edgepaths.map(function(v,i) { return i; }), newloop = true, endpt, newendpt, cnt, nexti, possiblei, addpath; function istop(pt) { return Math.abs(pt[1] - perimeter[0][1]) < 0.01; } function isbottom(pt) { return Math.abs(pt[1] - perimeter[2][1]) < 0.01; } function isleft(pt) { return Math.abs(pt[0] - perimeter[0][0]) < 0.01; } function isright(pt) { return Math.abs(pt[0] - perimeter[2][0]) < 0.01; } while(startsleft.length) { addpath = Drawing.smoothopen(pi.edgepaths[i], pi.smoothing); fullpath += newloop ? addpath : addpath.replace(/^M/, 'L'); startsleft.splice(startsleft.indexOf(i), 1); endpt = pi.edgepaths[i][pi.edgepaths[i].length-1]; nexti = -1; //now loop through sides, moving our endpoint until we find a new start for(cnt=0; cnt<4; cnt++) { // just to prevent infinite loops if(!endpt) { console.log('missing end?',i,pi); break; } if(istop(endpt) && !isright(endpt)) newendpt = perimeter[1]; // right top else if(isleft(endpt)) newendpt = perimeter[0]; // left top else if(isbottom(endpt)) newendpt = perimeter[3]; // right bottom else if(isright(endpt)) newendpt = perimeter[2]; // left bottom for(possiblei=0; possiblei < pi.edgepaths.length; possiblei++) { var ptNew = pi.edgepaths[possiblei][0]; // is ptNew on the (horz. or vert.) segment from endpt to newendpt? if(Math.abs(endpt[0]-newendpt[0]) < 0.01) { if(Math.abs(endpt[0]-ptNew[0]) < 0.01 && (ptNew[1]-endpt[1]) * (newendpt[1]-ptNew[1]) >= 0) { newendpt = ptNew; nexti = possiblei; } } else if(Math.abs(endpt[1]-newendpt[1]) < 0.01) { if(Math.abs(endpt[1]-ptNew[1]) < 0.01 && (ptNew[0]-endpt[0]) * (newendpt[0]-ptNew[0]) >= 0) { newendpt = ptNew; nexti = possiblei; } } else { console.log('endpt to newendpt is not vert. or horz.', endpt, newendpt, ptNew); } } endpt = newendpt; if(nexti>=0) break; fullpath += 'L'+newendpt; } if(nexti === pi.edgepaths.length) { console.log('unclosed perimeter path'); break; } i = nexti; // if we closed back on a loop we already included, // close it and start a new loop newloop = (startsleft.indexOf(i)===-1); if(newloop) { i = startsleft[0]; fullpath += 'Z'; } } // finally add the interior paths for(i = 0; i < pi.paths.length; i++) { fullpath += Drawing.smoothclosed(pi.paths[i], pi.smoothing); } return fullpath; } function makeLines(plotgroup, pathinfo, contours) { var smoothing = pathinfo[0].smoothing; var linegroup = plotgroup.selectAll('g.contourlevel') .data(contours.showlines===false ? [] : pathinfo); linegroup.enter().append('g') .classed('contourlevel',true); linegroup.exit().remove(); var opencontourlines = linegroup.selectAll('path.openline') .data(function(d) { return d.edgepaths; }); opencontourlines.enter().append('path') .classed('openline',true); opencontourlines.exit().remove(); opencontourlines .attr('d', function(d) { return Drawing.smoothopen(d, smoothing); }) .style('stroke-miterlimit',1); var closedcontourlines = linegroup.selectAll('path.closedline') .data(function(d) { return d.paths; }); closedcontourlines.enter().append('path') .classed('closedline',true); closedcontourlines.exit().remove(); closedcontourlines .attr('d', function(d) { return Drawing.smoothclosed(d, smoothing); }) .style('stroke-miterlimit',1); } function clipGaps(plotGroup, plotinfo, cd0, perimeter) { var clipId = 'clip' + cd0.trace.uid; var defs = plotinfo.plot.selectAll('defs') .data([0]); defs.enter().append('defs'); var clipPath = defs.selectAll('#' + clipId) .data(cd0.trace.connectgaps ? [] : [0]); clipPath.enter().append('clipPath').attr('id', clipId); clipPath.exit().remove(); if(cd0.trace.connectgaps === false) { var clipPathInfo = { // fraction of the way from missing to present point // to draw the boundary. // if you make this 1 (or 1-epsilon) then a point in // a sea of missing data will disappear entirely. level: 0.9, crossings: {}, starts: [], edgepaths: [], paths: [], xaxis: plotinfo.x(), yaxis: plotinfo.y(), x: cd0.x, y: cd0.y, // 0 = no data, 1 = data z: makeClipMask(cd0), smoothing: 0 }; makeCrossings([clipPathInfo]); findAllPaths([clipPathInfo]); var fullpath = joinAllPaths(clipPathInfo, perimeter); var path = clipPath.selectAll('path') .data([0]); path.enter().append('path'); path.attr('d', fullpath); } else clipId = null; plotGroup.call(Drawing.setClipUrl, clipId); plotinfo.plot.selectAll('.hm' + cd0.trace.uid) .call(Drawing.setClipUrl, clipId); } function makeClipMask(cd0) { var empties = cd0.trace._emptypoints, z = [], m = cd0.z.length, n = cd0.z[0].length, i, row = [], emptyPoint; for(i = 0; i < n; i++) row.push(1); for(i = 0; i < m; i++) z.push(row.slice()); for(i = 0; i < empties.length; i++) { emptyPoint = empties[i]; z[emptyPoint[0]][emptyPoint[1]] = 0; } // save this mask to determine whether to show this data in hover cd0.zmask = z; return z; } },{"../../components/drawing":317,"../../lib":349,"../heatmap/plot":468,"d3":70}],457:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Drawing = require('../../components/drawing'); var getColorscale = require('../../components/colorscale/get_scale'); var heatmapStyle = require('../heatmap/style'); module.exports = function style(gd) { d3.select(gd).selectAll('g.contour') .style('opacity', function(d) { return d.trace.opacity; }) .each(function(d) { var c = d3.select(this), trace = d.trace, contours = trace.contours, line = trace.line, colorLines = contours.coloring==='lines', cs = contours.size||1, nc = Math.floor((contours.end + cs/10 - contours.start)/cs) + 1, scl = getColorscale(trace.colorscale), extraLevel = colorLines ? 0 : 1, colormap = d3.scale.linear() .domain(scl.map(function(si) { return (si[0]*(nc+extraLevel-1)-(extraLevel/2)) * cs + contours.start; })) .interpolate(d3.interpolateRgb) .range(scl.map(function(si) { return si[1]; })); c.selectAll('g.contourlevel').each(function(d, i) { d3.select(this).selectAll('path') .call(Drawing.lineGroupStyle, line.width, colorLines ? colormap(contours.start+i*cs) : line.color, line.dash); }); c.selectAll('g.contourbg path') .style('fill', colormap(contours.start - cs/2)); c.selectAll('g.contourfill path') .style('fill',function(d, i) { return colormap(contours.start + (i+0.5)*cs); }); }); heatmapStyle(gd); }; },{"../../components/colorscale/get_scale":310,"../../components/drawing":317,"../heatmap/style":469,"d3":70}],458:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var colorscaleDefaults = require('../../components/colorscale/defaults'); module.exports = function handleStyleDefaults(traceIn, traceOut, coerce, layout) { var coloring = coerce('contours.coloring'); var showLines; if(coloring === 'fill') showLines = coerce('contours.showlines'); if(showLines !== false) { if(coloring !== 'lines') coerce('line.color', '#000'); coerce('line.width', 0.5); coerce('line.dash'); } coerce('line.smoothing'); if((traceOut.contours || {}).coloring !== 'none') { colorscaleDefaults( traceIn, traceOut, layout, coerce, {prefix: '', cLetter: 'z'} ); } }; },{"../../components/colorscale/defaults":308}],459:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var scatterAttrs = require('../scatter/attributes'); var colorscaleAttrs = require('../../components/colorscale/attributes'); var extendFlat = require('../../lib/extend').extendFlat; module.exports = { z: { valType: 'data_array', }, x: scatterAttrs.x, x0: scatterAttrs.x0, dx: scatterAttrs.dx, y: scatterAttrs.y, y0: scatterAttrs.y0, dy: scatterAttrs.dy, text: { valType: 'data_array', }, transpose: { valType: 'boolean', dflt: false, }, xtype: { valType: 'enumerated', values: ['array', 'scaled'], }, ytype: { valType: 'enumerated', values: ['array', 'scaled'], }, zauto: colorscaleAttrs.zauto, zmin: colorscaleAttrs.zmin, zmax: colorscaleAttrs.zmax, colorscale: colorscaleAttrs.colorscale, autocolorscale: extendFlat({}, colorscaleAttrs.autocolorscale, {dflt: false}), reversescale: colorscaleAttrs.reversescale, showscale: colorscaleAttrs.showscale, zsmooth: { valType: 'enumerated', values: ['fast', 'best', false], dflt: false, }, connectgaps: { valType: 'boolean', dflt: false, }, _nestedModules: { 'colorbar': 'Colorbar' } }; },{"../../components/colorscale/attributes":305,"../../lib/extend":345,"../scatter/attributes":502}],460:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var Axes = require('../../plots/cartesian/axes'); var Plots = require('../../plots/plots'); var histogram2dCalc = require('../histogram2d/calc'); var colorscaleCalc = require('../../components/colorscale/calc'); var hasColumns = require('./has_columns'); var convertColumnXYZ = require('./convert_column_xyz'); var maxRowLength = require('./max_row_length'); module.exports = function calc(gd, trace) { Lib.markTime('start convert x&y'); // prepare the raw data // run makeCalcdata on x and y even for heatmaps, in case of category mappings var xa = Axes.getFromId(gd, trace.xaxis||'x'), ya = Axes.getFromId(gd, trace.yaxis||'y'), isContour = Plots.traceIs(trace, 'contour'), isHist = Plots.traceIs(trace, 'histogram'), zsmooth = isContour ? 'best' : trace.zsmooth, x, x0, dx, y, y0, dy, z, i; // cancel minimum tick spacings (only applies to bars and boxes) xa._minDtick = 0; ya._minDtick = 0; Lib.markTime('done convert x&y'); if(isHist) { var binned = histogram2dCalc(gd, trace); x = binned.x; x0 = binned.x0; dx = binned.dx; y = binned.y; y0 = binned.y0; dy = binned.dy; z = binned.z; } else { if(hasColumns(trace)) convertColumnXYZ(trace, xa, ya); x = trace.x ? xa.makeCalcdata(trace, 'x') : []; y = trace.y ? ya.makeCalcdata(trace, 'y') : []; x0 = trace.x0 || 0; dx = trace.dx || 1; y0 = trace.y0 || 0; dy = trace.dy || 1; z = cleanZ(trace); if(isContour || trace.connectgaps) { trace._emptypoints = findEmpties(z); trace._interpz = interp2d(z, trace._emptypoints, trace._interpz); } } function noZsmooth(msg) { zsmooth = trace._input.zsmooth = trace.zsmooth = false; Lib.notifier('cannot fast-zsmooth: ' + msg); } // check whether we really can smooth (ie all boxes are about the same size) if(zsmooth === 'fast') { if(xa.type==='log' || ya.type==='log') { noZsmooth('log axis found'); } else if(!isHist) { if(x.length) { var avgdx = (x[x.length-1]-x[0]) / (x.length-1), maxErrX = Math.abs(avgdx/100); for(i=0; imaxErrX) { noZsmooth('x scale is not linear'); break; } } } if(y.length && zsmooth === 'fast') { var avgdy = (y[y.length-1]-y[0])/(y.length-1), maxErrY = Math.abs(avgdy/100); for(i=0; imaxErrY) { noZsmooth('y scale is not linear'); break; } } } } } // create arrays of brick boundaries, to be used by autorange and heatmap.plot var xlen = maxRowLength(z), xIn = trace.xtype==='scaled' ? '' : trace.x, xArray = makeBoundArray(trace, xIn, x0, dx, xlen, xa), yIn = trace.ytype==='scaled' ? '' : trace.y, yArray = makeBoundArray(trace, yIn, y0, dy, z.length, ya); Axes.expand(xa, xArray); Axes.expand(ya, yArray); var cd0 = {x: xArray, y: yArray, z: z}; // auto-z and autocolorscale if applicable colorscaleCalc(trace, z, '', 'z'); if(isContour && trace.contours && trace.contours.coloring==='heatmap') { var hmType = trace.type === 'contour' ? 'heatmap' : 'histogram2d'; cd0.xfill = makeBoundArray(hmType, xIn, x0, dx, xlen, xa); cd0.yfill = makeBoundArray(hmType, yIn, y0, dy, z.length, ya); } return [cd0]; }; function cleanZ(trace) { var zOld = trace.z; var rowlen, collen, getCollen, old2new, i, j; function cleanZvalue(v) { if(!isNumeric(v)) return undefined; return +v; } if(trace.transpose) { rowlen = 0; for(i = 0; i < zOld.length; i++) rowlen = Math.max(rowlen, zOld[i].length); if(rowlen === 0) return false; getCollen = function(zOld) { return zOld.length; }; old2new = function(zOld, i, j) { return zOld[j][i]; }; } else { rowlen = zOld.length; getCollen = function(zOld, i) { return zOld[i].length; }; old2new = function(zOld, i, j) { return zOld[i][j]; }; } var zNew = new Array(rowlen); for(i = 0; i < rowlen; i++) { collen = getCollen(zOld, i); zNew[i] = new Array(collen); for(j = 0; j < collen; j++) zNew[i][j] = cleanZvalue(old2new(zOld, i, j)); } return zNew; } function makeBoundArray(trace, arrayIn, v0In, dvIn, numbricks, ax) { var arrayOut = [], isContour = Plots.traceIs(trace, 'contour'), isHist = Plots.traceIs(trace, 'histogram'), v0, dv, i; if(Array.isArray(arrayIn) && !isHist && (ax.type!=='category')) { arrayIn = arrayIn.map(ax.d2c); var len = arrayIn.length; // given vals are brick centers // hopefully length==numbricks, but use this method even if too few are supplied // and extend it linearly based on the last two points if(len <= numbricks) { // contour plots only want the centers if(isContour) arrayOut = arrayIn.slice(0, numbricks); else if(numbricks === 1) arrayOut = [arrayIn[0]-0.5,arrayIn[0]+0.5]; else { arrayOut = [1.5*arrayIn[0]-0.5*arrayIn[1]]; for(i=1; i INTERPTHRESHOLD; i++) { maxFractionalChange = iterateInterp2d(z, emptyPoints, correctionOvershoot(maxFractionalChange)); } if(maxFractionalChange > INTERPTHRESHOLD) { console.log('interp2d didn\'t converge quickly', maxFractionalChange); } return z; } function findEmpties(z) { // return a list of empty points in 2D array z // each empty point z[i][j] gives an array [i, j, neighborCount] // neighborCount is the count of 4 nearest neighbors that DO exist // this is to give us an order of points to evaluate for interpolation. // if no neighbors exist, we iteratively look for neighbors that HAVE // neighbors, and add a fractional neighborCount var empties = [], neighborHash = {}, noNeighborList = [], nextRow = z[0], row = [], blank = [0, 0, 0], rowLength = maxRowLength(z), prevRow, i, j, thisPt, p, neighborCount, newNeighborHash, foundNewNeighbors; for(i = 0; i < z.length; i++) { prevRow = row; row = nextRow; nextRow = z[i + 1] || []; for(j = 0; j < rowLength; j++) { if(row[j]===undefined) { neighborCount = (row[j - 1] !== undefined ? 1 : 0) + (row[j + 1] !== undefined ? 1 : 0) + (prevRow[j] !== undefined ? 1 : 0) + (nextRow[j] !== undefined ? 1 : 0); if(neighborCount) { // for this purpose, don't count off-the-edge points // as undefined neighbors if(i === 0) neighborCount++; if(j === 0) neighborCount++; if(i === z.length - 1) neighborCount++; if(j === row.length - 1) neighborCount++; // if all neighbors that could exist do, we don't // need this for finding farther neighbors if(neighborCount < 4) { neighborHash[[i,j]] = [i, j, neighborCount]; } empties.push([i, j, neighborCount]); } else noNeighborList.push([i, j]); } } } while(noNeighborList.length) { newNeighborHash = {}; foundNewNeighbors = false; // look for cells that now have neighbors but didn't before for(p = noNeighborList.length - 1; p >= 0; p--) { thisPt = noNeighborList[p]; i = thisPt[0]; j = thisPt[1]; neighborCount = ((neighborHash[[i - 1, j]] || blank)[2] + (neighborHash[[i + 1, j]] || blank)[2] + (neighborHash[[i, j - 1]] || blank)[2] + (neighborHash[[i, j + 1]] || blank)[2])/20; if(neighborCount) { newNeighborHash[thisPt] = [i, j, neighborCount]; noNeighborList.splice(p, 1); foundNewNeighbors = true; } } if(!foundNewNeighbors) { throw 'findEmpties iterated with no new neighbors'; } // put these new cells into the main neighbor list for(thisPt in newNeighborHash) { neighborHash[thisPt] = newNeighborHash[thisPt]; empties.push(newNeighborHash[thisPt]); } } // sort the full list in descending order of neighbor count return empties.sort(function(a, b) { return b[2] - a[2]; }); } function iterateInterp2d(z, emptyPoints, overshoot) { var maxFractionalChange = 0, thisPt, i, j, p, q, neighborShift, neighborRow, neighborVal, neighborCount, neighborSum, initialVal, minNeighbor, maxNeighbor; for(p = 0; p < emptyPoints.length; p++) { thisPt = emptyPoints[p]; i = thisPt[0]; j = thisPt[1]; initialVal = z[i][j]; neighborSum = 0; neighborCount = 0; for(q = 0; q < 4; q++) { neighborShift = NEIGHBORSHIFTS[q]; neighborRow = z[i + neighborShift[0]]; if(!neighborRow) continue; neighborVal = neighborRow[j + neighborShift[1]]; if(neighborVal !== undefined) { if(neighborSum === 0) { minNeighbor = maxNeighbor = neighborVal; } else { minNeighbor = Math.min(minNeighbor, neighborVal); maxNeighbor = Math.max(maxNeighbor, neighborVal); } neighborCount++; neighborSum += neighborVal; } } if(neighborCount === 0) { throw 'iterateInterp2d order is wrong: no defined neighbors'; } // this is the laplace equation interpolation: // each point is just the average of its neighbors // note that this ignores differential x/y scaling // which I think is the right approach, since we // don't know what that scaling means z[i][j] = neighborSum / neighborCount; if(initialVal === undefined) { if(neighborCount < 4) maxFractionalChange = 1; } else { // we can make large empty regions converge faster // if we overshoot the change vs the previous value z[i][j] = (1 + overshoot) * z[i][j] - overshoot * initialVal; if(maxNeighbor > minNeighbor) { maxFractionalChange = Math.max(maxFractionalChange, Math.abs(z[i][j] - initialVal) / (maxNeighbor - minNeighbor)); } } } return maxFractionalChange; } },{"../../components/colorscale/calc":306,"../../lib":349,"../../plots/cartesian/axes":369,"../../plots/plots":413,"../histogram2d/calc":480,"./convert_column_xyz":462,"./has_columns":464,"./max_row_length":467,"fast-isnumeric":74}],461:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var Plots = require('../../plots/plots'); var getColorscale = require('../../components/colorscale/get_scale'); var drawColorbar = require('../../components/colorbar/draw'); module.exports = function colorbar(gd, cd) { var trace = cd[0].trace, cbId = 'cb' + trace.uid, scl = getColorscale(trace.colorscale), zmin = trace.zmin, zmax = trace.zmax; if(!isNumeric(zmin)) zmin = Lib.aggNums(Math.min, null, trace.z); if(!isNumeric(zmax)) zmax = Lib.aggNums(Math.max, null, trace.z); gd._fullLayout._infolayer.selectAll('.' + cbId).remove(); if(!trace.showscale) { Plots.autoMargin(gd, cbId); return; } var cb = cd[0].t.cb = drawColorbar(gd, cbId); cb.fillcolor(d3.scale.linear() .domain(scl.map(function(v) { return zmin + v[0]*(zmax-zmin); })) .range(scl.map(function(v) { return v[1]; }))) .filllevels({start: zmin, end: zmax, size: (zmax-zmin)/254}) .options(trace.colorbar)(); Lib.markTime('done colorbar'); }; },{"../../components/colorbar/draw":302,"../../components/colorscale/get_scale":310,"../../lib":349,"../../plots/plots":413,"d3":70,"fast-isnumeric":74}],462:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); module.exports = function convertColumnXYZ(trace, xa, ya) { var xCol = trace.x.slice(), yCol = trace.y.slice(), zCol = trace.z, textCol = trace.text, colLen = Math.min(xCol.length, yCol.length, zCol.length), hasColumnText = (textCol!==undefined && !Array.isArray(textCol[0])); var i; if(colLen < xCol.length) xCol = xCol.slice(0, colLen); if(colLen < yCol.length) yCol = yCol.slice(0, colLen); for(i = 0; i < colLen; i++) { xCol[i] = xa.d2c(xCol[i]); yCol[i] = ya.d2c(yCol[i]); } var xColdv = Lib.distinctVals(xCol), x = xColdv.vals, yColdv = Lib.distinctVals(yCol), y = yColdv.vals, z = Lib.init2dArray(y.length, x.length); var ix, iy, text; if(hasColumnText) text = Lib.init2dArray(y.length, x.length); for(i = 0; i < colLen; i++) { ix = Lib.findBin(xCol[i] + xColdv.minDiff / 2, x); iy = Lib.findBin(yCol[i] + yColdv.minDiff / 2, y); z[iy][ix] = zCol[i]; if(hasColumnText) text[iy][ix] = textCol[i]; } trace.x = x; trace.y = y; trace.z = z; if(hasColumnText) trace.text = text; }; },{"../../lib":349}],463:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var hasColumns = require('./has_columns'); var handleXYZDefaults = require('./xyz_defaults'); var colorscaleDefaults = require('../../components/colorscale/defaults'); var attributes = require('./attributes'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } var len = handleXYZDefaults(traceIn, traceOut, coerce); if(!len) { traceOut.visible = false; return; } coerce('text'); coerce('zsmooth'); coerce('connectgaps', hasColumns(traceOut) && (traceOut.zsmooth !== false)); colorscaleDefaults(traceIn, traceOut, layout, coerce, {prefix: '', cLetter: 'z'}); }; },{"../../components/colorscale/defaults":308,"../../lib":349,"./attributes":459,"./has_columns":464,"./xyz_defaults":470}],464:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = function(trace) { return !Array.isArray(trace.z[0]); }; },{}],465:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Fx = require('../../plots/cartesian/graph_interact'); var Lib = require('../../lib'); module.exports = function hoverPoints(pointData, xval, yval, hovermode, contour) { // never let a heatmap override another type as closest point if(pointData.distance < Fx.MAXDIST) return; var cd0 = pointData.cd[0], trace = cd0.trace, xa = pointData.xa, ya = pointData.ya, x = cd0.x, y = cd0.y, z = cd0.z, zmask = cd0.zmask, x2 = x, y2 = y, xl, yl, nx, ny; if(pointData.index!==false) { try { nx = Math.round(pointData.index[1]); ny = Math.round(pointData.index[0]); } catch(e) { console.log('Error hovering on heatmap, ' + 'pointNumber must be [row,col], found:', pointData.index); return; } if(nx<0 || nx>=z[0].length || ny<0 || ny>z.length) { return; } } else if(Fx.inbox(xval-x[0], xval-x[x.length-1]) > Fx.MAXDIST || Fx.inbox(yval-y[0], yval-y[y.length-1]) > Fx.MAXDIST) { return; } else { if(contour) { var i2; x2 = [2*x[0]-x[1]]; for(i2=1; i2 0) { right = xa.c2p(x[i]); i--; } if(right < left) { temp = right; right = left; left = temp; xrev = true; } i = 0; while(top === undefined && i < y.length - 1) { top = ya.c2p(y[i]); i++; } i = y.length - 1; while(bottom === undefined && i > 0) { bottom = ya.c2p(y[i]); i--; } if(bottom < top) { temp = top; top = bottom; bottom = temp; yrev = true; } // for contours with heatmap fill, we generate the boundaries based on // brick centers but then use the brick edges for drawing the bricks if(isContour) { // TODO: for 'best' smoothing, we really should use the given brick // centers as well as brick bounds in calculating values, in case of // nonuniform brick sizes x = cd[0].xfill; y = cd[0].yfill; } // make an image that goes at most half a screen off either side, to keep // time reasonable when you zoom in. if zsmooth is true/fast, don't worry // about this, because zooming doesn't increase number of pixels // if zsmooth is best, don't include anything off screen because it takes too long if(zsmooth !== 'fast') { var extra = zsmooth === 'best' ? 0 : 0.5; left = Math.max(-extra * xa._length, left); right = Math.min((1 + extra) * xa._length, right); top = Math.max(-extra * ya._length, top); bottom = Math.min((1 + extra) * ya._length, bottom); } var imageWidth = Math.round(right - left), imageHeight = Math.round(bottom - top); // now redraw // if image is entirely off-screen, don't even draw it if(imageWidth <= 0 || imageHeight <= 0) return; var canvasW, canvasH; if(zsmooth === 'fast') { canvasW = n; canvasH = m; } else { canvasW = imageWidth; canvasH = imageHeight; } var canvas = document.createElement('canvas'); canvas.width = canvasW; canvas.height = canvasH; var context = canvas.getContext('2d'); // interpolate for color scale // use an array instead of color strings, so we preserve alpha var s = d3.scale.linear() .domain(scl.map(function(si) { return si[0]; })) .range(scl.map(function(si) { var c = tinycolor(si[1]).toRgb(); return [c.r, c.g, c.b, c.a]; })) .clamp(true); // map brick boundaries to image pixels var xpx, ypx; if(zsmooth === 'fast') { xpx = xrev ? function(index) { return n - 1 - index; } : Lib.identity; ypx = yrev ? function(index) { return m - 1 - index; } : Lib.identity; } else { xpx = function(index) { return Lib.constrain(Math.round(xa.c2p(x[index]) - left), 0, imageWidth); }; ypx = function(index) { return Lib.constrain(Math.round(ya.c2p(y[index]) - top), 0, imageHeight); }; } // get interpolated bin value. Returns {bin0:closest bin, frac:fractional dist to next, bin1:next bin} function findInterp(pixel, pixArray) { var maxbin = pixArray.length - 2, bin = Lib.constrain(Lib.findBin(pixel, pixArray), 0, maxbin), pix0 = pixArray[bin], pix1 = pixArray[bin + 1], interp = Lib.constrain(bin + (pixel - pix0) / (pix1 - pix0) - 0.5, 0, maxbin), bin0 = Math.round(interp), frac = Math.abs(interp - bin0); if(!interp || interp === maxbin || !frac) { return { bin0: bin0, bin1: bin0, frac: 0 }; } return { bin0: bin0, frac: frac, bin1: Math.round(bin0 + frac / (interp - bin0)) }; } // build the pixel map brick-by-brick // cruise through z-matrix row-by-row // build a brick at each z-matrix value var yi = ypx(0), yb = [yi, yi], xbi = xrev ? 0 : 1, ybi = yrev ? 0 : 1, // for collecting an average luminosity of the heatmap pixcount = 0, rcount = 0, gcount = 0, bcount = 0, xb, j, xi, v, row, c; function setColor(v, pixsize) { if(v !== undefined) { var c = s((v - min) / (max - min)); c[0] = Math.round(c[0]); c[1] = Math.round(c[1]); c[2] = Math.round(c[2]); pixcount += pixsize; rcount += c[0] * pixsize; gcount += c[1] * pixsize; bcount += c[2] * pixsize; return c; } return [0, 0, 0, 0]; } function putColor(pixels, pxIndex, c) { pixels[pxIndex] = c[0]; pixels[pxIndex + 1] = c[1]; pixels[pxIndex + 2] = c[2]; pixels[pxIndex + 3] = Math.round(c[3] * 255); } function interpColor(r0, r1, xinterp, yinterp) { var z00 = r0[xinterp.bin0]; if(z00 === undefined) return setColor(undefined, 1); var z01 = r0[xinterp.bin1], z10 = r1[xinterp.bin0], z11 = r1[xinterp.bin1], dx = (z01 - z00) || 0, dy = (z10 - z00) || 0, dxy; // the bilinear interpolation term needs different calculations // for all the different permutations of missing data // among the neighbors of the main point, to ensure // continuity across brick boundaries. if(z01 === undefined) { if(z11 === undefined) dxy = 0; else if(z10 === undefined) dxy = 2 * (z11 - z00); else dxy = (2 * z11 - z10 - z00) * 2/3; } else if(z11 === undefined) { if(z10 === undefined) dxy = 0; else dxy = (2 * z00 - z01 - z10) * 2/3; } else if(z10 === undefined) dxy = (2 * z11 - z01 - z00) * 2/3; else dxy = (z11 + z00 - z01 - z10); return setColor(z00 + xinterp.frac * dx + yinterp.frac * (dy + xinterp.frac * dxy)); } Lib.markTime('done init png'); if(zsmooth) { // best or fast, works fastest with imageData var pxIndex = 0, pixels = new Uint8Array(imageWidth * imageHeight * 4); if(zsmooth === 'best') { var xPixArray = new Array(x.length), yPixArray = new Array(y.length), xinterpArray = new Array(imageWidth), yinterp, r0, r1; // first make arrays of x and y pixel locations of brick boundaries for(i = 0; i < x.length; i++) xPixArray[i] = Math.round(xa.c2p(x[i]) - left); for(i = 0; i < y.length; i++) yPixArray[i] = Math.round(ya.c2p(y[i]) - top); // then make arrays of interpolations // (bin0=closest, bin1=next, frac=fractional dist.) for(i = 0; i < imageWidth; i++) xinterpArray[i] = findInterp(i, xPixArray); // now do the interpolations and fill the png for(j = 0; j < imageHeight; j++) { yinterp = findInterp(j, yPixArray); r0 = z[yinterp.bin0]; r1 = z[yinterp.bin1]; for(i = 0; i < imageWidth; i++, pxIndex += 4) { c = interpColor(r0, r1, xinterpArray[i], yinterp); putColor(pixels, pxIndex, c); } } } else { // zsmooth = fast for(j = 0; j < m; j++) { row = z[j]; yb = ypx(j); for(i = 0; i < n; i++) { c = setColor(row[i],1); pxIndex = (yb * imageWidth + xpx(i)) * 4; putColor(pixels, pxIndex, c); } } } var imageData = context.createImageData(imageWidth, imageHeight); imageData.data.set(pixels); context.putImageData(imageData, 0, 0); } else { // zsmooth = false -> filling potentially large bricks works fastest with fillRect for(j = 0; j < m; j++) { row = z[j]; yb.reverse(); yb[ybi] = ypx(j + 1); if(yb[0] === yb[1] || yb[0] === undefined || yb[1] === undefined) { continue; } xi = xpx(0); xb = [xi, xi]; for(i = 0; i < n; i++) { // build one color brick! xb.reverse(); xb[xbi] = xpx(i + 1); if(xb[0] === xb[1] || xb[0] === undefined || xb[1] === undefined) { continue; } v = row[i]; c = setColor(v, (xb[1] - xb[0]) * (yb[1] - yb[0])); context.fillStyle = 'rgba(' + c.join(',') + ')'; context.fillRect(xb[0], yb[0], (xb[1] - xb[0]), (yb[1] - yb[0])); } } } Lib.markTime('done filling png'); rcount = Math.round(rcount / pixcount); gcount = Math.round(gcount/ pixcount); bcount = Math.round(bcount / pixcount); var avgColor = tinycolor('rgb(' + rcount + ',' + gcount + ',' + bcount + ')'); gd._hmpixcount = (gd._hmpixcount||0) + pixcount; gd._hmlumcount = (gd._hmlumcount||0) + pixcount * avgColor.getLuminance(); var plotgroup = plotinfo.plot.select('.imagelayer') .selectAll('g.hm.' + id) .data([0]); plotgroup.enter().append('g') .classed('hm', true) .classed(id, true); plotgroup.exit().remove(); var image3 = plotgroup.selectAll('image') .data(cd); image3.enter().append('svg:image'); image3.exit().remove(); image3.attr({ xmlns: xmlnsNamespaces.svg, 'xlink:href': canvas.toDataURL('image/png'), height: imageHeight, width: imageWidth, x: left, y: top, preserveAspectRatio: 'none' }); Lib.markTime('done showing png'); } },{"../../components/colorscale/get_scale":310,"../../constants/xmlns_namespaces":338,"../../lib":349,"../../plots/plots":413,"./max_row_length":467,"d3":70,"tinycolor2":229}],469:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); module.exports = function style(gd) { d3.select(gd).selectAll('image') .style('opacity', function(d) { return d.trace.opacity; }); }; },{"d3":70}],470:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var hasColumns = require('./has_columns'); module.exports = function handleXYZDefaults(traceIn, traceOut, coerce) { var z = coerce('z'); var x, y; if(z===undefined || !z.length) return 0; if(hasColumns(traceIn)) { x = coerce('x'); y = coerce('y'); // column z must be accompanied by 'x' and 'y' arrays if(!x || !y) return 0; } else { x = coordDefaults('x', coerce); y = coordDefaults('y', coerce); // TODO put z validation elsewhere if(!isValidZ(z)) return 0; coerce('transpose'); } return traceOut.z.length; }; function coordDefaults(coordStr, coerce) { var coord = coerce(coordStr), coordType = coord ? coerce(coordStr + 'type', 'array') : 'scaled'; if(coordType === 'scaled') { coerce(coordStr + '0'); coerce('d' + coordStr); } return coord; } function isValidZ(z) { var allRowsAreArrays = true, oneRowIsFilled = false, hasOneNumber = false, zi; /* * Without this step: * * hasOneNumber = false breaks contour but not heatmap * allRowsAreArrays = false breaks contour but not heatmap * oneRowIsFilled = false breaks both */ for(var i = 0; i < z.length; i++) { zi = z[i]; if(!Array.isArray(zi)) { allRowsAreArrays = false; break; } if(zi.length > 0) oneRowIsFilled = true; for(var j = 0; j < zi.length; j++) { if(isNumeric(zi[j])) { hasOneNumber = true; break; } } } return (allRowsAreArrays && oneRowIsFilled && hasOneNumber); } },{"./has_columns":464,"fast-isnumeric":74}],471:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var barAttrs = require('../bar/attributes'); var extendFlat = require('../../lib').extendFlat; var barMarkerAttrs = barAttrs.marker; var barMarkerLineAttrs = barMarkerAttrs.line; module.exports = { x: { valType: 'data_array', }, y: { valType: 'data_array', }, text: barAttrs.text, orientation: barAttrs.orientation, histfunc: { valType: 'enumerated', values: ['count', 'sum', 'avg', 'min', 'max'], dflt: 'count', }, histnorm: { valType: 'enumerated', values: ['', 'percent', 'probability', 'density', 'probability density'], dflt: '', }, autobinx: { valType: 'boolean', dflt: true, }, nbinsx: { valType: 'integer', min: 0, dflt: 0, }, xbins: makeBinsAttr('x'), autobiny: { valType: 'boolean', dflt: true, }, nbinsy: { valType: 'integer', min: 0, dflt: 0, }, ybins: makeBinsAttr('y'), marker: { color: barMarkerAttrs.color, colorscale: barMarkerAttrs.colorscale, cauto: barMarkerAttrs.cauto, cmax: barMarkerAttrs.cmax, cmin: barMarkerAttrs.cmin, autocolorscale: barMarkerAttrs.autocolorscale, reversescale: barMarkerAttrs.reversescale, showscale: barMarkerAttrs.showscale, line: { color: barMarkerLineAttrs.color, colorscale: barMarkerLineAttrs.colorscale, cauto: barMarkerLineAttrs.cauto, cmax: barMarkerLineAttrs.cmax, cmin: barMarkerLineAttrs.cmin, autocolorscale: barMarkerLineAttrs.autocolorscale, reversescale: barMarkerLineAttrs.reversescale, width: extendFlat({}, barMarkerLineAttrs.width, {dflt: 0}) } }, _nestedModules: { 'error_y': 'ErrorBars', 'error_x': 'ErrorBars', 'marker.colorbar': 'Colorbar' }, _deprecated: { bardir: barAttrs._deprecated.bardir } }; function makeBinsAttr(axLetter) { return { start: { valType: 'number', dflt: null, }, end: { valType: 'number', dflt: null, }, size: { valType: 'any', // for date axes dflt: 1, } }; } },{"../../lib":349,"../bar/attributes":425}],472:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = function doAvg(size, counts) { var nMax = size.length, total = 0; for(var i=0; iv) { size[n] = v; return v-size[n]; } } return 0; }, max: function(n, i, size, counterData) { var v = counterData[i]; if(isNumeric(v)) { v = Number(v); if(!isNumeric(size[n])) { size[n] = v; return v; } else if(size[n]setstyles var pos = [], size = [], i, pa = Axes.getFromId(gd, trace.orientation==='h' ? (trace.yaxis || 'y') : (trace.xaxis || 'x')), maindata = trace.orientation==='h' ? 'y' : 'x', counterdata = {x: 'y', y: 'x'}[maindata]; // prepare the raw data var pos0 = pa.makeCalcdata(trace, maindata); // calculate the bins if((trace['autobin' + maindata]!==false) || !(maindata + 'bins' in trace)) { trace[maindata + 'bins'] = Axes.autoBin(pos0, pa, trace['nbins' + maindata]); // copy bin info back to the source data. trace._input[maindata + 'bins'] = trace[maindata + 'bins']; } var binspec = trace[maindata + 'bins'], allbins = typeof binspec.size === 'string', bins = allbins ? [] : binspec, // make the empty bin array i2, binend, n, inc = [], counts = [], total = 0, norm = trace.histnorm, func = trace.histfunc, densitynorm = norm.indexOf('density')!==-1, extremefunc = func==='max' || func==='min', sizeinit = extremefunc ? null : 0, binfunc = binFunctions.count, normfunc = normFunctions[norm], doavg = false, rawCounterData; if(Array.isArray(trace[counterdata]) && func!=='count') { rawCounterData = trace[counterdata]; doavg = func==='avg'; binfunc = binFunctions[func]; } // create the bins (and any extra arrays needed) // assume more than 5000 bins is an error, so we don't crash the browser i = binspec.start; // decrease end a little in case of rounding errors binend = binspec.end + (binspec.start - Axes.tickIncrement(binspec.start, binspec.size)) / 1e6; while(i=0 && nfirstNonzero; i--) { if(size[i]) { lastNonzero = i; break; } } // create the "calculated data" to plot for(i=firstNonzero; i<=lastNonzero; i++) { if((isNumeric(pos[i]) && isNumeric(size[i]))) { cd.push({p: pos[i], s: size[i], b: 0}); } } return cd; }; },{"../../lib":349,"../../plots/cartesian/axes":369,"./average":472,"./bin_functions":474,"./norm_functions":478,"fast-isnumeric":74}],476:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var Color = require('../../components/color'); var handleBinDefaults = require('./bin_defaults'); var handleStyleDefaults = require('../bar/style_defaults'); var errorBarsSupplyDefaults = require('../../components/errorbars/defaults'); var attributes = require('./attributes'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } var x = coerce('x'), y = coerce('y'); coerce('text'); var orientation = coerce('orientation', (y && !x) ? 'h' : 'v'), sample = traceOut[orientation==='v' ? 'x' : 'y']; if(!(sample && sample.length)) { traceOut.visible = false; return; } var hasAggregationData = traceOut[orientation==='h' ? 'x' : 'y']; if(hasAggregationData) coerce('histfunc'); var binDirections = (orientation==='h') ? ['y'] : ['x']; handleBinDefaults(traceIn, traceOut, coerce, binDirections); handleStyleDefaults(traceIn, traceOut, coerce, defaultColor, layout); // override defaultColor for error bars with defaultLine errorBarsSupplyDefaults(traceIn, traceOut, Color.defaultLine, {axis: 'y'}); errorBarsSupplyDefaults(traceIn, traceOut, Color.defaultLine, {axis: 'x', inherit: 'y'}); }; },{"../../components/color":299,"../../components/errorbars/defaults":322,"../../lib":349,"../bar/style_defaults":435,"./attributes":471,"./bin_defaults":473}],477:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; /** * Histogram has its own attribute, defaults and calc steps, * but uses bar's plot to display * and bar's setPositions for stacking and grouping */ /** * histogram errorBarsOK is debatable, but it's put in for backward compat. * there are use cases for it - sqrt for a simple histogram works right now, * constant and % work but they're not so meaningful. I guess it could be cool * to allow quadrature combination of errors in summed histograms... */ var Histogram = {}; Histogram.attributes = require('./attributes'); Histogram.layoutAttributes = require('../bar/layout_attributes'); Histogram.supplyDefaults = require('./defaults'); Histogram.supplyLayoutDefaults = require('../bar/layout_defaults'); Histogram.calc = require('./calc'); Histogram.setPositions = require('../bar/set_positions'); Histogram.plot = require('../bar/plot'); Histogram.style = require('../bar/style'); Histogram.colorbar = require('../scatter/colorbar'); Histogram.hoverPoints = require('../bar/hover'); Histogram.moduleType = 'trace'; Histogram.name = 'histogram'; Histogram.basePlotModule = require('../../plots/cartesian'); Histogram.categories = ['cartesian', 'bar', 'histogram', 'oriented', 'errorBarsOK', 'showLegend']; Histogram.meta = { }; module.exports = Histogram; },{"../../plots/cartesian":375,"../bar/hover":428,"../bar/layout_attributes":430,"../bar/layout_defaults":431,"../bar/plot":432,"../bar/set_positions":433,"../bar/style":434,"../scatter/colorbar":505,"./attributes":471,"./calc":475,"./defaults":476}],478:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { percent: function(size, total) { var nMax = size.length, norm = 100/total; for(var n=0; nserieslen) x.splice(serieslen, x.length-serieslen); if(y.length>serieslen) y.splice(serieslen, y.length-serieslen); Lib.markTime('done convert data'); // calculate the bins if(trace.autobinx || !('xbins' in trace)) { trace.xbins = Axes.autoBin(x, xa, trace.nbinsx, '2d'); if(trace.type==='histogram2dcontour') { trace.xbins.start -= trace.xbins.size; trace.xbins.end += trace.xbins.size; } // copy bin info back to the source data. trace._input.xbins = trace.xbins; } if(trace.autobiny || !('ybins' in trace)) { trace.ybins = Axes.autoBin(y,ya,trace.nbinsy,'2d'); if(trace.type==='histogram2dcontour') { trace.ybins.start -= trace.ybins.size; trace.ybins.end += trace.ybins.size; } trace._input.ybins = trace.ybins; } Lib.markTime('done autoBin'); // make the empty bin array & scale the map z = []; var onecol = [], zerocol = [], xbins = (typeof(trace.xbins.size)==='string') ? [] : trace.xbins, ybins = (typeof(trace.xbins.size)==='string') ? [] : trace.ybins, total = 0, n, m, counts=[], norm = trace.histnorm, func = trace.histfunc, densitynorm = (norm.indexOf('density')!==-1), extremefunc = (func==='max' || func==='min'), sizeinit = (extremefunc ? null : 0), binfunc = binFunctions.count, normfunc = normFunctions[norm], doavg = false, xinc = [], yinc = []; // set a binning function other than count? // for binning functions: check first for 'z', // then 'mc' in case we had a colored scatter plot // and want to transfer these colors to the 2D histo // TODO: this is why we need a data picker in the popover... var rawCounterData = ('z' in trace) ? trace.z : (('marker' in trace && Array.isArray(trace.marker.color)) ? trace.marker.color : ''); if(rawCounterData && func!=='count') { doavg = func==='avg'; binfunc = binFunctions[func]; } // decrease end a little in case of rounding errors var binspec = trace.xbins, binend = binspec.end + (binspec.start - Axes.tickIncrement(binspec.start, binspec.size)) / 1e6; for(i=binspec.start; i=0 && n=0 && m 0) { cells = alphaShape(data.alphahull, positions); } else { var d = ['x', 'y', 'z'].indexOf(data.delaunayaxis); cells = triangulate(positions.map(function(c) { return [c[(d+1)%3], c[(d+2)%3]]; })); } var config = { positions: positions, cells: cells, ambient: data.lighting.ambient, diffuse: data.lighting.diffuse, specular: data.lighting.specular, roughness: data.lighting.roughness, fresnel: data.lighting.fresnel, opacity: data.opacity, contourEnable: data.contour.show, contourColor: str2RgbaArray(data.contour.color).slice(0,3), contourWidth: data.contour.width, useFacetNormals: data.flatshading }; if(data.intensity) { this.color = '#fff'; config.vertexIntensity = data.intensity; config.colormap = parseColorScale(data.colorscale); } else if(data.vertexcolor) { this.color = data.vertexcolors[0]; config.vertexColors = parseColorArray(data.vertexcolor); } else if(data.facecolor) { this.color = data.facecolor[0]; config.cellColors = parseColorArray(data.facecolor); } else { this.color = data.color; config.meshColor = str2RgbaArray(data.color); } //Update mesh this.mesh.update(config); }; proto.dispose = function() { this.scene.glplot.remove(this.mesh); this.mesh.dispose(); }; function createMesh3DTrace(scene, data) { var gl = scene.glplot.gl; var mesh = createMesh({gl: gl}); var result = new Mesh3DTrace(scene, mesh, data.uid); result.update(data); scene.glplot.add(mesh); return result; } module.exports = createMesh3DTrace; },{"../../lib/str2rgbarray":359,"alpha-shape":39,"convex-hull":60,"delaunay-triangulate":71,"gl-mesh3d":107,"tinycolor2":229}],489:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var colorbarDefaults = require('../../components/colorbar/defaults'); var attributes = require('./attributes'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } // read in face/vertex properties function readComponents(array) { var ret = array.map(function(attr) { var result = coerce(attr); if(result && Array.isArray(result)) return result; return null; }); return ret.every(function(x) { return x && x.length === ret[0].length; }) && ret; } var coords = readComponents(['x', 'y', 'z']); var indices = readComponents(['i', 'j', 'k']); if(!coords) { traceOut.visible = false; return; } if(indices) { // otherwise, convert all face indices to ints indices.forEach(function(index) { for(var i = 0; i < index.length; ++i) index[i] |= 0; }); } //Coerce remaining properties ['lighting.ambient', 'lighting.diffuse', 'lighting.specular', 'lighting.roughness', 'lighting.fresnel', 'contour.show', 'contour.color', 'contour.width', 'colorscale', 'reversescale', 'flatshading', 'alphahull', 'delaunayaxis', 'opacity' ].forEach(function(x) { coerce(x); }); if('intensity' in traceIn) { coerce('intensity'); coerce('showscale', true); } else { traceOut.showscale = false; if('vertexcolor' in traceIn) coerce('vertexcolor'); else if('facecolor' in traceIn) coerce('facecolor'); else coerce('color', defaultColor); } if(traceOut.reversescale) { traceOut.colorscale = traceOut.colorscale.map(function(si) { return [1 - si[0], si[1]]; }).reverse(); } if(traceOut.showscale) { colorbarDefaults(traceIn, traceOut, layout); } }; },{"../../components/colorbar/defaults":301,"../../lib":349,"./attributes":487}],490:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Mesh3D = {}; Mesh3D.attributes = require('./attributes'); Mesh3D.supplyDefaults = require('./defaults'); Mesh3D.colorbar = require('../heatmap/colorbar'); Mesh3D.plot = require('./convert'); Mesh3D.moduleType = 'trace'; Mesh3D.name = 'mesh3d', Mesh3D.basePlotModule = require('../../plots/gl3d'); Mesh3D.categories = ['gl3d']; Mesh3D.meta = { }; module.exports = Mesh3D; },{"../../plots/gl3d":400,"../heatmap/colorbar":461,"./attributes":487,"./convert":488,"./defaults":489}],491:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var colorAttrs = require('../../components/color/attributes'); var fontAttrs = require('../../plots/font_attributes'); var plotAttrs = require('../../plots/attributes'); var extendFlat = require('../../lib/extend').extendFlat; module.exports = { labels: { valType: 'data_array', }, // equivalent of x0 and dx, if label is missing label0: { valType: 'number', dflt: 0, }, dlabel: { valType: 'number', dflt: 1, }, values: { valType: 'data_array', }, marker: { colors: { valType: 'data_array', // TODO 'color_array' ? }, line: { color: { valType: 'color', dflt: colorAttrs.defaultLine, arrayOk: true, }, width: { valType: 'number', min: 0, dflt: 0, arrayOk: true, } } }, text: { valType: 'data_array', }, // 'see eg:' // 'https://www.e-education.psu.edu/natureofgeoinfo/sites/www.e-education.psu.edu.natureofgeoinfo/files/image/hisp_pies.gif', // '(this example involves a map too - may someday be a whole trace type', // 'of its own. but the point is the size of the whole pie is important.)' scalegroup: { valType: 'string', dflt: '', }, // labels (legend is handled by plots.attributes.showlegend and layout.hiddenlabels) textinfo: { valType: 'flaglist', flags: ['label', 'text', 'value', 'percent'], extras: ['none'], }, hoverinfo: extendFlat({}, plotAttrs.hoverinfo, { flags: ['label', 'text', 'value', 'percent', 'name'] }), textposition: { valType: 'enumerated', values: ['inside', 'outside', 'auto', 'none'], dflt: 'auto', arrayOk: true, }, // TODO make those arrayOk? textfont: extendFlat({}, fontAttrs, { }), insidetextfont: extendFlat({}, fontAttrs, { }), outsidetextfont: extendFlat({}, fontAttrs, { }), // position and shape domain: { x: { valType: 'info_array', items: [ {valType: 'number', min: 0, max: 1}, {valType: 'number', min: 0, max: 1} ], dflt: [0, 1], }, y: { valType: 'info_array', items: [ {valType: 'number', min: 0, max: 1}, {valType: 'number', min: 0, max: 1} ], dflt: [0, 1], } }, // 3D attributes commented out until I finish them in a later PR // tilt: { // // degrees to tilt the pie back from straight on // valType: 'number', // min: 0, // max: 90, // dflt: 0 // }, // tiltaxis: { // // degrees away from straight up to tilt the pie // // only has an effect if tilt is nonzero // valType: 'number', // min: -360, // max: 360, // dflt: 0 // }, // depth: { // // "3D" size, as a fraction of radius // // only has an effect if tilt is nonzero // valType: 'number', // min: 0, // max: 10, // dflt: 0.5 // }, // shading: { // // how much darker to make the sides than the top, // // with a 3D effect. We could of course get all // // fancy with lighting effects, but maybe this is // // sufficient. // valType: 'number', // min: 0, // max: 1, // dflt: 0.2 // }, hole: { valType: 'number', min: 0, max: 1, dflt: 0, }, // ordering and direction sort: { valType: 'boolean', dflt: true, }, direction: { /** * there are two common conventions, both of which place the first * (largest, if sorted) slice with its left edge at 12 o'clock but * succeeding slices follow either cw or ccw from there. * * see http://visage.co/data-visualization-101-pie-charts/ */ valType: 'enumerated', values: ['clockwise', 'counterclockwise'], dflt: 'counterclockwise', }, rotation: { valType: 'number', min: -360, max: 360, dflt: 0, }, pull: { valType: 'number', min: 0, max: 1, dflt: 0, arrayOk: true, } }; },{"../../components/color/attributes":298,"../../lib/extend":345,"../../plots/attributes":367,"../../plots/font_attributes":383}],492:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var tinycolor = require('tinycolor2'); var Color = require('../../components/color'); var helpers = require('./helpers'); module.exports = function calc(gd, trace) { var vals = trace.values, labels = trace.labels, cd = [], fullLayout = gd._fullLayout, colorMap = fullLayout._piecolormap, allThisTraceLabels = {}, needDefaults = false, vTotal = 0, hiddenLabels = fullLayout.hiddenlabels || [], i, v, label, color, hidden, pt; if(trace.dlabel) { labels = new Array(vals.length); for(i = 0; i < vals.length; i++) { labels[i] = String(trace.label0 + i * trace.dlabel); } } for(i = 0; i < vals.length; i++) { v = vals[i]; if(!isNumeric(v)) continue; v = +v; if(v < 0) continue; label = labels[i]; if(label === undefined || label === '') label = i; label = String(label); // only take the first occurrence of any given label. // TODO: perhaps (optionally?) sum values for a repeated label? if(allThisTraceLabels[label] === undefined) allThisTraceLabels[label] = true; else continue; color = tinycolor(trace.marker.colors[i]); if(color.isValid()) { color = Color.addOpacity(color, color.getAlpha()); if(!colorMap[label]) { colorMap[label] = color; } } // have we seen this label and assigned a color to it in a previous trace? else if(colorMap[label]) color = colorMap[label]; // color needs a default - mark it false, come back after sorting else { color = false; needDefaults = true; } hidden = hiddenLabels.indexOf(label) !== -1; if(!hidden) vTotal += v; cd.push({ v: v, label: label, color: color, i: i, hidden: hidden }); } if(trace.sort) cd.sort(function(a, b) { return b.v - a.v; }); /** * now go back and fill in colors we're still missing * this is done after sorting, so we pick defaults * in the order slices will be displayed */ if(needDefaults) { for(i = 0; i < cd.length; i++) { pt = cd[i]; if(pt.color === false) { colorMap[pt.label] = pt.color = nextDefaultColor(fullLayout._piedefaultcolorcount); fullLayout._piedefaultcolorcount++; } } } // include the sum of all values in the first point if(cd[0]) cd[0].vTotal = vTotal; // now insert text if(trace.textinfo && trace.textinfo !== 'none') { var hasLabel = trace.textinfo.indexOf('label') !== -1, hasText = trace.textinfo.indexOf('text') !== -1, hasValue = trace.textinfo.indexOf('value') !== -1, hasPercent = trace.textinfo.indexOf('percent') !== -1, thisText; for(i = 0; i < cd.length; i++) { pt = cd[i]; thisText = hasLabel ? [pt.label] : []; if(hasText && trace.text[pt.i]) thisText.push(trace.text[pt.i]); if(hasValue) thisText.push(helpers.formatPieValue(pt.v)); if(hasPercent) thisText.push(helpers.formatPiePercent(pt.v / vTotal)); pt.text = thisText.join('
'); } } return cd; }; /** * pick a default color from the main default set, augmented by * itself lighter then darker before repeating */ var pieDefaultColors; function nextDefaultColor(index) { if(!pieDefaultColors) { // generate this default set on demand (but then it gets saved in the module) var mainDefaults = Color.defaults; pieDefaultColors = mainDefaults.slice(); var i; for(i = 0; i < mainDefaults.length; i++) { pieDefaultColors.push(tinycolor(mainDefaults[i]).lighten(20).toHexString()); } for(i = 0; i < Color.defaults.length; i++) { pieDefaultColors.push(tinycolor(mainDefaults[i]).darken(20).toHexString()); } } return pieDefaultColors[index % pieDefaultColors.length]; } },{"../../components/color":299,"./helpers":494,"fast-isnumeric":74,"tinycolor2":229}],493:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var attributes = require('./attributes'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } var coerceFont = Lib.coerceFont; var vals = coerce('values'); if(!Array.isArray(vals) || !vals.length) { traceOut.visible = false; return; } var labels = coerce('labels'); if(!Array.isArray(labels)) { coerce('label0'); coerce('dlabel'); } var lineWidth = coerce('marker.line.width'); if(lineWidth) coerce('marker.line.color'); var colors = coerce('marker.colors'); if(!Array.isArray(colors)) traceOut.marker.colors = []; // later this will get padded with default colors coerce('scalegroup'); // TODO: tilt, depth, and hole all need to be coerced to the same values within a scaleegroup // (ideally actually, depth would get set the same *after* scaling, ie the same absolute depth) // and if colors aren't specified we should match these up - potentially even if separate pies // are NOT in the same sharegroup var textData = coerce('text'); var textInfo = coerce('textinfo', Array.isArray(textData) ? 'text+percent' : 'percent'); coerce('hoverinfo', (layout._dataLength === 1) ? 'label+text+value+percent' : undefined); if(textInfo && textInfo !== 'none') { var textPosition = coerce('textposition'), hasBoth = Array.isArray(textPosition) || textPosition === 'auto', hasInside = hasBoth || textPosition === 'inside', hasOutside = hasBoth || textPosition === 'outside'; if(hasInside || hasOutside) { var dfltFont = coerceFont(coerce, 'textfont', layout.font); if(hasInside) coerceFont(coerce, 'insidetextfont', dfltFont); if(hasOutside) coerceFont(coerce, 'outsidetextfont', dfltFont); } } coerce('domain.x'); coerce('domain.y'); // 3D attributes commented out until I finish them in a later PR // var tilt = coerce('tilt'); // if(tilt) { // coerce('tiltaxis'); // coerce('depth'); // coerce('shading'); // } coerce('hole'); coerce('sort'); coerce('direction'); coerce('rotation'); coerce('pull'); }; },{"../../lib":349,"./attributes":491}],494:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; exports.formatPiePercent = function formatPiePercent(v) { var vRounded = (v * 100).toPrecision(3); if(vRounded.indexOf('.') !== -1) return vRounded.replace(/[.]?0+$/,'') + '%'; return vRounded + '%'; }; exports.formatPieValue = function formatPieValue(v) { var vRounded = v.toPrecision(10); if(vRounded.indexOf('.') !== -1) return vRounded.replace(/[.]?0+$/,''); return vRounded; }; },{}],495:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Pie = {}; Pie.attributes = require('./attributes'); Pie.supplyDefaults = require('./defaults'); Pie.supplyLayoutDefaults = require('./layout_defaults'); Pie.layoutAttributes = require('./layout_attributes'); Pie.calc = require('./calc'); Pie.plot = require('./plot'); Pie.style = require('./style'); Pie.styleOne = require('./style_one'); Pie.moduleType = 'trace'; Pie.name = 'pie'; Pie.basePlotModule = require('../../plots/cartesian'); Pie.categories = ['pie', 'showLegend']; Pie.meta = { }; module.exports = Pie; },{"../../plots/cartesian":375,"./attributes":491,"./calc":492,"./defaults":493,"./layout_attributes":496,"./layout_defaults":497,"./plot":498,"./style":499,"./style_one":500}],496:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { /** * hiddenlabels is the pie chart analog of visible:'legendonly' * but it can contain many labels, and can hide slices * from several pies simultaneously */ hiddenlabels: {valType: 'data_array'} }; },{}],497:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var layoutAttributes = require('./layout_attributes'); module.exports = function supplyLayoutDefaults(layoutIn, layoutOut) { function coerce(attr, dflt) { return Lib.coerce(layoutIn, layoutOut, layoutAttributes, attr, dflt); } coerce('hiddenlabels'); }; },{"../../lib":349,"./layout_attributes":496}],498:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Fx = require('../../plots/cartesian/graph_interact'); var Color = require('../../components/color'); var Drawing = require('../../components/drawing'); var svgTextUtils = require('../../lib/svg_text_utils'); var helpers = require('./helpers'); module.exports = function plot(gd, cdpie) { var fullLayout = gd._fullLayout; scalePies(cdpie, fullLayout._size); var pieGroups = fullLayout._pielayer.selectAll('g.trace').data(cdpie); pieGroups.enter().append('g') .attr({ 'stroke-linejoin': 'round', // TODO: miter might look better but can sometimes cause problems // maybe miter with a small-ish stroke-miterlimit? 'class': 'trace' }); pieGroups.exit().remove(); pieGroups.order(); pieGroups.each(function(cd) { var pieGroup = d3.select(this), cd0 = cd[0], trace = cd0.trace, tiltRads = 0, //trace.tilt * Math.PI / 180, depthLength = (trace.depth||0) * cd0.r * Math.sin(tiltRads) / 2, tiltAxis = trace.tiltaxis || 0, tiltAxisRads = tiltAxis * Math.PI / 180, depthVector = [ depthLength * Math.sin(tiltAxisRads), depthLength * Math.cos(tiltAxisRads) ], rSmall = cd0.r * Math.cos(tiltRads); var pieParts = pieGroup.selectAll('g.part') .data(trace.tilt ? ['top', 'sides'] : ['top']); pieParts.enter().append('g').attr('class', function(d) { return d + ' part'; }); pieParts.exit().remove(); pieParts.order(); setCoords(cd); pieGroup.selectAll('.top').each(function() { var slices = d3.select(this).selectAll('g.slice').data(cd); slices.enter().append('g') .classed('slice', true); slices.exit().remove(); var quadrants = [ [[],[]], // y<0: x<0, x>=0 [[],[]] // y>=0: x<0, x>=0 ], hasOutsideText = false; slices.each(function(pt) { if(pt.hidden) { d3.select(this).selectAll('path,g').remove(); return; } quadrants[pt.pxmid[1] < 0 ? 0 : 1][pt.pxmid[0] < 0 ? 0 : 1].push(pt); var cx = cd0.cx + depthVector[0], cy = cd0.cy + depthVector[1], sliceTop = d3.select(this), slicePath = sliceTop.selectAll('path.surface').data([pt]), hasHoverData = false; function handleMouseOver(evt) { // in case fullLayout or fullData has changed without a replot var fullLayout2 = gd._fullLayout, trace2 = gd._fullData[trace.index], hoverinfo = trace2.hoverinfo; if(hoverinfo === 'all') hoverinfo = 'label+text+value+percent+name'; // in case we dragged over the pie from another subplot, // or if hover is turned off if(gd._dragging || fullLayout2.hovermode === false || hoverinfo === 'none' || !hoverinfo) { return; } var rInscribed = getInscribedRadiusFraction(pt, cd0), hoverCenterX = cx + pt.pxmid[0] * (1 - rInscribed), hoverCenterY = cy + pt.pxmid[1] * (1 - rInscribed), thisText = []; if(hoverinfo.indexOf('label') !== -1) thisText.push(pt.label); if(trace2.text && trace2.text[pt.i] && hoverinfo.indexOf('text') !== -1) { thisText.push(trace2.text[pt.i]); } if(hoverinfo.indexOf('value') !== -1) thisText.push(helpers.formatPieValue(pt.v)); if(hoverinfo.indexOf('percent') !== -1) thisText.push(helpers.formatPiePercent(pt.v / cd0.vTotal)); Fx.loneHover({ x0: hoverCenterX - rInscribed * cd0.r, x1: hoverCenterX + rInscribed * cd0.r, y: hoverCenterY, text: thisText.join('
'), name: hoverinfo.indexOf('name') !== -1 ? trace2.name : undefined, color: pt.color, idealAlign: pt.pxmid[0] < 0 ? 'left' : 'right' }, { container: fullLayout2._hoverlayer.node(), outerContainer: fullLayout2._paper.node() }); Fx.hover(gd, evt, 'pie'); hasHoverData = true; } function handleMouseOut() { if(hasHoverData) { Fx.loneUnhover(fullLayout._hoverlayer.node()); hasHoverData = false; } } function handleClick() { gd._hoverdata = [pt]; gd._hoverdata.trace = cd.trace; Fx.click(gd, { target: true }); } slicePath.enter().append('path') .classed('surface', true) .style({'pointer-events': 'all'}); sliceTop.select('path.textline').remove(); sliceTop .on('mouseover', handleMouseOver) .on('mouseout', handleMouseOut) .on('click', handleClick); if(trace.pull) { var pull = +(Array.isArray(trace.pull) ? trace.pull[pt.i] : trace.pull) || 0; if(pull > 0) { cx += pull * pt.pxmid[0]; cy += pull * pt.pxmid[1]; } } pt.cxFinal = cx; pt.cyFinal = cy; function arc(start, finish, cw, scale) { return 'a' + (scale * cd0.r) + ',' + (scale * rSmall) + ' ' + tiltAxis + ' ' + pt.largeArc + (cw ? ' 1 ' : ' 0 ') + (scale * (finish[0] - start[0])) + ',' + (scale * (finish[1] - start[1])); } var hole = trace.hole; if(pt.v === cd0.vTotal) { // 100% fails bcs arc start and end are identical var outerCircle = 'M' + (cx + pt.px0[0]) + ',' + (cy + pt.px0[1]) + arc(pt.px0, pt.pxmid, true, 1) + arc(pt.pxmid, pt.px0, true, 1) + 'Z'; if(hole) { slicePath.attr('d', 'M' + (cx + hole * pt.px0[0]) + ',' + (cy + hole * pt.px0[1]) + arc(pt.px0, pt.pxmid, false, hole) + arc(pt.pxmid, pt.px0, false, hole) + 'Z' + outerCircle); } else slicePath.attr('d', outerCircle); } else { var outerArc = arc(pt.px0, pt.px1, true, 1); if(hole) { var rim = 1 - hole; slicePath.attr('d', 'M' + (cx + hole * pt.px1[0]) + ',' + (cy + hole * pt.px1[1]) + arc(pt.px1, pt.px0, false, hole) + 'l' + (rim * pt.px0[0]) + ',' + (rim * pt.px0[1]) + outerArc + 'Z'); } else { slicePath.attr('d', 'M' + cx + ',' + cy + 'l' + pt.px0[0] + ',' + pt.px0[1] + outerArc + 'Z'); } } // add text var textPosition = Array.isArray(trace.textposition) ? trace.textposition[pt.i] : trace.textposition, sliceTextGroup = sliceTop.selectAll('g.slicetext') .data(pt.text && (textPosition !== 'none') ? [0] : []); sliceTextGroup.enter().append('g') .classed('slicetext', true); sliceTextGroup.exit().remove(); sliceTextGroup.each(function() { var sliceText = d3.select(this).selectAll('text').data([0]); sliceText.enter().append('text') // prohibit tex interpretation until we can handle // tex and regular text together .attr('data-notex', 1); sliceText.exit().remove(); sliceText.text(pt.text) .attr({ 'class': 'slicetext', transform: '', 'data-bb': '', 'text-anchor': 'middle', x: 0, y: 0 }) .call(Drawing.font, textPosition === 'outside' ? trace.outsidetextfont : trace.insidetextfont) .call(svgTextUtils.convertToTspans); sliceText.selectAll('tspan.line').attr({x: 0, y: 0}); // position the text relative to the slice // TODO: so far this only accounts for flat var textBB = Drawing.bBox(sliceText.node()), transform; if(textPosition === 'outside') { transform = transformOutsideText(textBB, pt); } else { transform = transformInsideText(textBB, pt, cd0); if(textPosition === 'auto' && transform.scale < 1) { sliceText.call(Drawing.font, trace.outsidetextfont); if(trace.outsidetextfont.family !== trace.insidetextfont.family || trace.outsidetextfont.size !== trace.insidetextfont.size) { sliceText.attr({'data-bb': ''}); textBB = Drawing.bBox(sliceText.node()); } transform = transformOutsideText(textBB, pt); } } var translateX = cx + pt.pxmid[0] * transform.rCenter + (transform.x || 0), translateY = cy + pt.pxmid[1] * transform.rCenter + (transform.y || 0); // save some stuff to use later ensure no labels overlap if(transform.outside) { pt.yLabelMin = translateY - textBB.height / 2; pt.yLabelMid = translateY; pt.yLabelMax = translateY + textBB.height / 2; pt.labelExtraX = 0; pt.labelExtraY = 0; hasOutsideText = true; } sliceText.attr('transform', 'translate(' + translateX + ',' + translateY + ')' + (transform.scale < 1 ? ('scale(' + transform.scale + ')') : '') + (transform.rotate ? ('rotate(' + transform.rotate + ')') : '') + 'translate(' + (-(textBB.left + textBB.right) / 2) + ',' + (-(textBB.top + textBB.bottom) / 2) + ')'); }); }); // now make sure no labels overlap (at least within one pie) if(hasOutsideText) scootLabels(quadrants, trace); slices.each(function(pt) { if(pt.labelExtraX || pt.labelExtraY) { // first move the text to its new location var sliceTop = d3.select(this), sliceText = sliceTop.select('g.slicetext text'); sliceText.attr('transform', 'translate(' + pt.labelExtraX + ',' + pt.labelExtraY + ')' + sliceText.attr('transform')); // then add a line to the new location var lineStartX = pt.cxFinal + pt.pxmid[0], lineStartY = pt.cyFinal + pt.pxmid[1], textLinePath = 'M' + lineStartX + ',' + lineStartY, finalX = (pt.yLabelMax - pt.yLabelMin) * (pt.pxmid[0] < 0 ? -1 : 1) / 4; if(pt.labelExtraX) { var yFromX = pt.labelExtraX * pt.pxmid[1] / pt.pxmid[0], yNet = pt.yLabelMid + pt.labelExtraY - (pt.cyFinal + pt.pxmid[1]); if(Math.abs(yFromX) > Math.abs(yNet)) { textLinePath += 'l' + (yNet * pt.pxmid[0] / pt.pxmid[1]) + ',' + yNet + 'H' + (lineStartX + pt.labelExtraX + finalX); } else { textLinePath += 'l' + pt.labelExtraX + ',' + yFromX + 'v' + (yNet - yFromX) + 'h' + finalX; } } else { textLinePath += 'V' + (pt.yLabelMid + pt.labelExtraY) + 'h' + finalX; } sliceTop.append('path') .classed('textline', true) .call(Color.stroke, trace.outsidetextfont.color) .attr({ 'stroke-width': Math.min(2, trace.outsidetextfont.size / 8), d: textLinePath, fill: 'none' }); } }); }); }); // This is for a bug in Chrome (as of 2015-07-22, and does not affect FF) // if insidetextfont and outsidetextfont are different sizes, sometimes the size // of an "em" gets taken from the wrong element at first so lines are // spaced wrong. You just have to tell it to try again later and it gets fixed. // I have no idea why we haven't seen this in other contexts. Also, sometimes // it gets the initial draw correct but on redraw it gets confused. setTimeout(function() { pieGroups.selectAll('tspan').each(function() { var s = d3.select(this); if(s.attr('dy')) s.attr('dy', s.attr('dy')); }); }, 0); }; function transformInsideText(textBB, pt, cd0) { var textDiameter = Math.sqrt(textBB.width * textBB.width + textBB.height * textBB.height), textAspect = textBB.width / textBB.height, halfAngle = Math.PI * Math.min(pt.v / cd0.vTotal, 0.5), ring = 1 - cd0.trace.hole, rInscribed = getInscribedRadiusFraction(pt, cd0), // max size text can be inserted inside without rotating it // this inscribes the text rectangle in a circle, which is then inscribed // in the slice, so it will be an underestimate, which some day we may want // to improve so this case can get more use transform = { scale: rInscribed * cd0.r * 2 / textDiameter, // and the center position and rotation in this case rCenter: 1 - rInscribed, rotate: 0 }; if(transform.scale >= 1) return transform; // max size if text is rotated radially var Qr = textAspect + 1 / (2 * Math.tan(halfAngle)), maxHalfHeightRotRadial = cd0.r * Math.min( 1 / (Math.sqrt(Qr * Qr + 0.5) + Qr), ring / (Math.sqrt(textAspect * textAspect + ring / 2) + textAspect) ), radialTransform = { scale: maxHalfHeightRotRadial * 2 / textBB.height, rCenter: Math.cos(maxHalfHeightRotRadial / cd0.r) - maxHalfHeightRotRadial * textAspect / cd0.r, rotate: (180 / Math.PI * pt.midangle + 720) % 180 - 90 }, // max size if text is rotated tangentially aspectInv = 1 / textAspect, Qt = aspectInv + 1 / (2 * Math.tan(halfAngle)), maxHalfWidthTangential = cd0.r * Math.min( 1 / (Math.sqrt(Qt * Qt + 0.5) + Qt), ring / (Math.sqrt(aspectInv * aspectInv + ring / 2) + aspectInv) ), tangentialTransform = { scale: maxHalfWidthTangential * 2 / textBB.width, rCenter: Math.cos(maxHalfWidthTangential / cd0.r) - maxHalfWidthTangential / textAspect / cd0.r, rotate: (180 / Math.PI * pt.midangle + 810) % 180 - 90 }, // if we need a rotated transform, pick the biggest one // even if both are bigger than 1 rotatedTransform = tangentialTransform.scale > radialTransform.scale ? tangentialTransform : radialTransform; if(transform.scale < 1 && rotatedTransform.scale > transform.scale) return rotatedTransform; return transform; } function getInscribedRadiusFraction(pt, cd0) { if(pt.v === cd0.vTotal && !cd0.trace.hole) return 1;// special case of 100% with no hole var halfAngle = Math.PI * Math.min(pt.v / cd0.vTotal, 0.5); return Math.min(1 / (1 + 1 / Math.sin(halfAngle)), (1 - cd0.trace.hole) / 2); } function transformOutsideText(textBB, pt) { var x = pt.pxmid[0], y = pt.pxmid[1], dx = textBB.width / 2, dy = textBB.height / 2; if(x < 0) dx *= -1; if(y < 0) dy *= -1; return { scale: 1, rCenter: 1, rotate: 0, x: dx + Math.abs(dy) * (dx > 0 ? 1 : -1) / 2, y: dy / (1 + x * x / (y * y)), outside: true }; } function scootLabels(quadrants, trace) { var xHalf, yHalf, equatorFirst, farthestX, farthestY, xDiffSign, yDiffSign, thisQuad, oppositeQuad, wholeSide, i, thisQuadOutside, firstOppositeOutsidePt; function topFirst(a, b) { return a.pxmid[1] - b.pxmid[1]; } function bottomFirst(a, b) { return b.pxmid[1] - a.pxmid[1]; } function scootOneLabel(thisPt, prevPt) { if(!prevPt) prevPt = {}; var prevOuterY = prevPt.labelExtraY + (yHalf ? prevPt.yLabelMax : prevPt.yLabelMin), thisInnerY = yHalf ? thisPt.yLabelMin : thisPt.yLabelMax, thisOuterY = yHalf ? thisPt.yLabelMax : thisPt.yLabelMin, thisSliceOuterY = thisPt.cyFinal + farthestY(thisPt.px0[1], thisPt.px1[1]), newExtraY = prevOuterY - thisInnerY, xBuffer, i, otherPt, otherOuterY, otherOuterX, newExtraX; // make sure this label doesn't overlap other labels // this *only* has us move these labels vertically if(newExtraY * yDiffSign > 0) thisPt.labelExtraY = newExtraY; // make sure this label doesn't overlap any slices if(!Array.isArray(trace.pull)) return; // this can only happen with array pulls for(i = 0; i < wholeSide.length; i++) { otherPt = wholeSide[i]; // overlap can only happen if the other point is pulled more than this one if(otherPt === thisPt || ((trace.pull[thisPt.i] || 0) >= trace.pull[otherPt.i] || 0)) continue; if((thisPt.pxmid[1] - otherPt.pxmid[1]) * yDiffSign > 0) { // closer to the equator - by construction all of these happen first // move the text vertically to get away from these slices otherOuterY = otherPt.cyFinal + farthestY(otherPt.px0[1], otherPt.px1[1]); newExtraY = otherOuterY - thisInnerY - thisPt.labelExtraY; if(newExtraY * yDiffSign > 0) thisPt.labelExtraY += newExtraY; } else if((thisOuterY + thisPt.labelExtraY - thisSliceOuterY) * yDiffSign > 0) { // farther from the equator - happens after we've done all the // vertical moving we're going to do // move horizontally to get away from these more polar slices // if we're moving horz. based on a slice that's several slices away from this one // then we need some extra space for the lines to labels between them xBuffer = 3 * xDiffSign * Math.abs(i - wholeSide.indexOf(thisPt)); otherOuterX = otherPt.cxFinal + farthestX(otherPt.px0[0], otherPt.px1[0]); newExtraX = otherOuterX + xBuffer - (thisPt.cxFinal + thisPt.pxmid[0]) - thisPt.labelExtraX; if(newExtraX * xDiffSign > 0) thisPt.labelExtraX += newExtraX; } } } for(yHalf = 0; yHalf < 2; yHalf++) { equatorFirst = yHalf ? topFirst : bottomFirst; farthestY = yHalf ? Math.max : Math.min; yDiffSign = yHalf ? 1 : -1; for(xHalf = 0; xHalf < 2; xHalf++) { farthestX = xHalf ? Math.max : Math.min; xDiffSign = xHalf ? 1 : -1; // first sort the array // note this is a copy of cd, so cd itself doesn't get sorted // but we can still modify points in place. thisQuad = quadrants[yHalf][xHalf]; thisQuad.sort(equatorFirst); oppositeQuad = quadrants[1 - yHalf][xHalf]; wholeSide = oppositeQuad.concat(thisQuad); thisQuadOutside = []; for(i = 0; i < thisQuad.length; i++) { if(thisQuad[i].yLabelMid !== undefined) thisQuadOutside.push(thisQuad[i]); } firstOppositeOutsidePt = false; for(i = 0; yHalf && i < oppositeQuad.length; i++) { if(oppositeQuad[i].yLabelMid !== undefined) { firstOppositeOutsidePt = oppositeQuad[i]; break; } } // each needs to avoid the previous for(i = 0; i < thisQuadOutside.length; i++) { var prevPt = i && thisQuadOutside[i - 1]; // bottom half needs to avoid the first label of the top half // top half we still need to call scootOneLabel on the first slice // so we can avoid other slices, but we don't pass a prevPt if(firstOppositeOutsidePt && !i) prevPt = firstOppositeOutsidePt; scootOneLabel(thisQuadOutside[i], prevPt); } } } } function scalePies(cdpie, plotSize) { var pieBoxWidth, pieBoxHeight, i, j, cd0, trace, tiltAxisRads, maxPull, scaleGroups = [], scaleGroup, minPxPerValUnit; // first figure out the center and maximum radius for each pie for(i = 0; i < cdpie.length; i++) { cd0 = cdpie[i][0]; trace = cd0.trace; pieBoxWidth = plotSize.w * (trace.domain.x[1] - trace.domain.x[0]); pieBoxHeight = plotSize.h * (trace.domain.y[1] - trace.domain.y[0]); tiltAxisRads = trace.tiltaxis * Math.PI / 180; maxPull = trace.pull; if(Array.isArray(maxPull)) { maxPull = 0; for(j = 0; j < trace.pull.length; j++) { if(trace.pull[j] > maxPull) maxPull = trace.pull[j]; } } cd0.r = Math.min( pieBoxWidth / maxExtent(trace.tilt, Math.sin(tiltAxisRads), trace.depth), pieBoxHeight / maxExtent(trace.tilt, Math.cos(tiltAxisRads), trace.depth) ) / (2 + 2 * maxPull); cd0.cx = plotSize.l + plotSize.w * (trace.domain.x[1] + trace.domain.x[0])/2; cd0.cy = plotSize.t + plotSize.h * (2 - trace.domain.y[1] - trace.domain.y[0])/2; if(trace.scalegroup && scaleGroups.indexOf(trace.scalegroup) === -1) { scaleGroups.push(trace.scalegroup); } } // Then scale any pies that are grouped for(j = 0; j < scaleGroups.length; j++) { minPxPerValUnit = Infinity; scaleGroup = scaleGroups[j]; for(i = 0; i < cdpie.length; i++) { cd0 = cdpie[i][0]; if(cd0.trace.scalegroup === scaleGroup) { minPxPerValUnit = Math.min(minPxPerValUnit, cd0.r * cd0.r / cd0.vTotal); } } for(i = 0; i < cdpie.length; i++) { cd0 = cdpie[i][0]; if(cd0.trace.scalegroup === scaleGroup) { cd0.r = Math.sqrt(minPxPerValUnit * cd0.vTotal); } } } } function setCoords(cd) { var cd0 = cd[0], trace = cd0.trace, tilt = trace.tilt, tiltAxisRads, tiltAxisSin, tiltAxisCos, tiltRads, crossTilt, inPlane, currentAngle = trace.rotation * Math.PI / 180, angleFactor = 2 * Math.PI / cd0.vTotal, firstPt = 'px0', lastPt = 'px1', i, cdi, currentCoords; if(trace.direction === 'counterclockwise') { for(i = 0; i < cd.length; i++) { if(!cd[i].hidden) break; // find the first non-hidden slice } if(i === cd.length) return; // all slices hidden currentAngle += angleFactor * cd[i].v; angleFactor *= -1; firstPt = 'px1'; lastPt = 'px0'; } if(tilt) { tiltRads = tilt * Math.PI / 180; tiltAxisRads = trace.tiltaxis * Math.PI / 180; crossTilt = Math.sin(tiltAxisRads) * Math.cos(tiltAxisRads); inPlane = 1 - Math.cos(tiltRads); tiltAxisSin = Math.sin(tiltAxisRads); tiltAxisCos = Math.cos(tiltAxisRads); } function getCoords(angle) { var xFlat = cd0.r * Math.sin(angle), yFlat = -cd0.r * Math.cos(angle); if(!tilt) return [xFlat, yFlat]; return [ xFlat * (1 - inPlane * tiltAxisSin * tiltAxisSin) + yFlat * crossTilt * inPlane, xFlat * crossTilt * inPlane + yFlat * (1 - inPlane * tiltAxisCos * tiltAxisCos), Math.sin(tiltRads) * (yFlat * tiltAxisCos - xFlat * tiltAxisSin) ]; } currentCoords = getCoords(currentAngle); for(i = 0; i < cd.length; i++) { cdi = cd[i]; if(cdi.hidden) continue; cdi[firstPt] = currentCoords; currentAngle += angleFactor * cdi.v / 2; cdi.pxmid = getCoords(currentAngle); cdi.midangle = currentAngle; currentAngle += angleFactor * cdi.v / 2; currentCoords = getCoords(currentAngle); cdi[lastPt] = currentCoords; cdi.largeArc = (cdi.v > cd0.vTotal / 2) ? 1 : 0; } } function maxExtent(tilt, tiltAxisFraction, depth) { if(!tilt) return 1; var sinTilt = Math.sin(tilt * Math.PI / 180); return Math.max(0.01, // don't let it go crazy if you tilt the pie totally on its side depth * sinTilt * Math.abs(tiltAxisFraction) + 2 * Math.sqrt(1 - sinTilt * sinTilt * tiltAxisFraction * tiltAxisFraction)); } },{"../../components/color":299,"../../components/drawing":317,"../../lib/svg_text_utils":360,"../../plots/cartesian/graph_interact":374,"./helpers":494,"d3":70}],499:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var styleOne = require('./style_one'); module.exports = function style(gd) { gd._fullLayout._pielayer.selectAll('.trace').each(function(cd) { var cd0 = cd[0], trace = cd0.trace, traceSelection = d3.select(this); traceSelection.style({opacity: trace.opacity}); traceSelection.selectAll('.top path.surface').each(function(pt) { d3.select(this).call(styleOne, pt, trace); }); }); }; },{"./style_one":500,"d3":70}],500:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Color = require('../../components/color'); module.exports = function styleOne(s, pt, trace) { var lineColor = trace.marker.line.color; if(Array.isArray(lineColor)) lineColor = lineColor[pt.i] || Color.defaultLine; var lineWidth = trace.marker.line.width || 0; if(Array.isArray(lineWidth)) lineWidth = lineWidth[pt.i] || 0; s.style({ 'stroke-width': lineWidth, fill: pt.color }) .call(Color.stroke, lineColor); }; },{"../../components/color":299}],501:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); // arrayOk attributes, merge them into calcdata array module.exports = function arraysToCalcdata(cd) { var trace = cd[0].trace, marker = trace.marker; Lib.mergeArray(trace.text, cd, 'tx'); Lib.mergeArray(trace.textposition, cd, 'tp'); if(trace.textfont) { Lib.mergeArray(trace.textfont.size, cd, 'ts'); Lib.mergeArray(trace.textfont.color, cd, 'tc'); Lib.mergeArray(trace.textfont.family, cd, 'tf'); } if(marker && marker.line) { var markerLine = marker.line; Lib.mergeArray(marker.opacity, cd, 'mo'); Lib.mergeArray(marker.symbol, cd, 'mx'); Lib.mergeArray(marker.color, cd, 'mc'); Lib.mergeArray(markerLine.color, cd, 'mlc'); Lib.mergeArray(markerLine.width, cd, 'mlw'); } }; },{"../../lib":349}],502:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Drawing = require('../../components/drawing'); var constants = require('./constants'); module.exports = { x: { valType: 'data_array', }, x0: { valType: 'any', dflt: 0, }, dx: { valType: 'number', dflt: 1, }, y: { valType: 'data_array', }, y0: { valType: 'any', dflt: 0, }, dy: { valType: 'number', dflt: 1, }, text: { valType: 'string', dflt: '', arrayOk: true, }, mode: { valType: 'flaglist', flags: ['lines', 'markers', 'text'], extras: ['none'], }, line: { color: { valType: 'color', }, width: { valType: 'number', min: 0, dflt: 2, }, shape: { valType: 'enumerated', values: ['linear', 'spline', 'hv', 'vh', 'hvh', 'vhv'], dflt: 'linear', }, smoothing: { valType: 'number', min: 0, max: 1.3, dflt: 1, }, dash: { valType: 'string', // string type usually doesn't take values... this one should really be // a special type or at least a special coercion function, from the GUI // you only get these values but elsewhere the user can supply a list of // dash lengths in px, and it will be honored values: ['solid', 'dot', 'dash', 'longdash', 'dashdot', 'longdashdot'], dflt: 'solid', } }, connectgaps: { valType: 'boolean', dflt: false, }, fill: { valType: 'enumerated', values: ['none', 'tozeroy', 'tozerox', 'tonexty', 'tonextx'], dflt: 'none', }, fillcolor: { valType: 'color', }, marker: { symbol: { valType: 'enumerated', values: Drawing.symbolList, dflt: 'circle', arrayOk: true, }, opacity: { valType: 'number', min: 0, max: 1, arrayOk: true, }, size: { valType: 'number', min: 0, dflt: 6, arrayOk: true, }, color: { valType: 'color', arrayOk: true, }, maxdisplayed: { valType: 'number', min: 0, dflt: 0, }, sizeref: { valType: 'number', dflt: 1, }, sizemin: { valType: 'number', min: 0, dflt: 0, }, sizemode: { valType: 'enumerated', values: ['diameter', 'area'], dflt: 'diameter', }, colorscale: { valType: 'colorscale', }, cauto: { valType: 'boolean', dflt: true, }, cmax: { valType: 'number', dflt: null, }, cmin: { valType: 'number', dflt: null, }, autocolorscale: { valType: 'boolean', dflt: true, }, reversescale: { valType: 'boolean', dflt: false, }, showscale: { valType: 'boolean', dflt: false, }, line: { color: { valType: 'color', arrayOk: true, }, width: { valType: 'number', min: 0, arrayOk: true, }, colorscale: { valType: 'colorscale', }, cauto: { valType: 'boolean', dflt: true, }, cmax: { valType: 'number', dflt: null, }, cmin: { valType: 'number', dflt: null, }, autocolorscale: { valType: 'boolean', dflt: true, }, reversescale: { valType: 'boolean', dflt: false, } } }, textposition: { valType: 'enumerated', values: [ 'top left', 'top center', 'top right', 'middle left', 'middle center', 'middle right', 'bottom left', 'bottom center', 'bottom right' ], dflt: 'middle center', arrayOk: true, }, textfont: { family: { valType: 'string', noBlank: true, strict: true, arrayOk: true }, size: { valType: 'number', min: 1, arrayOk: true }, color: { valType: 'color', arrayOk: true }, }, r: { valType: 'data_array', }, t: { valType: 'data_array', }, _nestedModules: { // nested module coupling 'error_y': 'ErrorBars', 'error_x': 'ErrorBars', 'marker.colorbar': 'Colorbar' } }; },{"../../components/drawing":317,"./constants":506}],503:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); var Axes = require('../../plots/cartesian/axes'); var Lib = require('../../lib'); var subTypes = require('./subtypes'); var calcMarkerColorscale = require('./marker_colorscale_calc'); module.exports = function calc(gd, trace) { var xa = Axes.getFromId(gd, trace.xaxis || 'x'), ya = Axes.getFromId(gd, trace.yaxis || 'y'); Lib.markTime('in Scatter.calc'); var x = xa.makeCalcdata(trace, 'x'); Lib.markTime('finished convert x'); var y = ya.makeCalcdata(trace, 'y'); Lib.markTime('finished convert y'); var serieslen = Math.min(x.length, y.length), marker, s, i; // cancel minimum tick spacings (only applies to bars and boxes) xa._minDtick = 0; ya._minDtick = 0; if(x.length > serieslen) x.splice(serieslen, x.length - serieslen); if(y.length > serieslen) y.splice(serieslen, y.length - serieslen); // check whether bounds should be tight, padded, extended to zero... // most cases both should be padded on both ends, so start with that. var xOptions = {padded: true}, yOptions = {padded: true}; if(subTypes.hasMarkers(trace)) { // Treat size like x or y arrays --- Run d2c // this needs to go before ppad computation marker = trace.marker; s = marker.size; if(Array.isArray(s)) { // I tried auto-type but category and dates dont make much sense. var ax = {type: 'linear'}; Axes.setConvert(ax); s = ax.makeCalcdata(trace.marker, 'size'); if(s.length > serieslen) s.splice(serieslen, s.length - serieslen); } var sizeref = 1.6 * (trace.marker.sizeref || 1), markerTrans; if(trace.marker.sizemode === 'area') { markerTrans = function(v) { return Math.max(Math.sqrt((v || 0) / sizeref), 3); }; } else { markerTrans = function(v) { return Math.max((v || 0) / sizeref, 3); }; } xOptions.ppad = yOptions.ppad = Array.isArray(s) ? s.map(markerTrans) : markerTrans(s); } calcMarkerColorscale(trace); // TODO: text size // include zero (tight) and extremes (padded) if fill to zero // (unless the shape is closed, then it's just filling the shape regardless) if(((trace.fill === 'tozerox') || ((trace.fill === 'tonextx') && gd.firstscatter)) && ((x[0] !== x[serieslen - 1]) || (y[0] !== y[serieslen - 1]))) { xOptions.tozero = true; } // if no error bars, markers or text, or fill to y=0 remove x padding else if(!trace.error_y.visible && ( ['tonexty', 'tozeroy'].indexOf(trace.fill) !== -1 || (!subTypes.hasMarkers(trace) && !subTypes.hasText(trace)) )) { xOptions.padded = false; xOptions.ppad = 0; } // now check for y - rather different logic, though still mostly padded both ends // include zero (tight) and extremes (padded) if fill to zero // (unless the shape is closed, then it's just filling the shape regardless) if(((trace.fill === 'tozeroy') || ((trace.fill === 'tonexty') && gd.firstscatter)) && ((x[0] !== x[serieslen - 1]) || (y[0] !== y[serieslen - 1]))) { yOptions.tozero = true; } // tight y: any x fill else if(['tonextx', 'tozerox'].indexOf(trace.fill) !== -1) { yOptions.padded = false; } Lib.markTime('ready for Axes.expand'); Axes.expand(xa, x, xOptions); Lib.markTime('done expand x'); Axes.expand(ya, y, yOptions); Lib.markTime('done expand y'); // create the "calculated data" to plot var cd = new Array(serieslen); for(i = 0; i < serieslen; i++) { cd[i] = (isNumeric(x[i]) && isNumeric(y[i])) ? {x: x[i], y: y[i]} : {x: false, y: false}; } // this has migrated up from arraysToCalcdata as we have a reference to 's' here if(typeof s !== undefined) Lib.mergeArray(s, cd, 'ms'); gd.firstscatter = false; return cd; }; },{"../../lib":349,"../../plots/cartesian/axes":369,"./marker_colorscale_calc":515,"./subtypes":520,"fast-isnumeric":74}],504:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = function cleanData(fullData) { var i, tracei, filli, j, tracej; // remove opacity for any trace that has a fill or is filled to for(i = 0; i < fullData.length; i++) { tracei = fullData[i]; filli = tracei.fill; if((filli === 'none') || (tracei.type !== 'scatter')) continue; tracei.opacity = undefined; if(filli === 'tonexty' || filli === 'tonextx') { for(j = i - 1; j >= 0; j--) { tracej = fullData[j]; if((tracej.type === 'scatter') && (tracej.xaxis === tracei.xaxis) && (tracej.yaxis === tracei.yaxis)) { tracej.opacity = undefined; break; } } } } }; },{}],505:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var Plots = require('../../plots/plots'); var getColorscale = require('../../components/colorscale/get_scale'); var drawColorbar = require('../../components/colorbar/draw'); module.exports = function colorbar(gd, cd) { var trace = cd[0].trace, marker = trace.marker, cbId = 'cb' + trace.uid; gd._fullLayout._infolayer.selectAll('.' + cbId).remove(); // TODO unify Scatter.colorbar and Heatmap.colorbar // TODO make Plotly[module].colorbar support multiple colorbar per trace if((marker === undefined) || !marker.showscale) { Plots.autoMargin(gd, cbId); return; } var scl = getColorscale(marker.colorscale), vals = marker.color, cmin = marker.cmin, cmax = marker.cmax; if(!isNumeric(cmin)) cmin = Lib.aggNums(Math.min, null, vals); if(!isNumeric(cmax)) cmax = Lib.aggNums(Math.max, null, vals); var cb = cd[0].t.cb = drawColorbar(gd, cbId); cb.fillcolor(d3.scale.linear() .domain(scl.map(function(v) { return cmin + v[0] * (cmax - cmin); })) .range(scl.map(function(v) { return v[1]; }))) .filllevels({start: cmin, end: cmax, size: (cmax - cmin) / 254}) .options(marker.colorbar)(); Lib.markTime('done colorbar'); }; },{"../../components/colorbar/draw":302,"../../components/colorscale/get_scale":310,"../../lib":349,"../../plots/plots":413,"d3":70,"fast-isnumeric":74}],506:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; module.exports = { PTS_LINESONLY: 20 }; },{}],507:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var attributes = require('./attributes'); var constants = require('./constants'); var subTypes = require('./subtypes'); var handleXYDefaults = require('./xy_defaults'); var handleMarkerDefaults = require('./marker_defaults'); var handleLineDefaults = require('./line_defaults'); var handleTextDefaults = require('./text_defaults'); var handleFillColorDefaults = require('./fillcolor_defaults'); var errorBarsSupplyDefaults = require('../../components/errorbars/defaults'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } var len = handleXYDefaults(traceIn, traceOut, coerce), // TODO: default mode by orphan points... defaultMode = len < constants.PTS_LINESONLY ? 'lines+markers' : 'lines'; if(!len) { traceOut.visible = false; return; } coerce('text'); coerce('mode', defaultMode); if(subTypes.hasLines(traceOut)) { handleLineDefaults(traceIn, traceOut, defaultColor, coerce); lineShapeDefaults(traceIn, traceOut, coerce); coerce('connectgaps'); } if(subTypes.hasMarkers(traceOut)) { handleMarkerDefaults(traceIn, traceOut, defaultColor, layout, coerce); } if(subTypes.hasText(traceOut)) { handleTextDefaults(traceIn, traceOut, layout, coerce); } if(subTypes.hasMarkers(traceOut) || subTypes.hasText(traceOut)) { coerce('marker.maxdisplayed'); } coerce('fill'); if(traceOut.fill !== 'none') { handleFillColorDefaults(traceIn, traceOut, defaultColor, coerce); if(!subTypes.hasLines(traceOut)) lineShapeDefaults(traceIn, traceOut, coerce); } errorBarsSupplyDefaults(traceIn, traceOut, defaultColor, {axis: 'y'}); errorBarsSupplyDefaults(traceIn, traceOut, defaultColor, {axis: 'x', inherit: 'y'}); }; function lineShapeDefaults(traceIn, traceOut, coerce) { var shape = coerce('line.shape'); if(shape === 'spline') coerce('line.smoothing'); } },{"../../components/errorbars/defaults":322,"../../lib":349,"./attributes":502,"./constants":506,"./fillcolor_defaults":508,"./line_defaults":512,"./marker_defaults":516,"./subtypes":520,"./text_defaults":521,"./xy_defaults":522}],508:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Color = require('../../components/color'); // common to 'scatter' and 'scattergl' module.exports = function fillColorDefaults(traceIn, traceOut, defaultColor, coerce) { var inheritColorFromMarker = false; if(traceOut.marker) { // don't try to inherit a color array var markerColor = traceOut.marker.color, markerLineColor = (traceOut.marker.line || {}).color; if(markerColor && !Array.isArray(markerColor)) { inheritColorFromMarker = markerColor; } else if(markerLineColor && !Array.isArray(markerLineColor)) { inheritColorFromMarker = markerLineColor; } } coerce('fillcolor', Color.addOpacity( (traceOut.line || {}).color || inheritColorFromMarker || defaultColor, 0.5 )); }; },{"../../components/color":299}],509:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Color = require('../../components/color'); var subtypes = require('./subtypes'); module.exports = function getTraceColor(trace, di) { var lc, tc; // TODO: text modes if(trace.mode === 'lines') { lc = trace.line.color; return (lc && Color.opacity(lc)) ? lc : trace.fillcolor; } else if(trace.mode === 'none') { return trace.fill ? trace.fillcolor : ''; } else { var mc = di.mcc || (trace.marker || {}).color, mlc = di.mlcc || ((trace.marker || {}).line || {}).color; tc = (mc && Color.opacity(mc)) ? mc : (mlc && Color.opacity(mlc) && (di.mlw || ((trace.marker || {}).line || {}).width)) ? mlc : ''; if(tc) { // make sure the points aren't TOO transparent if(Color.opacity(tc) < 0.3) { return Color.addOpacity(tc, 0.3); } else return tc; } else { lc = (trace.line || {}).color; return (lc && Color.opacity(lc) && subtypes.hasLines(trace) && trace.line.width) ? lc : trace.fillcolor; } } }; },{"../../components/color":299,"./subtypes":520}],510:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Fx = require('../../plots/cartesian/graph_interact'); var ErrorBars = require('../../components/errorbars'); var getTraceColor = require('./get_trace_color'); module.exports = function hoverPoints(pointData, xval, yval, hovermode) { var cd = pointData.cd, trace = cd[0].trace, xa = pointData.xa, ya = pointData.ya, dx = function(di) { // scatter points: d.mrc is the calculated marker radius // adjust the distance so if you're inside the marker it // always will show up regardless of point size, but // prioritize smaller points var rad = Math.max(3, di.mrc || 0); return Math.max(Math.abs(xa.c2p(di.x)-xa.c2p(xval))-rad, 1-3/rad); }, dy = function(di) { var rad = Math.max(3, di.mrc || 0); return Math.max(Math.abs(ya.c2p(di.y)-ya.c2p(yval))-rad, 1-3/rad); }, dxy = function(di) { var rad = Math.max(3, di.mrc || 0), dx = Math.abs(xa.c2p(di.x)-xa.c2p(xval)), dy = Math.abs(ya.c2p(di.y)-ya.c2p(yval)); return Math.max(Math.sqrt(dx*dx + dy*dy)-rad, 1-3/rad); }, distfn = Fx.getDistanceFunction(hovermode, dx, dy, dxy); Fx.getClosest(cd, distfn, pointData); // skip the rest (for this trace) if we didn't find a close point if(pointData.index === false) return; // the closest data point var di = cd[pointData.index], xc = xa.c2p(di.x, true), yc = ya.c2p(di.y, true), rad = di.mrc || 1; pointData.color = getTraceColor(trace, di); pointData.x0 = xc - rad; pointData.x1 = xc + rad; pointData.xLabelVal = di.x; pointData.y0 = yc - rad; pointData.y1 = yc + rad; pointData.yLabelVal = di.y; if(di.tx) pointData.text = di.tx; else if(trace.text) pointData.text = trace.text; ErrorBars.hoverInfo(di, trace, pointData); return [pointData]; }; },{"../../components/errorbars":323,"../../plots/cartesian/graph_interact":374,"./get_trace_color":509}],511:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Scatter = {}; var subtypes = require('./subtypes'); Scatter.hasLines = subtypes.hasLines; Scatter.hasMarkers = subtypes.hasMarkers; Scatter.hasText = subtypes.hasText; Scatter.isBubble = subtypes.isBubble; // traces with < this many points are by default shown // with points and lines, > just get lines Scatter.attributes = require('./attributes'); Scatter.supplyDefaults = require('./defaults'); Scatter.cleanData = require('./clean_data'); Scatter.calc = require('./calc'); Scatter.arraysToCalcdata = require('./arrays_to_calcdata'); Scatter.plot = require('./plot'); Scatter.colorbar = require('./colorbar'); Scatter.style = require('./style'); Scatter.hoverPoints = require('./hover'); Scatter.selectPoints = require('./select'); Scatter.moduleType = 'trace'; Scatter.name = 'scatter'; Scatter.basePlotModule = require('../../plots/cartesian'); Scatter.categories = ['cartesian', 'symbols', 'markerColorscale', 'errorBarsOK', 'showLegend']; Scatter.meta = { }; module.exports = Scatter; },{"../../plots/cartesian":375,"./arrays_to_calcdata":501,"./attributes":502,"./calc":503,"./clean_data":504,"./colorbar":505,"./defaults":507,"./hover":510,"./plot":517,"./select":518,"./style":519,"./subtypes":520}],512:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; // common to 'scatter', 'scatter3d', 'scattergeo' and 'scattergl' module.exports = function lineDefaults(traceIn, traceOut, defaultColor, coerce) { var markerColor = (traceIn.marker || {}).color; // don't try to inherit a color array coerce('line.color', (Array.isArray(markerColor) ? false : markerColor) || defaultColor); coerce('line.width'); coerce('line.dash'); }; },{}],513:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Axes = require('../../plots/cartesian/axes'); module.exports = function linePoints(d, opts) { var xa = opts.xaxis, ya = opts.yaxis, connectGaps = opts.connectGaps, baseTolerance = opts.baseTolerance, linear = opts.linear, segments = [], badnum = Axes.BADNUM, minTolerance = 0.2, // fraction of tolerance "so close we don't even consider it a new point" pts = new Array(d.length), pti = 0, i, // pt variables are pixel coordinates [x,y] of one point clusterStartPt, // these four are the outputs of clustering on a line clusterEndPt, clusterHighPt, clusterLowPt, thisPt, // "this" is the next point we're considering adding to the cluster clusterRefDist, clusterHighFirst, // did we encounter the high point first, then a low point, or vice versa? clusterUnitVector, // the first two points in the cluster determine its unit vector // so the second is always in the "High" direction thisVector, // the pixel delta from clusterStartPt // val variables are (signed) pixel distances along the cluster vector clusterHighVal, clusterLowVal, thisVal, // deviation variables are (signed) pixel distances normal to the cluster vector clusterMinDeviation, clusterMaxDeviation, thisDeviation; // turn one calcdata point into pixel coordinates function getPt(index) { var x = xa.c2p(d[index].x), y = ya.c2p(d[index].y); if(x === badnum || y === badnum) return false; return [x, y]; } // if we're off-screen, increase tolerance over baseTolerance function getTolerance(pt) { var xFrac = pt[0] / xa._length, yFrac = pt[1] / ya._length; return (1 + 10 * Math.max(0, -xFrac, xFrac - 1, -yFrac, yFrac - 1)) * baseTolerance; } function ptDist(pt1, pt2) { var dx = pt1[0] - pt2[0], dy = pt1[1] - pt2[1]; return Math.sqrt(dx * dx + dy * dy); } // loop over ALL points in this trace for(i = 0; i < d.length; i++) { clusterStartPt = getPt(i); if(!clusterStartPt) continue; pti = 0; pts[pti++] = clusterStartPt; // loop over one segment of the trace for(i++; i < d.length; i++) { clusterHighPt = getPt(i); if(!clusterHighPt) { if(connectGaps) continue; else break; } // can't decimate if nonlinear line shape // TODO: we *could* decimate [hv]{2,3} shapes if we restricted clusters to horz or vert again // but spline would be verrry awkward to decimate if(!linear) { pts[pti++] = clusterHighPt; continue; } clusterRefDist = ptDist(clusterHighPt, clusterStartPt); if(clusterRefDist < getTolerance(clusterHighPt) * minTolerance) continue; clusterUnitVector = [ (clusterHighPt[0] - clusterStartPt[0]) / clusterRefDist, (clusterHighPt[1] - clusterStartPt[1]) / clusterRefDist ]; clusterLowPt = clusterStartPt; clusterHighVal = clusterRefDist; clusterLowVal = clusterMinDeviation = clusterMaxDeviation = 0; clusterHighFirst = false; clusterEndPt = clusterHighPt; // loop over one cluster of points that collapse onto one line for(i++; i < d.length; i++) { thisPt = getPt(i); if(!thisPt) { if(connectGaps) continue; else break; } thisVector = [ thisPt[0] - clusterStartPt[0], thisPt[1] - clusterStartPt[1] ]; // cross product (or dot with normal to the cluster vector) thisDeviation = thisVector[0] * clusterUnitVector[1] - thisVector[1] * clusterUnitVector[0]; clusterMinDeviation = Math.min(clusterMinDeviation, thisDeviation); clusterMaxDeviation = Math.max(clusterMaxDeviation, thisDeviation); if(clusterMaxDeviation - clusterMinDeviation > getTolerance(thisPt)) break; clusterEndPt = thisPt; thisVal = thisVector[0] * clusterUnitVector[0] + thisVector[1] * clusterUnitVector[1]; if(thisVal > clusterHighVal) { clusterHighVal = thisVal; clusterHighPt = thisPt; clusterHighFirst = false; } else if(thisVal < clusterLowVal) { clusterLowVal = thisVal; clusterLowPt = thisPt; clusterHighFirst = true; } } // insert this cluster into pts // we've already inserted the start pt, now check if we have high and low pts if(clusterHighFirst) { pts[pti++] = clusterHighPt; if(clusterEndPt !== clusterLowPt) pts[pti++] = clusterLowPt; } else { if(clusterLowPt !== clusterStartPt) pts[pti++] = clusterLowPt; if(clusterEndPt !== clusterHighPt) pts[pti++] = clusterHighPt; } // and finally insert the end pt pts[pti++] = clusterEndPt; // have we reached the end of this segment? if(i >= d.length || !thisPt) break; // otherwise we have an out-of-cluster point to insert as next clusterStartPt pts[pti++] = thisPt; clusterStartPt = thisPt; } segments.push(pts.slice(0, pti)); } return segments; }; },{"../../plots/cartesian/axes":369}],514:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var isNumeric = require('fast-isnumeric'); // used in the drawing step for 'scatter' and 'scattegeo' and // in the convert step for 'scatter3d' module.exports = function makeBubbleSizeFn(trace) { var marker = trace.marker, sizeRef = marker.sizeref || 1, sizeMin = marker.sizemin || 0; // for bubble charts, allow scaling the provided value linearly // and by area or diameter. // Note this only applies to the array-value sizes var baseFn = (marker.sizemode === 'area') ? function(v) { return Math.sqrt(v / sizeRef); } : function(v) { return v / sizeRef; }; // TODO add support for position/negative bubbles? // TODO add 'sizeoffset' attribute? return function(v) { var baseSize = baseFn(v / 2); // don't show non-numeric and negative sizes return (isNumeric(baseSize) && (baseSize > 0)) ? Math.max(baseSize, sizeMin) : 0; }; }; },{"fast-isnumeric":74}],515:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var hasColorscale = require('../../components/colorscale/has_colorscale'); var calcColorscale = require('../../components/colorscale/calc'); var subTypes = require('./subtypes'); // common to 'scatter', 'scatter3d' and 'scattergeo' module.exports = function calcMarkerColorscale(trace) { if(!subTypes.hasMarkers(trace)) return; var marker = trace.marker; // auto-z and autocolorscale if applicable if(hasColorscale(trace, 'marker')) { calcColorscale(trace, marker.color, 'marker', 'c'); } if(hasColorscale(trace, 'marker.line')) { calcColorscale(trace, marker.line.color, 'marker.line', 'c'); } }; },{"../../components/colorscale/calc":306,"../../components/colorscale/has_colorscale":311,"./subtypes":520}],516:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Color = require('../../components/color'); var hasColorscale = require('../../components/colorscale/has_colorscale'); var colorscaleDefaults = require('../../components/colorscale/defaults'); var subTypes = require('./subtypes'); // common to 'scatter', 'scatter3d', 'scattergeo' and 'scattergl' module.exports = function markerDefaults(traceIn, traceOut, defaultColor, layout, coerce) { var isBubble = subTypes.isBubble(traceIn), lineColor = (traceIn.line || {}).color, defaultMLC; if(lineColor) defaultColor = lineColor; coerce('marker.symbol'); coerce('marker.opacity', isBubble ? 0.7 : 1); coerce('marker.size'); coerce('marker.color', defaultColor); if(hasColorscale(traceIn, 'marker')) { colorscaleDefaults( traceIn, traceOut, layout, coerce, {prefix: 'marker.', cLetter: 'c'} ); } // if there's a line with a different color than the marker, use // that line color as the default marker line color // mostly this is for transparent markers to behave nicely if(lineColor && (traceOut.marker.color !== lineColor)) { defaultMLC = lineColor; } else if(isBubble) defaultMLC = Color.background; else defaultMLC = Color.defaultLine; coerce('marker.line.color', defaultMLC); if(hasColorscale(traceIn, 'marker.line')) { colorscaleDefaults( traceIn, traceOut, layout, coerce, {prefix: 'marker.line.', cLetter: 'c'} ); } coerce('marker.line.width', isBubble ? 1 : 0); if(isBubble) { coerce('marker.sizeref'); coerce('marker.sizemin'); coerce('marker.sizemode'); } }; },{"../../components/color":299,"../../components/colorscale/defaults":308,"../../components/colorscale/has_colorscale":311,"./subtypes":520}],517:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Lib = require('../../lib'); var Drawing = require('../../components/drawing'); var subTypes = require('./subtypes'); var arraysToCalcdata = require('./arrays_to_calcdata'); var linePoints = require('./line_points'); module.exports = function plot(gd, plotinfo, cdscatter) { selectMarkers(gd, plotinfo, cdscatter); var xa = plotinfo.x(), ya = plotinfo.y(); // make the container for scatter plots // (so error bars can find them along with bars) var scattertraces = plotinfo.plot.select('.scatterlayer') .selectAll('g.trace.scatter') .data(cdscatter); scattertraces.enter().append('g') .attr('class', 'trace scatter') .style('stroke-miterlimit', 2); // BUILD LINES AND FILLS var prevpath = '', tozero, tonext, nexttonext; scattertraces.each(function(d) { var trace = d[0].trace, line = trace.line, tr = d3.select(this); if(trace.visible !== true) return; d[0].node3 = tr; // store node for tweaking by selectPoints arraysToCalcdata(d); if(!subTypes.hasLines(trace) && trace.fill === 'none') return; var thispath, // fullpath is all paths for this curve, joined together straight // across gaps, for filling fullpath = '', // revpath is fullpath reversed, for fill-to-next revpath = '', // functions for converting a point array to a path pathfn, revpathbase, revpathfn; // make the fill-to-zero path now, so it shows behind the line // fill to next puts the fill associated with one trace // grouped with the previous if(trace.fill.substr(0, 6) === 'tozero' || (trace.fill.substr(0, 2) === 'to' && !prevpath)) { tozero = tr.append('path') .classed('js-fill', true); } else tozero = null; // make the fill-to-next path now for the NEXT trace, so it shows // behind both lines. // nexttonext was created last time, but give it // this curve's data for fill color if(nexttonext) tonext = nexttonext.datum(d); // now make a new nexttonext for next time nexttonext = tr.append('path').classed('js-fill', true); if(['hv', 'vh', 'hvh', 'vhv'].indexOf(line.shape) !== -1) { pathfn = Drawing.steps(line.shape); revpathbase = Drawing.steps( line.shape.split('').reverse().join('') ); } else if(line.shape === 'spline') { pathfn = revpathbase = function(pts) { return Drawing.smoothopen(pts, line.smoothing); }; } else { pathfn = revpathbase = function(pts) { return 'M' + pts.join('L'); }; } revpathfn = function(pts) { // note: this is destructive (reverses pts in place) so can't use pts after this return 'L' + revpathbase(pts.reverse()).substr(1); }; var segments = linePoints(d, { xaxis: xa, yaxis: ya, connectGaps: trace.connectgaps, baseTolerance: Math.max(line.width || 1, 3) / 4, linear: line.shape === 'linear' }); if(segments.length) { var pt0 = segments[0][0], lastSegment = segments[segments.length - 1], pt1 = lastSegment[lastSegment.length - 1]; for(var i = 0; i < segments.length; i++) { var pts = segments[i]; thispath = pathfn(pts); fullpath += fullpath ? ('L' + thispath.substr(1)) : thispath; revpath = revpathfn(pts) + revpath; if(subTypes.hasLines(trace) && pts.length > 1) { tr.append('path').classed('js-line', true).attr('d', thispath); } } if(tozero) { if(pt0 && pt1) { if(trace.fill.charAt(trace.fill.length - 1) === 'y') { pt0[1] = pt1[1] = ya.c2p(0, true); } else pt0[0] = pt1[0] = xa.c2p(0, true); // fill to zero: full trace path, plus extension of // the endpoints to the appropriate axis tozero.attr('d', fullpath + 'L' + pt1 + 'L' + pt0 + 'Z'); } } else if(trace.fill.substr(0, 6) === 'tonext' && fullpath && prevpath) { // fill to next: full trace path, plus the previous path reversed tonext.attr('d', fullpath + prevpath + 'Z'); } prevpath = revpath; } }); // remove paths that didn't get used scattertraces.selectAll('path:not([d])').remove(); function visFilter(d) { return d.filter(function(v) { return v.vis; }); } scattertraces.append('g') .attr('class', 'points') .each(function(d) { var trace = d[0].trace, s = d3.select(this), showMarkers = subTypes.hasMarkers(trace), showText = subTypes.hasText(trace); if((!showMarkers && !showText) || trace.visible !== true) s.remove(); else { if(showMarkers) { s.selectAll('path.point') .data(trace.marker.maxdisplayed ? visFilter : Lib.identity) .enter().append('path') .classed('point', true) .call(Drawing.translatePoints, xa, ya); } if(showText) { s.selectAll('g') .data(trace.marker.maxdisplayed ? visFilter : Lib.identity) // each text needs to go in its own 'g' in case // it gets converted to mathjax .enter().append('g') .append('text') .call(Drawing.translatePoints, xa, ya); } } }); }; function selectMarkers(gd, plotinfo, cdscatter) { var xa = plotinfo.x(), ya = plotinfo.y(), xr = d3.extent(xa.range.map(xa.l2c)), yr = d3.extent(ya.range.map(ya.l2c)); cdscatter.forEach(function(d, i) { var trace = d[0].trace; if(!subTypes.hasMarkers(trace)) return; // if marker.maxdisplayed is used, select a maximum of // mnum markers to show, from the set that are in the viewport var mnum = trace.marker.maxdisplayed; // TODO: remove some as we get away from the viewport? if(mnum === 0) return; var cd = d.filter(function(v) { return v.x>=xr[0] && v.x<=xr[1] && v.y>=yr[0] && v.y<=yr[1]; }), inc = Math.ceil(cd.length / mnum), tnum = 0; cdscatter.forEach(function(cdj, j) { var tracei = cdj[0].trace; if(subTypes.hasMarkers(tracei) && tracei.marker.maxdisplayed>0 && j= 0) textOffset[1] += 1; if(tp.indexOf('top') >= 0) textOffset[1] -= 1; if(tp.indexOf('left') >= 0) textOffset[0] -= 1; if(tp.indexOf('right') >= 0) textOffset[0] += 1; return textOffset; } function calculateSize(sizeIn, sizeFn) { // rough parity with Plotly 2D markers return sizeFn(sizeIn * 4); } function calculateSymbol(symbolIn) { return MARKER_SYMBOLS[symbolIn]; } function formatParam(paramIn, len, calculate, dflt, extraFn) { var paramOut = null; if(Array.isArray(paramIn)) { paramOut = []; for(var i = 0; i < len; i++) { if(paramIn[i]===undefined) paramOut[i] = dflt; else paramOut[i] = calculate(paramIn[i], extraFn); } } else paramOut = calculate(paramIn, Lib.identity); return paramOut; } function convertPlotlyOptions(scene, data) { var params, i, points = [], sceneLayout = scene.fullSceneLayout, scaleFactor = scene.dataScale, xaxis = sceneLayout.xaxis, yaxis = sceneLayout.yaxis, zaxis = sceneLayout.zaxis, marker = data.marker, line = data.line, xc, x = data.x || [], yc, y = data.y || [], zc, z = data.z || [], len = x.length, text; //Convert points for(i = 0; i < len; i++) { // sanitize numbers and apply transforms based on axes.type xc = xaxis.d2l(x[i]) * scaleFactor[0]; yc = yaxis.d2l(y[i]) * scaleFactor[1]; zc = zaxis.d2l(z[i]) * scaleFactor[2]; points[i] = [xc, yc, zc]; } // convert text if(Array.isArray(data.text)) text = data.text; else if(data.text !== undefined) { text = new Array(len); for(i = 0; i < len; i++) text[i] = data.text; } //Build object parameters params = { position: points, mode: data.mode, text: text }; if('line' in data) { params.lineColor = str2RgbaArray(line.color); params.lineWidth = line.width; params.lineDashes = line.dash; } if('marker' in data) { var sizeFn = makeBubbleSizeFn(data); params.scatterColor = formatColor(marker, 1, len); params.scatterSize = formatParam(marker.size, len, calculateSize, 20, sizeFn); params.scatterMarker = formatParam(marker.symbol, len, calculateSymbol, '●'); params.scatterLineWidth = marker.line.width; // arrayOk === false params.scatterLineColor = formatColor(marker.line, 1, len); params.scatterAngle = 0; } if('textposition' in data) { params.textOffset = calculateTextOffset(data.textposition); // arrayOk === false params.textColor = formatColor(data.textfont, 1, len); params.textSize = formatParam(data.textfont.size, len, Lib.identity, 12); params.textFont = data.textfont.family; // arrayOk === false params.textAngle = 0; } var dims = ['x', 'y', 'z']; params.project = [false, false, false]; params.projectScale = [1,1,1]; params.projectOpacity = [1,1,1]; for(i = 0; i < 3; ++i) { var projection = data.projection[dims[i]]; if((params.project[i] = projection.show)) { params.projectOpacity[i] = projection.opacity; params.projectScale[i] = projection.scale; } } params.errorBounds = calculateError(data, scaleFactor); var errorParams = calculateErrorParams([data.error_x, data.error_y, data.error_z]); params.errorColor = errorParams.color; params.errorLineWidth = errorParams.lineWidth; params.errorCapSize = errorParams.capSize; params.delaunayAxis = data.surfaceaxis; params.delaunayColor = str2RgbaArray(data.surfacecolor); return params; } function arrayToColor(color) { if(Array.isArray(color)) { var c = color[0]; if(Array.isArray(c)) color = c; return 'rgb(' + color.slice(0,3).map(function(x) { return Math.round(x*255); }) + ')'; } return null; } proto.update = function(data) { var gl = this.scene.glplot.gl, lineOptions, scatterOptions, errorOptions, textOptions, dashPattern = DASH_PATTERNS.solid; //Save data this.data = data; //Run data conversion var options = convertPlotlyOptions(this.scene, data); if('mode' in options) { this.mode = options.mode; } if('lineDashes' in options) { if(options.lineDashes in DASH_PATTERNS) { dashPattern = DASH_PATTERNS[options.lineDashes]; } } this.color = arrayToColor(options.scatterColor) || arrayToColor(options.lineColor); //Save data points this.dataPoints = options.position; lineOptions = { gl: gl, position: options.position, color: options.lineColor, lineWidth: options.lineWidth || 1, dashes: dashPattern[0], dashScale: dashPattern[1], opacity: data.opacity }; if(this.mode.indexOf('lines') !== -1) { if(this.linePlot) this.linePlot.update(lineOptions); else { this.linePlot = createLinePlot(lineOptions); this.scene.glplot.add(this.linePlot); } } else if(this.linePlot) { this.scene.glplot.remove(this.linePlot); this.linePlot.dispose(); this.linePlot = null; } // N.B. marker.opacity must be a scalar for performance var scatterOpacity = data.opacity; if(data.marker && data.marker.opacity) scatterOpacity *= data.marker.opacity; scatterOptions = { gl: gl, position: options.position, color: options.scatterColor, size: options.scatterSize, glyph: options.scatterMarker, opacity: scatterOpacity, orthographic: true, lineWidth: options.scatterLineWidth, lineColor: options.scatterLineColor, project: options.project, projectScale: options.projectScale, projectOpacity: options.projectOpacity }; if(this.mode.indexOf('markers') !== -1) { if(this.scatterPlot) this.scatterPlot.update(scatterOptions); else { this.scatterPlot = createScatterPlot(scatterOptions); this.scatterPlot.highlightScale = 1; this.scene.glplot.add(this.scatterPlot); } } else if(this.scatterPlot) { this.scene.glplot.remove(this.scatterPlot); this.scatterPlot.dispose(); this.scatterPlot = null; } textOptions = { gl: gl, position: options.position, glyph: options.text, color: options.textColor, size: options.textSize, angle: options.textAngle, alignment: options.textOffset, font: options.textFont, orthographic: true, lineWidth: 0, project: false, opacity: data.opacity }; this.textLabels = options.text; if(this.mode.indexOf('text') !== -1) { if(this.textMarkers) this.textMarkers.update(textOptions); else { this.textMarkers = createScatterPlot(textOptions); this.textMarkers.highlightScale = 1; this.scene.glplot.add(this.textMarkers); } } else if(this.textMarkers) { this.scene.glplot.remove(this.textMarkers); this.textMarkers.dispose(); this.textMarkers = null; } errorOptions = { gl: gl, position: options.position, color: options.errorColor, error: options.errorBounds, lineWidth: options.errorLineWidth, capSize: options.errorCapSize, opacity: data.opacity }; if(this.errorBars) { if(options.errorBounds) { this.errorBars.update(errorOptions); } else { this.scene.glplot.remove(this.errorBars); this.errorBars.dispose(); this.errorBars = null; } } else if(options.errorBounds) { this.errorBars = createErrorBars(errorOptions); this.scene.glplot.add(this.errorBars); } if(options.delaunayAxis >= 0) { var delaunayOptions = constructDelaunay( options.position, options.delaunayColor, options.delaunayAxis); if(this.delaunayMesh) { this.delaunayMesh.update(delaunayOptions); } else { delaunayOptions.gl = gl; this.delaunayMesh = createMesh(delaunayOptions); this.scene.glplot.add(this.delaunayMesh); } } else if(this.delaunayMesh) { this.scene.glplot.remove(this.delaunayMesh); this.delaunayMesh.dispose(); this.delaunayMesh = null; } }; proto.dispose = function() { if(this.linePlot) { this.scene.glplot.remove(this.linePlot); this.linePlot.dispose(); } if(this.scatterPlot) { this.scene.glplot.remove(this.scatterPlot); this.scatterPlot.dispose(); } if(this.errorBars) { this.scene.remove(this.errorBars); this.errorBars.dispose(); } if(this.textMarkers) { this.scene.glplot.remove(this.textMarkers); this.textMarkers.dispose(); } if(this.delaunayMesh) { this.scene.glplot.remove(this.textMarkers); this.delaunayMesh.dispose(); } }; function createLineWithMarkers(scene, data) { var plot = new LineWithMarkers(scene, data.uid); plot.update(data); return plot; } module.exports = createLineWithMarkers; },{"../../constants/gl3d_dashes":336,"../../constants/gl_markers":337,"../../lib":349,"../../lib/gl_format_color":347,"../../lib/str2rgbarray":359,"../scatter/make_bubble_size_func":514,"./calc_errors":525,"delaunay-triangulate":71,"gl-error3d":78,"gl-line3d":84,"gl-mesh3d":107,"gl-scatter3d":150}],527:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var subTypes = require('../scatter/subtypes'); var handleMarkerDefaults = require('../scatter/marker_defaults'); var handleLineDefaults = require('../scatter/line_defaults'); var handleTextDefaults = require('../scatter/text_defaults'); var errorBarsSupplyDefaults = require('../../components/errorbars/defaults'); var attributes = require('./attributes'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } var len = handleXYZDefaults(traceIn, traceOut, coerce); if(!len) { traceOut.visible = false; return; } coerce('text'); coerce('mode'); if(subTypes.hasLines(traceOut)) { handleLineDefaults(traceIn, traceOut, defaultColor, coerce); } if(subTypes.hasMarkers(traceOut)) { handleMarkerDefaults(traceIn, traceOut, defaultColor, layout, coerce); } if(subTypes.hasText(traceOut)) { handleTextDefaults(traceIn, traceOut, layout, coerce); } var lineColor = (traceOut.line || {}).color , markerColor = (traceOut.marker || {}).color; if(coerce('surfaceaxis') >= 0) coerce('surfacecolor', lineColor || markerColor); var dims = ['x', 'y', 'z']; for(var i = 0; i < 3; ++i) { var projection = 'projection.' + dims[i]; if(coerce(projection + '.show')) { coerce(projection + '.opacity'); coerce(projection + '.scale'); } } errorBarsSupplyDefaults(traceIn, traceOut, defaultColor, {axis: 'z'}); errorBarsSupplyDefaults(traceIn, traceOut, defaultColor, {axis: 'y', inherit: 'z'}); errorBarsSupplyDefaults(traceIn, traceOut, defaultColor, {axis: 'x', inherit: 'z'}); }; function handleXYZDefaults(traceIn, traceOut, coerce) { var len = 0, x = coerce('x'), y = coerce('y'), z = coerce('z'); if(x && y && z) { len = Math.min(x.length, y.length, z.length); if(len < x.length) traceOut.x = x.slice(0, len); if(len < y.length) traceOut.y = y.slice(0, len); if(len < z.length) traceOut.z = z.slice(0, len); } return len; } },{"../../components/errorbars/defaults":322,"../../lib":349,"../scatter/line_defaults":512,"../scatter/marker_defaults":516,"../scatter/subtypes":520,"../scatter/text_defaults":521,"./attributes":523}],528:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Scatter3D = {}; Scatter3D.plot = require('./convert'); Scatter3D.attributes = require('./attributes'); Scatter3D.markerSymbols = require('../../constants/gl_markers'); Scatter3D.supplyDefaults = require('./defaults'); Scatter3D.colorbar = require('../scatter/colorbar'); Scatter3D.calc = require('./calc'); Scatter3D.moduleType = 'trace'; Scatter3D.name = 'scatter3d'; Scatter3D.basePlotModule = require('../../plots/gl3d'); Scatter3D.categories = ['gl3d', 'symbols', 'markerColorscale', 'showLegend']; Scatter3D.meta = { }; module.exports = Scatter3D; },{"../../constants/gl_markers":337,"../../plots/gl3d":400,"../scatter/colorbar":505,"./attributes":523,"./calc":524,"./convert":526,"./defaults":527}],529:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var scatterAttrs = require('../scatter/attributes'); var plotAttrs = require('../../plots/attributes'); var extendFlat = require('../../lib/extend').extendFlat; var scatterMarkerAttrs = scatterAttrs.marker, scatterLineAttrs = scatterAttrs.line, scatterMarkerLineAttrs = scatterMarkerAttrs.line; module.exports = { lon: { valType: 'data_array', }, lat: { valType: 'data_array', }, locations: { valType: 'data_array', }, locationmode: { valType: 'enumerated', values: ['ISO-3', 'USA-states', 'country names'], dflt: 'ISO-3', }, mode: extendFlat({}, scatterAttrs.mode, {dflt: 'markers'}), text: extendFlat({}, scatterAttrs.text, { }), line: { color: scatterLineAttrs.color, width: scatterLineAttrs.width, dash: scatterLineAttrs.dash }, marker: { symbol: scatterMarkerAttrs.symbol, opacity: scatterMarkerAttrs.opacity, size: scatterMarkerAttrs.size, sizeref: scatterMarkerAttrs.sizeref, sizemin: scatterMarkerAttrs.sizemin, sizemode: scatterMarkerAttrs.sizemode, color: scatterMarkerAttrs.color, colorscale: scatterMarkerAttrs.colorscale, cauto: scatterMarkerAttrs.cauto, cmax: scatterMarkerAttrs.cmax, cmin: scatterMarkerAttrs.cmin, autocolorscale: scatterMarkerAttrs.autocolorscale, reversescale: scatterMarkerAttrs.reversescale, showscale: scatterMarkerAttrs.showscale, line: { color: scatterMarkerLineAttrs.color, width: scatterMarkerLineAttrs.width, colorscale: scatterMarkerLineAttrs.colorscale, cauto: scatterMarkerLineAttrs.cauto, cmax: scatterMarkerLineAttrs.cmax, cmin: scatterMarkerLineAttrs.cmin, autocolorscale: scatterMarkerLineAttrs.autocolorscale, reversescale: scatterMarkerLineAttrs.reversescale } }, textfont: scatterAttrs.textfont, textposition: scatterAttrs.textposition, hoverinfo: extendFlat({}, plotAttrs.hoverinfo, { flags: ['lon', 'lat', 'location', 'text', 'name'] }), _nestedModules: { 'marker.colorbar': 'Colorbar' } }; },{"../../lib/extend":345,"../../plots/attributes":367,"../scatter/attributes":502}],530:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var calcMarkerColorscale = require('../scatter/marker_colorscale_calc'); module.exports = function calc(gd, trace) { var cd = [{x: false, y: false, trace: trace, t: {}}]; calcMarkerColorscale(trace); return cd; }; },{"../scatter/marker_colorscale_calc":515}],531:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var subTypes = require('../scatter/subtypes'); var handleMarkerDefaults = require('../scatter/marker_defaults'); var handleLineDefaults = require('../scatter/line_defaults'); var handleTextDefaults = require('../scatter/text_defaults'); var attributes = require('./attributes'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } var len = handleLonLatLocDefaults(traceIn, traceOut, coerce); if(!len) { traceOut.visible = false; return; } coerce('text'); coerce('mode'); if(subTypes.hasLines(traceOut)) { handleLineDefaults(traceIn, traceOut, defaultColor, coerce); } if(subTypes.hasMarkers(traceOut)) { handleMarkerDefaults(traceIn, traceOut, defaultColor, layout, coerce); } if(subTypes.hasText(traceOut)) { handleTextDefaults(traceIn, traceOut, layout, coerce); } coerce('hoverinfo', (layout._dataLength === 1) ? 'lon+lat+location+text' : undefined); }; function handleLonLatLocDefaults(traceIn, traceOut, coerce) { var len = 0, locations = coerce('locations'); var lon, lat; if(locations) { coerce('locationmode'); len = locations.length; return len; } lon = coerce('lon') || []; lat = coerce('lat') || []; len = Math.min(lon.length, lat.length); if(len < lon.length) traceOut.lon = lon.slice(0, len); if(len < lat.length) traceOut.lat = lat.slice(0, len); return len; } },{"../../lib":349,"../scatter/line_defaults":512,"../scatter/marker_defaults":516,"../scatter/subtypes":520,"../scatter/text_defaults":521,"./attributes":529}],532:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var ScatterGeo = {}; ScatterGeo.attributes = require('./attributes'); ScatterGeo.supplyDefaults = require('./defaults'); ScatterGeo.colorbar = require('../scatter/colorbar'); ScatterGeo.calc = require('./calc'); ScatterGeo.plot = require('./plot').plot; ScatterGeo.moduleType = 'trace'; ScatterGeo.name = 'scattergeo'; ScatterGeo.basePlotModule = require('../../plots/geo'); ScatterGeo.categories = ['geo', 'symbols', 'markerColorscale', 'showLegend']; ScatterGeo.meta = { }; module.exports = ScatterGeo; },{"../../plots/geo":385,"../scatter/colorbar":505,"./attributes":529,"./calc":530,"./defaults":531,"./plot":533}],533:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var d3 = require('d3'); var Fx = require('../../plots/cartesian/graph_interact'); var Axes = require('../../plots/cartesian/axes'); var getTopojsonFeatures = require('../../lib/topojson_utils').getTopojsonFeatures; var locationToFeature = require('../../lib/geo_location_utils').locationToFeature; var arrayToCalcItem = require('../../lib/array_to_calc_item'); var Color = require('../../components/color'); var Drawing = require('../../components/drawing'); var subTypes = require('../scatter/subtypes'); var attributes = require('./attributes'); var plotScatterGeo = module.exports = {}; plotScatterGeo.calcGeoJSON = function(trace, topojson) { var cdi = [], hasLocationData = Array.isArray(trace.locations); var len, features, getLonLat, locations; if(hasLocationData) { locations = trace.locations; len = locations.length; features = getTopojsonFeatures(trace, topojson); getLonLat = function(trace, i) { var feature = locationToFeature(trace.locationmode, locations[i], features); return (feature !== undefined) ? feature.properties.ct : undefined; }; } else { len = trace.lon.length; getLonLat = function(trace, i) { return [trace.lon[i], trace.lat[i]]; }; } for(var i = 0; i < len; i++) { var lonlat = getLonLat(trace, i); if(!lonlat) continue; // filter the blank points here var calcItem = { lon: lonlat[0], lat: lonlat[1], location: hasLocationData ? trace.locations[i] : null }; arrayItemToCalcdata(trace, calcItem, i); cdi.push(calcItem); } if(cdi.length > 0) cdi[0].trace = trace; return cdi; }; // similar Scatter.arraysToCalcdata but inside a filter loop function arrayItemToCalcdata(trace, calcItem, i) { var marker = trace.marker; function merge(traceAttr, calcAttr) { arrayToCalcItem(traceAttr, calcItem, calcAttr, i); } merge(trace.text, 'tx'); merge(trace.textposition, 'tp'); if(trace.textfont) { merge(trace.textfont.size, 'ts'); merge(trace.textfont.color, 'tc'); merge(trace.textfont.family, 'tf'); } if(marker && marker.line) { var markerLine = marker.line; merge(marker.opacity, 'mo'); merge(marker.symbol, 'mx'); merge(marker.color, 'mc'); merge(marker.size, 'ms'); merge(markerLine.color, 'mlc'); merge(markerLine.width, 'mlw'); } } function makeLineGeoJSON(trace) { var N = trace.lon.length, coordinates = new Array(N); for(var i = 0; i < N; i++) { coordinates[i] = [trace.lon[i], trace.lat[i]]; } return { type: 'LineString', coordinates: coordinates, trace: trace }; } plotScatterGeo.plot = function(geo, scattergeoData) { var gScatterGeoTraces = geo.framework.select('.scattergeolayer') .selectAll('g.trace.scattergeo') .data(scattergeoData, function(trace) { return trace.uid; }); gScatterGeoTraces.enter().append('g') .attr('class', 'trace scattergeo'); gScatterGeoTraces.exit().remove(); // TODO add hover - how? gScatterGeoTraces .each(function(trace) { if(!subTypes.hasLines(trace)) return; d3.select(this) .append('path') .datum(makeLineGeoJSON(trace)) .attr('class', 'js-line'); }); gScatterGeoTraces.append('g') .attr('class', 'points') .each(function(trace) { var s = d3.select(this), showMarkers = subTypes.hasMarkers(trace), showText = subTypes.hasText(trace); if((!showMarkers && !showText)) return; var cdi = plotScatterGeo.calcGeoJSON(trace, geo.topojson), cleanHoverLabelsFunc = makeCleanHoverLabelsFunc(geo, trace), eventDataFunc = makeEventDataFunc(trace); var hoverinfo = trace.hoverinfo, hasNameLabel = ( hoverinfo === 'all' || hoverinfo.indexOf('name') !== -1 ); function handleMouseOver(pt, ptIndex) { if(!geo.showHover) return; var xy = geo.projection([pt.lon, pt.lat]); cleanHoverLabelsFunc(pt); Fx.loneHover({ x: xy[0], y: xy[1], name: hasNameLabel ? trace.name : undefined, text: pt.textLabel, color: pt.mc || (trace.marker || {}).color }, { container: geo.hoverContainer.node() }); geo.graphDiv.emit('plotly_hover', eventDataFunc(pt, ptIndex)); } function handleClick(pt, ptIndex) { geo.graphDiv.emit('plotly_click', eventDataFunc(pt, ptIndex)); } if(showMarkers) { s.selectAll('path.point') .data(cdi) .enter().append('path') .attr('class', 'point') .on('mouseover', handleMouseOver) .on('click', handleClick) .on('mouseout', function() { Fx.loneUnhover(geo.hoverContainer); }) .on('mousedown', function() { // to simulate the 'zoomon' event Fx.loneUnhover(geo.hoverContainer); }) .on('mouseup', handleMouseOver); // ~ 'zoomend' } if(showText) { s.selectAll('g') .data(cdi) .enter().append('g') .append('text'); } }); plotScatterGeo.style(geo); }; plotScatterGeo.style = function(geo) { var selection = geo.framework.selectAll('g.trace.scattergeo'); selection.style('opacity', function(trace) { return trace.opacity; }); selection.selectAll('g.points') .each(function(trace) { d3.select(this).selectAll('path.point') .call(Drawing.pointStyle, trace); d3.select(this).selectAll('text') .call(Drawing.textPointStyle, trace); }); // GeoJSON calc data is incompatible with Drawing.lineGroupStyle selection.selectAll('path.js-line') .style('fill', 'none') .each(function(d) { var trace = d.trace, line = trace.line || {}; d3.select(this) .call(Color.stroke, line.color) .call(Drawing.dashLine, line.dash || '', line.width || 0); }); }; function makeCleanHoverLabelsFunc(geo, trace) { var hoverinfo = trace.hoverinfo; if(hoverinfo === 'none') { return function cleanHoverLabelsFunc(d) { delete d.textLabel; }; } var hoverinfoParts = (hoverinfo === 'all') ? attributes.hoverinfo.flags : hoverinfo.split('+'); var hasLocation = ( hoverinfoParts.indexOf('location') !== -1 && Array.isArray(trace.locations) ), hasLon = (hoverinfoParts.indexOf('lon') !== -1), hasLat = (hoverinfoParts.indexOf('lat') !== -1), hasText = (hoverinfoParts.indexOf('text') !== -1); function formatter(val) { var axis = geo.mockAxis; return Axes.tickText(axis, axis.c2l(val), 'hover').text + '\u00B0'; } return function cleanHoverLabelsFunc(pt) { var thisText = []; if(hasLocation) thisText.push(pt.location); else if(hasLon && hasLat) { thisText.push('(' + formatter(pt.lon) + ', ' + formatter(pt.lat) + ')'); } else if(hasLon) thisText.push('lon: ' + formatter(pt.lon)); else if(hasLat) thisText.push('lat: ' + formatter(pt.lat)); if(hasText) thisText.push(pt.tx || trace.text); pt.textLabel = thisText.join('
'); }; } function makeEventDataFunc(trace) { var hasLocation = Array.isArray(trace.locations); return function(pt, ptIndex) { return {points: [{ data: trace._input, fullData: trace, curveNumber: trace.index, pointNumber: ptIndex, lon: pt.lon, lat: pt.lat, location: hasLocation ? pt.location : null }]}; }; } },{"../../components/color":299,"../../components/drawing":317,"../../lib/array_to_calc_item":341,"../../lib/geo_location_utils":346,"../../lib/topojson_utils":361,"../../plots/cartesian/axes":369,"../../plots/cartesian/graph_interact":374,"../scatter/subtypes":520,"./attributes":529,"d3":70}],534:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var scatterAttrs = require('../scatter/attributes'); var DASHES = require('../../constants/gl2d_dashes'); var MARKERS = require('../../constants/gl_markers'); var extendFlat = require('../../lib/extend').extendFlat; var scatterLineAttrs = scatterAttrs.line, scatterMarkerAttrs = scatterAttrs.marker, scatterMarkerLineAttrs = scatterMarkerAttrs.line; module.exports = { x: scatterAttrs.x, x0: scatterAttrs.x0, dx: scatterAttrs.dx, y: scatterAttrs.y, y0: scatterAttrs.y0, dy: scatterAttrs.dy, text: extendFlat({}, scatterAttrs.text, { }), mode: { valType: 'flaglist', flags: ['lines', 'markers'], extras: ['none'], }, line: { color: scatterLineAttrs.color, width: scatterLineAttrs.width, dash: { valType: 'enumerated', values: Object.keys(DASHES), dflt: 'solid', } }, marker: { color: scatterMarkerAttrs.color, symbol: { valType: 'enumerated', values: Object.keys(MARKERS), dflt: 'circle', arrayOk: true, }, size: scatterMarkerAttrs.size, sizeref: scatterMarkerAttrs.sizeref, sizemin: scatterMarkerAttrs.sizemin, sizemode: scatterMarkerAttrs.sizemode, opacity: scatterMarkerAttrs.opacity, colorscale: scatterMarkerAttrs.colorscale, cauto: scatterMarkerAttrs.cauto, cmax: scatterMarkerAttrs.cmax, cmin: scatterMarkerAttrs.cmin, autocolorscale: scatterMarkerAttrs.autocolorscale, reversescale: scatterMarkerAttrs.reversescale, showscale: scatterMarkerAttrs.showscale, line: { color: scatterMarkerLineAttrs.color, width: scatterMarkerLineAttrs.width, colorscale: scatterMarkerLineAttrs.colorscale, cauto: scatterMarkerLineAttrs.cauto, cmax: scatterMarkerLineAttrs.cmax, cmin: scatterMarkerLineAttrs.cmin, autocolorscale: scatterMarkerLineAttrs.autocolorscale, reversescale: scatterMarkerLineAttrs.reversescale } }, fill: extendFlat({}, scatterAttrs.fill, { values: ['none', 'tozeroy', 'tozerox'] }), fillcolor: scatterAttrs.fillcolor, _nestedModules: { 'error_x': 'ErrorBars', 'error_y': 'ErrorBars', 'marker.colorbar': 'Colorbar' } }; },{"../../constants/gl2d_dashes":335,"../../constants/gl_markers":337,"../../lib/extend":345,"../scatter/attributes":502}],535:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var createScatter = require('gl-scatter2d'); var createFancyScatter = require('gl-scatter2d-fancy'); var createLine = require('gl-line2d'); var createError = require('gl-error2d'); var isNumeric = require('fast-isnumeric'); var Lib = require('../../lib'); var Axes = require('../../plots/cartesian/axes'); var ErrorBars = require('../../components/errorbars'); var str2RGBArray = require('../../lib/str2rgbarray'); var formatColor = require('../../lib/gl_format_color'); var subTypes = require('../scatter/subtypes'); var makeBubbleSizeFn = require('../scatter/make_bubble_size_func'); var getTraceColor = require('../scatter/get_trace_color'); var MARKER_SYMBOLS = require('../../constants/gl_markers'); var DASHES = require('../../constants/gl2d_dashes'); var AXES = ['xaxis', 'yaxis']; function LineWithMarkers(scene, uid) { this.scene = scene; this.uid = uid; this.xData = []; this.yData = []; this.textLabels = []; this.color = 'rgb(0, 0, 0)'; this.name = ''; this.hoverinfo = 'all'; this.idToIndex = []; this.bounds = [0, 0, 0, 0]; this.hasLines = false; this.lineOptions = { positions: new Float32Array(), color: [0, 0, 0, 1], width: 1, fill: [false, false, false, false], fillColor: [ [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1], [0, 0, 0, 1]], dashes: [1] }; this.line = createLine(scene.glplot, this.lineOptions); this.line._trace = this; this.hasErrorX = false; this.errorXOptions = { positions: new Float32Array(), errors: new Float32Array(), lineWidth: 1, capSize: 0, color: [0, 0, 0, 1] }; this.errorX = createError(scene.glplot, this.errorXOptions); this.errorX._trace = this; this.hasErrorY = false; this.errorYOptions = { positions: new Float32Array(), errors: new Float32Array(), lineWidth: 1, capSize: 0, color: [0, 0, 0, 1] }; this.errorY = createError(scene.glplot, this.errorYOptions); this.errorY._trace = this; this.hasMarkers = false; this.scatterOptions = { positions: new Float32Array(), sizes: [], colors: [], glyphs: [], borderWidths: [], borderColors: [], size: 12, color: [0, 0, 0, 1], borderSize: 1, borderColor: [0, 0, 0, 1] }; this.scatter = createScatter(scene.glplot, this.scatterOptions); this.scatter._trace = this; this.fancyScatter = createFancyScatter(scene.glplot, this.scatterOptions); this.fancyScatter._trace = this; } var proto = LineWithMarkers.prototype; proto.handlePick = function(pickResult) { var index = this.idToIndex[pickResult.pointId]; return { trace: this, dataCoord: pickResult.dataCoord, traceCoord: [ this.xData[index], this.yData[index] ], textLabel: Array.isArray(this.textLabels) ? this.textLabels[index] : this.textLabels, color: Array.isArray(this.color) ? this.color[index] : this.color, name: this.name, hoverinfo: this.hoverinfo }; }; // check if trace is fancy proto.isFancy = function(options) { if(this.scene.xaxis.type !== 'linear') return true; if(this.scene.yaxis.type !== 'linear') return true; if(!options.x || !options.y) return true; var marker = options.marker || {}; if(Array.isArray(marker.symbol) || marker.symbol !== 'circle' || Array.isArray(marker.size) || Array.isArray(marker.line.width) || Array.isArray(marker.opacity) ) return true; var markerColor = marker.color; if(Array.isArray(markerColor)) return true; var lineColor = Array.isArray(marker.line.color); if(Array.isArray(lineColor)) return true; if(this.hasErrorX) return true; if(this.hasErrorY) return true; return false; }; // handle the situation where values can be array-like or not array like function convertArray(convert, data, count) { if(!Array.isArray(data)) data = [data]; return _convertArray(convert, data, count); } function _convertArray(convert, data, count) { var result = new Array(count), data0 = data[0]; for(var i = 0; i < count; ++i) { result[i] = (i >= data.length) ? convert(data0) : convert(data[i]); } return result; } var convertNumber = convertArray.bind(null, function(x) { return +x; }); var convertColorBase = convertArray.bind(null, str2RGBArray); var convertSymbol = convertArray.bind(null, function(x) { return MARKER_SYMBOLS[x] || '●'; }); function convertColor(color, opacity, count) { return _convertColor( convertColorBase(color, count), convertNumber(opacity, count), count ); } function convertColorScale(containerIn, markerOpacity, traceOpacity, count) { var colors = formatColor(containerIn, markerOpacity, count); colors = Array.isArray(colors[0]) ? colors : _convertArray(Lib.identity, [colors], count); return _convertColor( colors, convertNumber(traceOpacity, count), count ); } function _convertColor(colors, opacities, count) { var result = new Array(4 * count); for(var i = 0; i < count; ++i) { for(var j = 0; j < 3; ++j) result[4*i+j] = colors[i][j]; result[4*i+3] = colors[i][3] * opacities[i]; } return result; } /** * Truncate a Float32Array to some length. A wrapper to support environments * (e.g. node-webkit) that do not implement Float32Array.prototype.slice */ function truncate(float32ArrayIn, len) { if(Float32Array.slice === undefined) { var float32ArrayOut = new Float32Array(len); for(var i = 0; i < len; i++) float32ArrayOut[i] = float32ArrayIn[i]; return float32ArrayOut; } return float32ArrayIn.slice(0, len); } /* Order is important here to get the correct laying: * - lines * - errorX * - errorY * - markers */ proto.update = function(options) { if(options.visible !== true) { this.hasLines = false; this.hasErrorX = false; this.hasErrorY = false; this.hasMarkers = false; } else { this.hasLines = subTypes.hasLines(options); this.hasErrorX = options.error_x.visible === true; this.hasErrorY = options.error_y.visible === true; this.hasMarkers = subTypes.hasMarkers(options); } this.textLabels = options.text; this.name = options.name; this.hoverinfo = options.hoverinfo; this.bounds = [Infinity, Infinity, -Infinity, -Infinity]; if(this.isFancy(options)) { this.updateFancy(options); } else { this.updateFast(options); } // not quite on-par with 'scatter', but close enough for now // does not handle the colorscale case this.color = getTraceColor(options, {}); }; proto.updateFast = function(options) { var x = this.xData = options.x; var y = this.yData = options.y; var len = x.length, idToIndex = new Array(len), positions = new Float32Array(2 * len), bounds = this.bounds, pId = 0, ptr = 0; var xx, yy; // TODO add 'very fast' mode that bypasses this loop // TODO bypass this on modebar +/- zoom for(var i = 0; i < len; ++i) { xx = x[i]; yy = y[i]; // check for isNaN is faster but doesn't skip over nulls if(!isNumeric(xx) || !isNumeric(yy)) continue; idToIndex[pId++] = i; positions[ptr++] = xx; positions[ptr++] = yy; bounds[0] = Math.min(bounds[0], xx); bounds[1] = Math.min(bounds[1], yy); bounds[2] = Math.max(bounds[2], xx); bounds[3] = Math.max(bounds[3], yy); } positions = truncate(positions, ptr); this.idToIndex = idToIndex; this.updateLines(options, positions); this.updateError('X', options); this.updateError('Y', options); var markerSize; if(this.hasMarkers) { this.scatterOptions.positions = positions; var markerColor = str2RGBArray(options.marker.color), borderColor = str2RGBArray(options.marker.line.color), opacity = (options.opacity) * (options.marker.opacity); markerColor[3] *= opacity; this.scatterOptions.color = markerColor; borderColor[3] *= opacity; this.scatterOptions.borderColor = borderColor; markerSize = options.marker.size; this.scatterOptions.size = markerSize; this.scatterOptions.borderSize = options.marker.line.width; this.scatter.update(this.scatterOptions); } else { this.scatterOptions.positions = new Float32Array(); this.scatterOptions.glyphs = []; this.scatter.update(this.scatterOptions); } // turn off fancy scatter plot this.scatterOptions.positions = new Float32Array(); this.scatterOptions.glyphs = []; this.fancyScatter.update(this.scatterOptions); // add item for autorange routine this.expandAxesFast(bounds, markerSize); }; proto.updateFancy = function(options) { var scene = this.scene, xaxis = scene.xaxis, yaxis = scene.yaxis, bounds = this.bounds; // makeCalcdata runs d2c (data-to-coordinate) on every point var x = this.xData = xaxis.makeCalcdata(options, 'x'); var y = this.yData = yaxis.makeCalcdata(options, 'y'); // get error values var errorVals = ErrorBars.calcFromTrace(options, scene.fullLayout); var len = x.length, idToIndex = new Array(len), positions = new Float32Array(2 * len), errorsX = new Float32Array(4 * len), errorsY = new Float32Array(4 * len), pId = 0, ptr = 0, ptrX = 0, ptrY = 0; var getX = (xaxis.type === 'log') ? function(x) { return xaxis.d2l(x); } : function(x) { return x; }; var getY = (yaxis.type === 'log') ? function(y) { return yaxis.d2l(y); } : function(y) { return y; }; var i, j, xx, yy, ex0, ex1, ey0, ey1; for(i = 0; i < len; ++i) { xx = getX(x[i]); yy = getY(y[i]); if(isNaN(xx) || isNaN(yy)) continue; idToIndex[pId++] = i; positions[ptr++] = xx; positions[ptr++] = yy; ex0 = errorsX[ptrX++] = xx - errorVals[i].xs || 0; ex1 = errorsX[ptrX++] = errorVals[i].xh - xx || 0; errorsX[ptrX++] = 0; errorsX[ptrX++] = 0; errorsY[ptrY++] = 0; errorsY[ptrY++] = 0; ey0 = errorsY[ptrY++] = yy - errorVals[i].ys || 0; ey1 = errorsY[ptrY++] = errorVals[i].yh - yy || 0; bounds[0] = Math.min(bounds[0], xx - ex0); bounds[1] = Math.min(bounds[1], yy - ey0); bounds[2] = Math.max(bounds[2], xx + ex1); bounds[3] = Math.max(bounds[3], yy + ey1); } positions = truncate(positions, ptr); this.idToIndex = idToIndex; this.updateLines(options, positions); this.updateError('X', options, positions, errorsX); this.updateError('Y', options, positions, errorsY); var sizes; if(this.hasMarkers) { this.scatterOptions.positions = positions; // TODO rewrite convert function so that // we don't have to loop through the data another time this.scatterOptions.sizes = new Array(pId); this.scatterOptions.glyphs = new Array(pId); this.scatterOptions.borderWidths = new Array(pId); this.scatterOptions.colors = new Array(pId * 4); this.scatterOptions.borderColors = new Array(pId * 4); var markerSizeFunc = makeBubbleSizeFn(options), markerOpts = options.marker, markerOpacity = markerOpts.opacity, traceOpacity = options.opacity, colors = convertColorScale(markerOpts, markerOpacity, traceOpacity, len), glyphs = convertSymbol(markerOpts.symbol, len), borderWidths = convertNumber(markerOpts.line.width, len), borderColors = convertColorScale(markerOpts.line, markerOpacity, traceOpacity, len), index; sizes = convertArray(markerSizeFunc, markerOpts.size, len); for(i = 0; i < pId; ++i) { index = idToIndex[i]; this.scatterOptions.sizes[i] = 4.0 * sizes[index]; this.scatterOptions.glyphs[i] = glyphs[index]; this.scatterOptions.borderWidths[i] = 0.5 * borderWidths[index]; for(j = 0; j < 4; ++j) { this.scatterOptions.colors[4*i+j] = colors[4*index+j]; this.scatterOptions.borderColors[4*i+j] = borderColors[4*index+j]; } } this.fancyScatter.update(this.scatterOptions); } else { this.scatterOptions.positions = new Float32Array(); this.scatterOptions.glyphs = []; this.fancyScatter.update(this.scatterOptions); } // turn off fast scatter plot this.scatterOptions.positions = new Float32Array(); this.scatterOptions.glyphs = []; this.scatter.update(this.scatterOptions); // add item for autorange routine this.expandAxesFancy(x, y, sizes); }; proto.updateLines = function(options, positions) { if(this.hasLines) { this.lineOptions.positions = positions; var lineColor = str2RGBArray(options.line.color); if(this.hasMarkers) lineColor[3] *= options.marker.opacity; var lineWidth = Math.round(0.5 * this.lineOptions.width), dashes = (DASHES[options.line.dash] || [1]).slice(); for(var i = 0; i < dashes.length; ++i) dashes[i] *= lineWidth; switch(options.fill) { case 'tozeroy': this.lineOptions.fill = [false, true, false, false]; break; case 'tozerox': this.lineOptions.fill = [true, false, false, false]; break; default: this.lineOptions.fill = [false, false, false, false]; break; } var fillColor = str2RGBArray(options.fillcolor); this.lineOptions.color = lineColor; this.lineOptions.width = 2.0 * options.line.width; this.lineOptions.dashes = dashes; this.lineOptions.fillColor = [fillColor, fillColor, fillColor, fillColor]; } else { this.lineOptions.positions = new Float32Array(); } this.line.update(this.lineOptions); }; proto.updateError = function(axLetter, options, positions, errors) { var errorObj = this['error' + axLetter], errorOptions = options['error_' + axLetter.toLowerCase()], errorObjOptions = this['error' + axLetter + 'Options']; if(axLetter.toLowerCase() === 'x' && errorOptions.copy_ystyle) { errorOptions = options.error_y; } if(this['hasError' + axLetter]) { errorObjOptions.positions = positions; errorObjOptions.errors = errors; errorObjOptions.capSize = errorOptions.width; errorObjOptions.lineWidth = errorOptions.thickness / 2; // ballpark rescaling errorObjOptions.color = convertColor(errorOptions.color, 1, 1); } else { errorObjOptions.positions = new Float32Array(); } errorObj.update(errorObjOptions); }; proto.expandAxesFast = function(bounds, markerSize) { var pad = markerSize || 10; var ax, min, max; for(var i = 0; i < 2; i++) { ax = this.scene[AXES[i]]; min = ax._min; if(!min) min = []; min.push({ val: bounds[i], pad: pad }); max = ax._max; if(!max) max = []; max.push({ val: bounds[i+2], pad: pad }); } }; // not quite on-par with 'scatter' (scatter fill in several other expand options), // but close enough for now proto.expandAxesFancy = function(x, y, ppad) { var scene = this.scene, expandOpts = { padded: true, ppad: ppad }; Axes.expand(scene.xaxis, x, expandOpts); Axes.expand(scene.yaxis, y, expandOpts); }; proto.dispose = function() { this.line.dispose(); this.errorX.dispose(); this.errorY.dispose(); this.scatter.dispose(); this.fancyScatter.dispose(); }; function createLineWithMarkers(scene, data) { var plot = new LineWithMarkers(scene, data.uid); plot.update(data); return plot; } module.exports = createLineWithMarkers; },{"../../components/errorbars":323,"../../constants/gl2d_dashes":335,"../../constants/gl_markers":337,"../../lib":349,"../../lib/gl_format_color":347,"../../lib/str2rgbarray":359,"../../plots/cartesian/axes":369,"../scatter/get_trace_color":509,"../scatter/make_bubble_size_func":514,"../scatter/subtypes":520,"fast-isnumeric":74,"gl-error2d":76,"gl-line2d":82,"gl-scatter2d":147,"gl-scatter2d-fancy":142}],536:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var constants = require('../scatter/constants'); var subTypes = require('../scatter/subtypes'); var handleXYDefaults = require('../scatter/xy_defaults'); var handleMarkerDefaults = require('../scatter/marker_defaults'); var handleLineDefaults = require('../scatter/line_defaults'); var handleFillColorDefaults = require('../scatter/fillcolor_defaults'); var errorBarsSupplyDefaults = require('../../components/errorbars/defaults'); var attributes = require('./attributes'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } var len = handleXYDefaults(traceIn, traceOut, coerce); if(!len) { traceOut.visible = false; return; } coerce('text'); coerce('mode', len < constants.PTS_LINESONLY ? 'lines+markers' : 'lines'); if(subTypes.hasLines(traceOut)) { handleLineDefaults(traceIn, traceOut, defaultColor, coerce); } if(subTypes.hasMarkers(traceOut)) { handleMarkerDefaults(traceIn, traceOut, defaultColor, layout, coerce); } coerce('fill'); if(traceOut.fill !== 'none') { handleFillColorDefaults(traceIn, traceOut, defaultColor, coerce); } errorBarsSupplyDefaults(traceIn, traceOut, defaultColor, {axis: 'y'}); errorBarsSupplyDefaults(traceIn, traceOut, defaultColor, {axis: 'x', inherit: 'y'}); }; },{"../../components/errorbars/defaults":322,"../../lib":349,"../scatter/constants":506,"../scatter/fillcolor_defaults":508,"../scatter/line_defaults":512,"../scatter/marker_defaults":516,"../scatter/subtypes":520,"../scatter/xy_defaults":522,"./attributes":534}],537:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var ScatterGl = {}; ScatterGl.attributes = require('./attributes'); ScatterGl.supplyDefaults = require('./defaults'); ScatterGl.colorbar = require('../scatter/colorbar'); // reuse the Scatter3D 'dummy' calc step so that legends know what to do ScatterGl.calc = require('../scatter3d/calc'); ScatterGl.plot = require('./convert'); ScatterGl.moduleType = 'trace'; ScatterGl.name = 'scattergl'; ScatterGl.basePlotModule = require('../../plots/gl2d'); ScatterGl.categories = ['gl2d', 'symbols', 'errorBarsOK', 'markerColorscale', 'showLegend']; ScatterGl.meta = { }; module.exports = ScatterGl; },{"../../plots/gl2d":397,"../scatter/colorbar":505,"../scatter3d/calc":524,"./attributes":534,"./convert":535,"./defaults":536}],538:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var colorscaleAttrs = require('../../components/colorscale/attributes'); var extendFlat = require('../../lib/extend').extendFlat; function makeContourProjAttr(axLetter) { return { valType: 'boolean', dflt: false, }; } function makeContourAttr(axLetter) { return { show: { valType: 'boolean', dflt: false, }, project: { x: makeContourProjAttr('x'), y: makeContourProjAttr('y'), z: makeContourProjAttr('z') }, color: { valType: 'color', dflt: '#000' }, usecolormap: { valType: 'boolean', dflt: false }, width: { valType: 'number', min: 1, max: 16, dflt: 2 }, highlight: { valType: 'boolean', dflt: false }, highlightColor: { valType: 'color', dflt: '#000' }, highlightWidth: { valType: 'number', min: 1, max: 16, dflt: 2 } }; } module.exports = { z: { valType: 'data_array', }, x: { valType: 'data_array', }, y: { valType: 'data_array', }, text: { valType: 'data_array', }, zauto: colorscaleAttrs.zauto, zmin: colorscaleAttrs.zmin, zmax: colorscaleAttrs.zmax, colorscale: colorscaleAttrs.colorscale, autocolorscale: extendFlat({}, colorscaleAttrs.autocolorscale, {dflt: false}), reversescale: colorscaleAttrs.reversescale, showscale: colorscaleAttrs.showscale, contours: { x: makeContourAttr('x'), y: makeContourAttr('y'), z: makeContourAttr('z') }, hidesurface: { valType: 'boolean', dflt: false }, lighting: { ambient: { valType: 'number', min: 0.00, max: 1.0, dflt: 0.8 }, diffuse: { valType: 'number', min: 0.00, max: 1.00, dflt: 0.8 }, specular: { valType: 'number', min: 0.00, max: 2.00, dflt: 0.05 }, roughness: { valType: 'number', min: 0.00, max: 1.00, dflt: 0.5 }, fresnel: { valType: 'number', min: 0.00, max: 5.00, dflt: 0.2 } }, opacity: { valType: 'number', min: 0, max: 1, dflt: 1 }, _nestedModules: { // nested module coupling 'colorbar': 'Colorbar' } }; },{"../../components/colorscale/attributes":305,"../../lib/extend":345}],539:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var colorscaleCalc = require('../../components/colorscale/calc'); // Compute auto-z and autocolorscale if applicable module.exports = function calc(gd, trace) { colorscaleCalc(trace, trace.z, '', 'z'); }; },{"../../components/colorscale/calc":306}],540:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var createSurface = require('gl-surface3d'); var ndarray = require('ndarray'); var homography = require('ndarray-homography'); var fill = require('ndarray-fill'); var ops = require('ndarray-ops'); var tinycolor = require('tinycolor2'); var str2RgbaArray = require('../../lib/str2rgbarray'); var MIN_RESOLUTION = 128; function SurfaceTrace(scene, surface, uid) { this.scene = scene; this.uid = uid; this.surface = surface; this.data = null; this.showContour = [false, false, false]; this.dataScale = 1.0; } var proto = SurfaceTrace.prototype; proto.handlePick = function(selection) { if(selection.object === this.surface) { var selectIndex = [ Math.min( Math.round(selection.data.index[0]/this.dataScale-1)|0, this.data.z[0].length-1 ), Math.min( Math.round(selection.data.index[1]/this.dataScale-1)|0, this.data.z.length-1 ) ]; var traceCoordinate = [0,0,0]; if(Array.isArray(this.data.x[0])) { traceCoordinate[0] = this.data.x[selectIndex[1]][selectIndex[0]]; } else { traceCoordinate[0] = this.data.x[selectIndex[0]]; } if(Array.isArray(this.data.y[0])) { traceCoordinate[1] = this.data.y[selectIndex[1]][selectIndex[0]]; } else { traceCoordinate[1] = this.data.y[selectIndex[1]]; } traceCoordinate[2] = this.data.z[selectIndex[1]][selectIndex[0]]; selection.traceCoordinate = traceCoordinate; var sceneLayout = this.scene.fullSceneLayout; selection.dataCoordinate = [ sceneLayout.xaxis.d2l(traceCoordinate[0]) * this.scene.dataScale[0], sceneLayout.yaxis.d2l(traceCoordinate[1]) * this.scene.dataScale[1], sceneLayout.zaxis.d2l(traceCoordinate[2]) * this.scene.dataScale[2] ]; var text = this.data.text; if(text && text[selectIndex[1]] && text[selectIndex[1]][selectIndex[0]]!==undefined) { selection.textLabel = text[selectIndex[1]][selectIndex[0]]; } else selection.textLabel = ''; selection.data.dataCoordinate = selection.dataCoordinate.slice(); this.surface.highlight(selection.data); // Snap spikes to data coordinate this.scene.glplot.spikes.position = selection.dataCoordinate; return true; } }; function parseColorScale(colorscale, alpha) { if(alpha === undefined) alpha = 1; return colorscale.map(function(elem) { var index = elem[0]; var color = tinycolor(elem[1]); var rgb = color.toRgb(); return { index: index, rgb: [rgb.r, rgb.g, rgb.b, alpha] }; }); } // Pad coords by +1 function padField(field) { var shape = field.shape; var nshape = [shape[0]+2, shape[1]+2]; var nfield = ndarray(new Float32Array(nshape[0] * nshape[1]), nshape); // Center ops.assign(nfield.lo(1, 1).hi(shape[0], shape[1]), field); // Edges ops.assign(nfield.lo(1).hi(shape[0], 1), field.hi(shape[0], 1)); ops.assign(nfield.lo(1, nshape[1]-1).hi(shape[0], 1), field.lo(0, shape[1]-1).hi(shape[0], 1)); ops.assign(nfield.lo(0, 1).hi(1, shape[1]), field.hi(1)); ops.assign(nfield.lo(nshape[0]-1, 1).hi(1, shape[1]), field.lo(shape[0]-1)); // Corners nfield.set(0, 0, field.get(0, 0)); nfield.set(0, nshape[1]-1, field.get(0, shape[1]-1)); nfield.set(nshape[0]-1, 0, field.get(shape[0]-1, 0)); nfield.set(nshape[0]-1, nshape[1]-1, field.get(shape[0]-1, shape[1]-1)); return nfield; } function refine(coords) { var minScale = Math.max(coords[0].shape[0], coords[0].shape[1]); if(minScale < MIN_RESOLUTION) { var scaleF = MIN_RESOLUTION / minScale; var nshape = [ Math.floor((coords[0].shape[0]) * scaleF+1)|0, Math.floor((coords[0].shape[1]) * scaleF+1)|0 ]; var nsize = nshape[0] * nshape[1]; for(var i = 0; i < 3; ++i) { var padImg = padField(coords[i]); var scaledImg = ndarray(new Float32Array(nsize), nshape); homography(scaledImg, padImg, [scaleF, 0, 0, 0, scaleF, 0, 0, 0, 1]); coords[i] = scaledImg; } return scaleF; } return 1.0; } proto.setContourLevels = function() { var nlevels = [[], [], []]; var needsUpdate = false; for(var i = 0; i < 3; ++i) { if(this.showContour[i]) { needsUpdate = true; nlevels[i] = this.scene.contourLevels[i]; } } if(needsUpdate) { this.surface.update({ levels: nlevels }); } }; proto.update = function(data) { var i, scene = this.scene, sceneLayout = scene.fullSceneLayout, surface = this.surface, alpha = data.opacity, colormap = parseColorScale(data.colorscale, alpha), z = data.z, x = data.x, y = data.y, xaxis = sceneLayout.xaxis, yaxis = sceneLayout.yaxis, zaxis = sceneLayout.zaxis, scaleFactor = scene.dataScale, xlen = z[0].length, ylen = z.length, coords = [ ndarray(new Float32Array(xlen * ylen), [xlen, ylen]), ndarray(new Float32Array(xlen * ylen), [xlen, ylen]), ndarray(new Float32Array(xlen * ylen), [xlen, ylen]) ], xc = coords[0], yc = coords[1], contourLevels = scene.contourLevels; //Save data this.data = data; /* * Fill and transpose zdata. * Consistent with 'heatmap' and 'contour', plotly 'surface' * 'z' are such that sub-arrays correspond to y-coords * and that the sub-array entries correspond to a x-coords, * which is the transpose of 'gl-surface-plot'. */ fill(coords[2], function(row, col) { return zaxis.d2l(z[col][row]) * scaleFactor[2]; }); // coords x if(Array.isArray(x[0])) { fill(xc, function(row, col) { return xaxis.d2l(x[col][row]) * scaleFactor[0]; }); } else { // ticks x fill(xc, function(row) { return xaxis.d2l(x[row]) * scaleFactor[0]; }); } // coords y if(Array.isArray(y[0])) { fill(yc, function(row, col) { return yaxis.d2l(y[col][row]) * scaleFactor[1]; }); } else { // ticks y fill(yc, function(row, col) { return yaxis.d2l(y[col]) * scaleFactor[1]; }); } //Refine if necessary this.dataScale = refine(coords); var params = { colormap: colormap, levels: [[], [], []], showContour: [true, true, true], showSurface: !data.hidesurface, contourProject: [ [false, false, false], [false, false, false], [false, false, false] ], contourWidth: [1, 1, 1], contourColor: [[1, 1, 1, 1], [1, 1, 1, 1], [1, 1, 1, 1]], contourTint: [1, 1, 1], dynamicColor: [[1, 1, 1, 1], [1, 1, 1, 1], [1, 1, 1, 1]], dynamicWidth: [1, 1, 1], dynamicTint: [1, 1, 1], opacity: 1, colorBounds: [data.zmin * scaleFactor[2], data.zmax * scaleFactor[2]] }; if('opacity' in data) { if(data.opacity < 1) { params.opacity = 0.25 * data.opacity; } } var highlightEnable = [true, true, true]; var contourEnable = [true, true, true]; var axis = ['x', 'y', 'z']; for(i = 0; i < 3; ++i) { var contourParams = data.contours[axis[i]]; highlightEnable[i] = contourParams.highlight; contourEnable[i] = contourParams.show; params.showContour[i] = contourParams.show || contourParams.highlight; if(!params.showContour[i]) continue; params.contourProject[i] = [ contourParams.project.x, contourParams.project.y, contourParams.project.z ]; if(contourParams.show) { this.showContour[i] = true; params.levels[i] = contourLevels[i]; surface.highlightColor[i] = params.contourColor[i] = str2RgbaArray(contourParams.color); if(contourParams.usecolormap) { surface.highlightTint[i] = params.contourTint[i] = 0; } else { surface.highlightTint[i] = params.contourTint[i] = 1; } params.contourWidth[i] = contourParams.width; } else { this.showContour[i] = false; } if(contourParams.highlight) { params.dynamicColor[i] = str2RgbaArray(contourParams.highlightColor); params.dynamicWidth[i] = contourParams.highlightWidth; } } params.coords = coords; surface.update(params); surface.highlightEnable = highlightEnable; surface.contourEnable = contourEnable; surface.visible = data.visible; surface.snapToData = true; if('lighting' in data) { surface.ambientLight = data.lighting.ambient; surface.diffuseLight = data.lighting.diffuse; surface.specularLight = data.lighting.specular; surface.roughness = data.lighting.roughness; surface.fresnel = data.lighting.fresnel; } if(alpha && alpha < 1) { surface.supportsTransparency = true; } }; proto.dispose = function() { this.scene.glplot.remove(this.surface); this.surface.dispose(); }; function createSurfaceTrace(scene, data) { var gl = scene.glplot.gl; var surface = createSurface({ gl: gl }); var result = new SurfaceTrace(scene, surface, data.uid); result.update(data); scene.glplot.add(surface); return result; } module.exports = createSurfaceTrace; },{"../../lib/str2rgbarray":359,"gl-surface3d":184,"ndarray":208,"ndarray-fill":201,"ndarray-homography":206,"ndarray-ops":207,"tinycolor2":229}],541:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Lib = require('../../lib'); var colorscaleDefaults = require('../../components/colorscale/defaults'); var attributes = require('./attributes'); module.exports = function supplyDefaults(traceIn, traceOut, defaultColor, layout) { var i, j; function coerce(attr, dflt) { return Lib.coerce(traceIn, traceOut, attributes, attr, dflt); } var z = coerce('z'); if(!z) { traceOut.visible = false; return; } var xlen = z[0].length; var ylen = z.length; coerce('x'); coerce('y'); if(!Array.isArray(traceOut.x)) { // build a linearly scaled x traceOut.x = []; for(i = 0; i < xlen; ++i) { traceOut.x[i] = i; } } coerce('text'); if(!Array.isArray(traceOut.y)) { traceOut.y = []; for(i = 0; i < ylen; ++i) { traceOut.y[i] = i; } } coerce('lighting.ambient'); coerce('lighting.diffuse'); coerce('lighting.specular'); coerce('lighting.roughness'); coerce('lighting.fresnel'); coerce('hidesurface'); coerce('opacity'); coerce('colorscale'); var dims = ['x', 'y', 'z']; for(i = 0; i < 3; ++i) { var contourDim = 'contours.' + dims[i]; var show = coerce(contourDim + '.show'); var highlight = coerce(contourDim + '.highlight'); if(show || highlight) { for(j = 0; j < 3; ++j) { coerce(contourDim + '.project.' + dims[j]); } } if(show) { coerce(contourDim + '.color'); coerce(contourDim + '.width'); coerce(contourDim + '.usecolormap'); } if(highlight) { coerce(contourDim + '.highlightColor'); coerce(contourDim + '.highlightWidth'); } } colorscaleDefaults( traceIn, traceOut, layout, coerce, {prefix: '', cLetter: 'z'} ); }; },{"../../components/colorscale/defaults":308,"../../lib":349,"./attributes":538}],542:[function(require,module,exports){ /** * Copyright 2012-2016, Plotly, Inc. * All rights reserved. * * This source code is licensed under the MIT license found in the * LICENSE file in the root directory of this source tree. */ 'use strict'; var Surface = {}; Surface.attributes = require('./attributes'); Surface.supplyDefaults = require('./defaults'); Surface.colorbar = require('../heatmap/colorbar'); Surface.calc = require('./calc'); Surface.plot = require('./convert'); Surface.moduleType = 'trace'; Surface.name = 'surface'; Surface.basePlotModule = require('../../plots/gl3d'); Surface.categories = ['gl3d', 'noOpacity']; Surface.meta = { }; module.exports = Surface; },{"../../plots/gl3d":400,"../heatmap/colorbar":461,"./attributes":538,"./calc":539,"./convert":540,"./defaults":541}]},{},[12])(12) });