A B C D E F G H I J K L M N O P Q R S T U V W X Y Z _ 

E

e - Variable in class org.meteoinfo.projection.proj4j.proj.Projection
The eccentricity
E - org.meteoinfo.data.meteodata.DimensionType
 
E - Static variable in class org.meteoinfo.jts.math.DD
The value nearest to the constant e (the natural logarithm base).
EarthWind - Variable in class org.meteoinfo.data.meteodata.grads.GrADSDataInfo
 
EarthWind - Variable in class org.meteoinfo.data.meteodata.MeteoDataInfo
 
East - org.meteoinfo.global.Direction
 
eccentricity - Variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
eccentricity2 - Variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
Eckert1Projection - Class in org.meteoinfo.projection.proj4j.proj
 
Eckert1Projection() - Constructor for class org.meteoinfo.projection.proj4j.proj.Eckert1Projection
 
Eckert2Projection - Class in org.meteoinfo.projection.proj4j.proj
 
Eckert2Projection() - Constructor for class org.meteoinfo.projection.proj4j.proj.Eckert2Projection
 
Eckert4Projection - Class in org.meteoinfo.projection.proj4j.proj
 
Eckert4Projection() - Constructor for class org.meteoinfo.projection.proj4j.proj.Eckert4Projection
 
Eckert5Projection - Class in org.meteoinfo.projection.proj4j.proj
 
Eckert5Projection() - Constructor for class org.meteoinfo.projection.proj4j.proj.Eckert5Projection
 
Eckert6Projection - Class in org.meteoinfo.projection.proj4j.proj
 
Eckert6Projection() - Constructor for class org.meteoinfo.projection.proj4j.proj.Eckert6Projection
 
edge - Variable in class org.meteoinfo.jts.geomgraph.EdgeEnd
 
Edge - Class in org.meteoinfo.jts.geomgraph
 
Edge - Class in org.meteoinfo.jts.planargraph
Represents an undirected edge of a PlanarGraph.
Edge - Enum in org.meteoinfo.layout
 
Edge() - Constructor for class org.meteoinfo.jts.planargraph.Edge
Constructs an Edge whose DirectedEdges are not yet set.
Edge(Coordinate[]) - Constructor for class org.meteoinfo.jts.geomgraph.Edge
 
Edge(Coordinate[], Label) - Constructor for class org.meteoinfo.jts.geomgraph.Edge
 
Edge(DirectedEdge, DirectedEdge) - Constructor for class org.meteoinfo.jts.planargraph.Edge
Constructs an Edge initialized with the given DirectedEdges, and for each DirectedEdge: sets the Edge, sets the symmetric DirectedEdge, and adds this Edge to its from-Node.
edgeAction - Variable in class org.meteoinfo.image.filter.TransformFilter
The action to take for pixels off the image edge.
edgeAction - Variable in class org.meteoinfo.image.math.ImageFunction2D
 
EdgeConnectedTriangleTraversal - Class in org.meteoinfo.jts.triangulate.quadedge
A framework to visit sets of edge-connected QuadEdgeTriangles in breadth-first order
EdgeConnectedTriangleTraversal() - Constructor for class org.meteoinfo.jts.triangulate.quadedge.EdgeConnectedTriangleTraversal
 
edgeDirection - Variable in class org.meteoinfo.jts.planargraph.DirectedEdge
 
EdgeEnd - Class in org.meteoinfo.jts.geomgraph
Models the end of an edge incident on a node.
EdgeEnd(Edge) - Constructor for class org.meteoinfo.jts.geomgraph.EdgeEnd
 
EdgeEnd(Edge, Coordinate, Coordinate) - Constructor for class org.meteoinfo.jts.geomgraph.EdgeEnd
 
EdgeEnd(Edge, Coordinate, Coordinate, Label) - Constructor for class org.meteoinfo.jts.geomgraph.EdgeEnd
 
EdgeEndBuilder - Class in org.meteoinfo.jts.operation.relate
Computes the EdgeEnds which arise from a noded Edge.
EdgeEndBuilder() - Constructor for class org.meteoinfo.jts.operation.relate.EdgeEndBuilder
 
EdgeEndBundle - Class in org.meteoinfo.jts.operation.relate
A collection of EdgeEnds which obey the following invariant: They originate at the same node and have the same direction.
EdgeEndBundle(BoundaryNodeRule, EdgeEnd) - Constructor for class org.meteoinfo.jts.operation.relate.EdgeEndBundle
 
EdgeEndBundle(EdgeEnd) - Constructor for class org.meteoinfo.jts.operation.relate.EdgeEndBundle
 
EdgeEndBundleStar - Class in org.meteoinfo.jts.operation.relate
An ordered list of EdgeEndBundles around a RelateNode.
EdgeEndBundleStar() - Constructor for class org.meteoinfo.jts.operation.relate.EdgeEndBundleStar
Creates a new empty EdgeEndBundleStar
edgeEndList - Variable in class org.meteoinfo.jts.geomgraph.PlanarGraph
 
EdgeEndStar - Class in org.meteoinfo.jts.geomgraph
A EdgeEndStar is an ordered list of EdgeEnds around a node.
EdgeEndStar() - Constructor for class org.meteoinfo.jts.geomgraph.EdgeEndStar
 
EdgeFilter - Class in org.meteoinfo.image.filter
An edge-detection filter.
EdgeFilter() - Constructor for class org.meteoinfo.image.filter.EdgeFilter
 
EdgeGraph - Class in org.meteoinfo.jts.edgegraph
A graph comprised of HalfEdges.
EdgeGraph() - Constructor for class org.meteoinfo.jts.edgegraph.EdgeGraph
 
EdgeGraphBuilder - Class in org.meteoinfo.jts.edgegraph
Builds an edge graph from geometries containing edges.
EdgeGraphBuilder() - Constructor for class org.meteoinfo.jts.edgegraph.EdgeGraphBuilder
 
EdgeIntersection - Class in org.meteoinfo.jts.geomgraph
Represents a point on an edge which intersects with another edge.
EdgeIntersection(Coordinate, int, double) - Constructor for class org.meteoinfo.jts.geomgraph.EdgeIntersection
 
EdgeIntersectionList - Class in org.meteoinfo.jts.geomgraph
A list of edge intersections along an Edge.
EdgeIntersectionList(Edge) - Constructor for class org.meteoinfo.jts.geomgraph.EdgeIntersectionList
 
edgeIterator() - Method in class org.meteoinfo.jts.planargraph.PlanarGraph
Returns an Iterator over the Edges in this PlanarGraph, in the order in which they were added.
edgeIterator() - Method in class org.meteoinfo.jts.planargraph.Subgraph
Returns an Iterator over the Edges in this graph, in the order in which they were added.
edgeList - Variable in class org.meteoinfo.jts.geomgraph.EdgeEndStar
A list of all outgoing edges in the result, in CCW order
EdgeList - Class in org.meteoinfo.jts.geomgraph
A EdgeList is a list of Edges.
EdgeList() - Constructor for class org.meteoinfo.jts.geomgraph.EdgeList
 
edgeMap - Variable in class org.meteoinfo.jts.geomgraph.EdgeEndStar
A map which maintains the edges in sorted order around the node
EdgeNodingValidator - Class in org.meteoinfo.jts.geomgraph
Validates that a collection of Edges is correctly noded.
EdgeNodingValidator(Collection) - Constructor for class org.meteoinfo.jts.geomgraph.EdgeNodingValidator
Creates a new validator for the given collection of Edges.
EdgeRing - Class in org.meteoinfo.jts.geomgraph
 
EdgeRing(DirectedEdge, GeometryFactory) - Constructor for class org.meteoinfo.jts.geomgraph.EdgeRing
 
edges - Variable in class org.meteoinfo.jts.geomgraph.Node
 
edges - Variable in class org.meteoinfo.jts.geomgraph.PlanarGraph
 
edges - Variable in class org.meteoinfo.jts.planargraph.PlanarGraph
 
edges - Variable in class org.meteoinfo.jts.planargraph.Subgraph
 
EdgeSetIntersector - Class in org.meteoinfo.jts.geomgraph.index
An EdgeSetIntersector computes all the intersections between the edges in the set.
EdgeSetIntersector() - Constructor for class org.meteoinfo.jts.geomgraph.index.EdgeSetIntersector
 
EdgeSetNoder - Class in org.meteoinfo.jts.operation.overlay
Nodes a set of edges.
EdgeSetNoder(LineIntersector) - Constructor for class org.meteoinfo.jts.operation.overlay.EdgeSetNoder
 
EdgeString - Class in org.meteoinfo.jts.operation.linemerge
A sequence of LineMergeDirectedEdges forming one of the lines that will be output by the line-merging process.
EdgeString(GeometryFactory) - Constructor for class org.meteoinfo.jts.operation.linemerge.EdgeString
Constructs an EdgeString with the given factory used to convert this EdgeString to a LineString
edit(Coordinate[], Geometry) - Method in class org.meteoinfo.jts.geom.util.GeometryEditor.CoordinateOperation
Edits the array of Coordinates from a Geometry.
edit(Coordinate[], Geometry) - Method in class org.meteoinfo.jts.precision.PrecisionReducerCoordinateOperation
 
edit(CoordinateSequence, Geometry) - Method in class org.meteoinfo.jts.geom.util.GeometryEditor.CoordinateSequenceOperation
edit(Geometry, GeometryFactory) - Method in class org.meteoinfo.jts.geom.util.GeometryEditor.CoordinateOperation
 
edit(Geometry, GeometryFactory) - Method in class org.meteoinfo.jts.geom.util.GeometryEditor.CoordinateSequenceOperation
 
edit(Geometry, GeometryFactory) - Method in interface org.meteoinfo.jts.geom.util.GeometryEditor.GeometryEditorOperation
Edits a Geometry by returning a new Geometry with a modification.
edit(Geometry, GeometryFactory) - Method in class org.meteoinfo.jts.geom.util.GeometryEditor.NoOpGeometryOperation
 
edit(Geometry, GeometryEditor.GeometryEditorOperation) - Method in class org.meteoinfo.jts.geom.util.GeometryEditor
Edit the input Geometry with the given edit operation.
Edit_AddRing - org.meteoinfo.map.MouseTools
 
Edit_DeleteRing - org.meteoinfo.map.MouseTools
 
Edit_FeatureVertices - org.meteoinfo.map.MouseTools
 
Edit_FillRing - org.meteoinfo.map.MouseTools
 
Edit_InEditingVertices - org.meteoinfo.map.MouseTools
 
Edit_MoveSelection - org.meteoinfo.map.MouseTools
 
Edit_NewFeature - org.meteoinfo.map.MouseTools
 
Edit_ReformFeature - org.meteoinfo.map.MouseTools
 
Edit_SplitFeature - org.meteoinfo.map.MouseTools
 
Edit_Tool - org.meteoinfo.map.MouseTools
 
editAddField(String, DataTypes) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Add a field
editAddField(Field) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Add a field
editAddShape(Shape) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Add a shape
editAddShape(Shape, List<Object>) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Add a shape
editCellValue(int, int, Object) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Edit cell value
editCellValue(String, int, Object) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Edit cell value
editInsertShape(Shape, int) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Insert shape
editInsertShape(Shape, int, DataRow) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Insert shape
editRemoveField(String) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Remove a field
editRemoveShape(Shape) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Remove a shape
editRenameField(String, String) - Method in class org.meteoinfo.layer.VectorLayer
Edit: Rename a field
EditVertices - org.meteoinfo.layout.MouseMode
 
EditVertices - org.meteoinfo.map.MouseTools
 
eigen(Array) - Static method in class org.meteoinfo.math.linalg.LinalgUtil
Calculates the eigen decomposition of a real matrix.
eigen_bak(Array) - Static method in class org.meteoinfo.math.linalg.LinalgUtil
Calculates the eigen decomposition of a real matrix.
eigen_EJML(Array) - Static method in class org.meteoinfo.math.linalg.LinalgUtil
Calculates the eigen decomposition of a real matrix.
elementSelectedEvent(ElementSelectedEvent) - Method in interface org.meteoinfo.global.event.IElementSelectedListener
 
ElementSelectedEvent - Class in org.meteoinfo.global.event
Size changed event
ElementSelectedEvent(Object) - Constructor for class org.meteoinfo.global.event.ElementSelectedEvent
Constructor
ElementType - Enum in org.meteoinfo.layout
 
Ellipse - org.meteoinfo.shape.ShapeTypes
 
EllipseShape - Class in org.meteoinfo.shape
Ellipse shape class
EllipseShape() - Constructor for class org.meteoinfo.shape.EllipseShape
Constructor
ellipsoid - Variable in class org.meteoinfo.projection.proj4j.proj.Projection
The ellipsoid used by this projection
Ellipsoid - Class in org.meteoinfo.projection.proj4j.datum
A class representing a geographic reference ellipsoid (or more correctly an oblate spheroid), used to model the shape of the surface of the earth.
Ellipsoid() - Constructor for class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
Ellipsoid(String, double, double, double, String) - Constructor for class org.meteoinfo.projection.proj4j.datum.Ellipsoid
Creates a new Ellipsoid.
Ellipsoid(String, double, double, String) - Constructor for class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
ELLIPSOID_E2_TOLERANCE - Static variable in class org.meteoinfo.projection.proj4j.datum.Datum
 
ellipsoids - Static variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
ellipsoids - Static variable in class org.meteoinfo.projection.proj4j.Registry
 
ellps - Static variable in class org.meteoinfo.projection.proj4j.parser.Proj4Keyword
 
EmbossFilter - Class in org.meteoinfo.image.filter
A class to emboss an image.
EmbossFilter() - Constructor for class org.meteoinfo.image.filter.EmbossFilter
 
EmptyTileFactory - Class in org.meteoinfo.data.mapdata.webmap.empty
A null implementation of TileFactory.
EmptyTileFactory() - Constructor for class org.meteoinfo.data.mapdata.webmap.empty.EmptyTileFactory
Creates a new instance of EmptyTileFactory
EmptyTileFactory(TileFactoryInfo) - Constructor for class org.meteoinfo.data.mapdata.webmap.empty.EmptyTileFactory
Creates a new instance of EmptyTileFactory using the specified info.
encode(byte[], ByteOrder) - Method in interface org.meteoinfo.data.mapdata.geotiff.compression.CompressionEncoder
Encode the bytes
encode(byte[], ByteOrder) - Method in class org.meteoinfo.data.mapdata.geotiff.compression.DeflateCompression
 
encode(byte[], ByteOrder) - Method in class org.meteoinfo.data.mapdata.geotiff.compression.LZWCompression
Encode the bytes
encodingDetect(File) - Static method in class org.meteoinfo.io.IOUtil
Detect file encoding
encodingDetect(String) - Static method in class org.meteoinfo.io.IOUtil
Detect file encoding
EncodingDetect - Class in org.meteoinfo.io
Copyright (C) <2009> This program is free software: you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version.
EncodingDetect() - Constructor for class org.meteoinfo.io.EncodingDetect
 
encodingDetectShp(String) - Static method in class org.meteoinfo.io.IOUtil
Encoding detect to a shape file
end_index - Variable in class org.meteoinfo.data.meteodata.mm5.SubHeader
 
endElement(String, String, String) - Method in class org.meteoinfo.jts.io.gml2.GMLHandler
 
EndianDataInputStream - Class in org.meteoinfo.io
 
EndianDataInputStream(InputStream) - Constructor for class org.meteoinfo.io.EndianDataInputStream
Creates new EndianDataInputStream
EndianDataOutputStream - Class in org.meteoinfo.io
 
EndianDataOutputStream(OutputStream) - Constructor for class org.meteoinfo.io.EndianDataOutputStream
Creates new EndianDataOutputStream
endLine() - Method in class org.meteoinfo.jts.linearref.LinearGeometryBuilder
Terminate the current LineString.
ENDPOINT_BOUNDARY_RULE - Static variable in interface org.meteoinfo.jts.algorithm.BoundaryNodeRule
The Endpoint Boundary Node Rule.
EndPointBoundaryNodeRule() - Constructor for class org.meteoinfo.jts.algorithm.BoundaryNodeRule.EndPointBoundaryNodeRule
 
endYear - Variable in class org.meteoinfo.ui.calendar.JYearChooser
 
enfn(double) - Static method in class org.meteoinfo.projection.proj4j.util.ProjectionMath
 
enforceConstraints() - Method in class org.meteoinfo.jts.triangulate.ConformingDelaunayTriangulator
Enforces the supplied constraints into the triangulation.
ENGELIS - Static variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
EnhancedPrecisionOp - Class in org.meteoinfo.jts.precision
Provides versions of Geometry spatial functions which use enhanced precision techniques to reduce the likelihood of robustness problems.
EnhancedPrecisionOp() - Constructor for class org.meteoinfo.jts.precision.EnhancedPrecisionOp
 
ensureExtent(Envelope, double) - Static method in class org.meteoinfo.jts.index.quadtree.Quadtree
Ensure that the envelope for the inserted item has non-zero extents.
ensureExtent(Interval, double) - Static method in class org.meteoinfo.jts.index.bintree.Bintree
Ensure that the Interval for the inserted item has non-zero extents.
ensureValidRing(CoordinateSequenceFactory, CoordinateSequence) - Static method in class org.meteoinfo.jts.geom.CoordinateSequences
Ensures that a CoordinateSequence forms a valid ring, returning a new closed sequence of the correct length if required.
entrySet() - Method in class org.meteoinfo.data.dataframe.impl.Views.DataFrameMapView
 
envelope - Variable in class org.meteoinfo.jts.geom.Geometry
The bounding box of this Geometry.
envelope(Collection) - Static method in class org.meteoinfo.jts.triangulate.DelaunayTriangulationBuilder
Computes the Envelope of a collection of Coordinates.
envelope(Coordinate[]) - Static method in class org.meteoinfo.jts.geom.CoordinateArrays
Computes the envelope of the coordinates.
Envelope - Class in org.meteoinfo.jts.geom
Defines a rectangular region of the 2D coordinate plane.
Envelope() - Constructor for class org.meteoinfo.jts.geom.Envelope
Creates a null Envelope.
Envelope(double, double, double, double) - Constructor for class org.meteoinfo.jts.geom.Envelope
Creates an Envelope for a region defined by maximum and minimum values.
Envelope(Coordinate) - Constructor for class org.meteoinfo.jts.geom.Envelope
Creates an Envelope for a region defined by a single Coordinate.
Envelope(Coordinate, Coordinate) - Constructor for class org.meteoinfo.jts.geom.Envelope
Creates an Envelope for a region defined by two Coordinates.
Envelope(Envelope) - Constructor for class org.meteoinfo.jts.geom.Envelope
Create an Envelope from an existing Envelope.
EOF - Class in org.meteoinfo.math.linalg
 
EOF() - Constructor for class org.meteoinfo.math.linalg.EOF
 
EOF.DataProMethod - Enum in org.meteoinfo.math.linalg
 
EPS - Static variable in class org.meteoinfo.jts.math.DD
The smallest representable relative difference between two {link @ DoubleDouble} values
EPS10 - Static variable in class org.meteoinfo.projection.proj4j.proj.Projection
 
EPS10 - Static variable in class org.meteoinfo.projection.proj4j.util.ProjectionMath
 
equal(Number) - Method in class org.meteoinfo.data.dataframe.Series
Equal
equal(Coordinate, Coordinate, double) - Method in class org.meteoinfo.jts.geom.Geometry
 
equal(Array, Number) - Static method in class org.meteoinfo.data.ArrayMath
Array equal
equal(Array, Array) - Static method in class org.meteoinfo.data.ArrayMath
Array equal
EqualAreaAzimuthalProjection - Class in org.meteoinfo.projection.proj4j.proj
 
EqualAreaAzimuthalProjection() - Constructor for class org.meteoinfo.projection.proj4j.proj.EqualAreaAzimuthalProjection
 
equalInZ(Coordinate, double) - Method in class org.meteoinfo.jts.geom.Coordinate
Tests if another coordinate has the same value for Z, within a tolerance.
EqualizeFilter - Class in org.meteoinfo.image.filter
A filter to perform auto-equalization on an image.
EqualizeFilter() - Constructor for class org.meteoinfo.image.filter.EqualizeFilter
 
equals(Object) - Method in class org.meteoinfo.data.mapdata.webmap.GeoPosition
Returns true the specified GeoPosition and this GeoPosition represent the exact same latitude and longitude coordinates.
equals(Object) - Method in class org.meteoinfo.image.composite.ContourComposite
 
equals(Object) - Method in class org.meteoinfo.image.composite.MiscComposite
 
equals(Object) - Method in class org.meteoinfo.image.composite.RGBComposite
 
equals(Object) - Method in class org.meteoinfo.jts.geom.Coordinate
Returns true if other has the same values for the x and y ordinates.
equals(Object) - Method in class org.meteoinfo.jts.geom.Envelope
 
equals(Object) - Method in class org.meteoinfo.jts.geom.Geometry
Tests whether this geometry is structurally and numerically equal to a given Object.
equals(Object) - Method in class org.meteoinfo.jts.geom.LineSegment
Returns true if other has the same values for its points.
equals(Object) - Method in class org.meteoinfo.jts.geom.PrecisionModel
 
equals(Object) - Method in class org.meteoinfo.jts.geom.util.AffineTransformation
Tests if an object is an AffineTransformation and has the same matrix as this transformation.
equals(Object) - Method in class org.meteoinfo.jts.geomgraph.Edge
equals is defined to be:
equals(Object) - Method in class org.meteoinfo.jts.index.strtree.Interval
 
equals(Object) - Method in class org.meteoinfo.jts.math.Vector2D
Tests if a vector o has the same values for the x and y components.
equals(Object) - Method in class org.meteoinfo.projection.proj4j.ProjCoordinate
 
equals(Object) - Method in class org.meteoinfo.projection.proj4j.units.Unit
 
equals(Object, Object) - Static method in class org.meteoinfo.jts.util.Assert
Throws an AssertionFailedException if the given objects are not equal, according to the equals method.
equals(Object, Object) - Static method in class org.meteoinfo.util.Assert
Throws an AssertionFailedException if the given objects are not equal, according to the equals method.
equals(Object, Object, String) - Static method in class org.meteoinfo.jts.util.Assert
Throws an AssertionFailedException with the given message if the given objects are not equal, according to the equals method.
equals(Object, Object, String) - Static method in class org.meteoinfo.util.Assert
Throws an AssertionFailedException with the given message if the given objects are not equal, according to the equals method.
equals(Date, Date) - Static method in class org.meteoinfo.global.util.DateUtil
Date equals
equals(Dimension) - Method in class org.meteoinfo.data.meteodata.Dimension
Determine if two dimensions equals
equals(GRIB2MessageIndex) - Method in class org.meteoinfo.data.meteodata.grib.grib2.GRIB2MessageIndex
Judge if two message index are equal
equals(Variable) - Method in class org.meteoinfo.data.meteodata.Variable
Determine if two parameter are equal
equals(PointD) - Method in class org.meteoinfo.global.PointD
Equals of two pointDs
equals(Coordinate[], Coordinate[]) - Static method in class org.meteoinfo.jts.geom.CoordinateArrays
Returns true if the two arrays are identical, both null, or pointwise equal (as compared using Coordinate#equals)
equals(Coordinate[], Coordinate[], Comparator) - Static method in class org.meteoinfo.jts.geom.CoordinateArrays
Returns true if the two arrays are identical, both null, or pointwise equal, using a user-defined Comparator for Coordinate s
equals(Coordinate, Coordinate) - Method in class org.meteoinfo.jts.edgegraph.HalfEdge
Tests whether this edge has the given orig and dest vertices.
equals(Coordinate, Coordinate, double) - Static method in class org.meteoinfo.jts.util.Debug
 
equals(Geometry) - Method in class org.meteoinfo.jts.geom.Geometry
Tests whether this geometry is topologically equal to the argument geometry.
equals(DD) - Method in class org.meteoinfo.jts.math.DD
Tests whether this value is equal to another DoubleDouble value.
equals(Vertex) - Method in class org.meteoinfo.jts.triangulate.quadedge.Vertex
 
equals(Vertex, double) - Method in class org.meteoinfo.jts.triangulate.quadedge.Vertex
 
equals(ProjectionInfo) - Method in class org.meteoinfo.projection.ProjectionInfo
Determine if the projection is same with another projection
equals(Shape) - Method in class org.meteoinfo.shape.Shape
If this shape equals another one
equals2D(Coordinate) - Method in class org.meteoinfo.jts.geom.Coordinate
Returns whether the planar projections of the two Coordinates are equal.
equals2D(Coordinate, double) - Method in class org.meteoinfo.jts.geom.Coordinate
Tests if another coordinate has the same values for the X and Y ordinates.
equals3D(Coordinate) - Method in class org.meteoinfo.jts.geom.Coordinate
Tests if another coordinate has the same values for the X, Y and Z ordinates.
equalsExact(Geometry) - Method in class org.meteoinfo.jts.geom.Geometry
Returns true if the two Geometrys are exactly equal.
equalsExact(Geometry, double) - Method in class org.meteoinfo.jts.geom.Geometry
Returns true if the two Geometrys are exactly equal, up to a specified distance tolerance.
equalsExact(Geometry, double) - Method in class org.meteoinfo.jts.geom.GeometryCollection
 
equalsExact(Geometry, double) - Method in class org.meteoinfo.jts.geom.LineString
 
equalsExact(Geometry, double) - Method in class org.meteoinfo.jts.geom.MultiLineString
 
equalsExact(Geometry, double) - Method in class org.meteoinfo.jts.geom.MultiPoint
 
equalsExact(Geometry, double) - Method in class org.meteoinfo.jts.geom.MultiPolygon
 
equalsExact(Geometry, double) - Method in class org.meteoinfo.jts.geom.Point
 
equalsExact(Geometry, double) - Method in class org.meteoinfo.jts.geom.Polygon
 
equalsNonOriented(QuadEdge) - Method in class org.meteoinfo.jts.triangulate.quadedge.QuadEdge
Tests if this quadedge and another have the same line segment geometry, regardless of orientation.
equalsNorm(Geometry) - Method in class org.meteoinfo.jts.geom.Geometry
Tests whether two geometries are exactly equal in their normalized forms.
equalsOriented(QuadEdge) - Method in class org.meteoinfo.jts.triangulate.quadedge.QuadEdge
Tests if this quadedge and another have the same line segment geometry with the same orientation.
equalsTopo(Geometry) - Method in class org.meteoinfo.jts.geom.Geometry
Tests whether this geometry is topologically equal to the argument geometry as defined by the SFS equals predicate.
equalsTopo(LineSegment) - Method in class org.meteoinfo.jts.geom.LineSegment
Returns true if other is topologically equal to this LineSegment (e.g.
equalsTopo(Segment) - Method in class org.meteoinfo.jts.triangulate.Segment
Determines whether two segments are topologically equal.
equalsWithTolerance(double, double, double) - Static method in class org.meteoinfo.jts.util.NumberUtil
 
EQUATOR - Static variable in class org.meteoinfo.projection.proj4j.proj.AzimuthalProjection
 
equatorRadius - Variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
EquidistantAzimuthalProjection - Class in org.meteoinfo.projection.proj4j.proj
 
EquidistantAzimuthalProjection() - Constructor for class org.meteoinfo.projection.proj4j.proj.EquidistantAzimuthalProjection
 
EquidistantAzimuthalProjection(double, double) - Constructor for class org.meteoinfo.projection.proj4j.proj.EquidistantAzimuthalProjection
 
EquidistantConicProjection - Class in org.meteoinfo.projection.proj4j.proj
The Equidistant Conic projection.
EquidistantConicProjection() - Constructor for class org.meteoinfo.projection.proj4j.proj.EquidistantConicProjection
 
ErodeAlphaFilter - Class in org.meteoinfo.image.filter
 
ErodeAlphaFilter() - Constructor for class org.meteoinfo.image.filter.ErodeAlphaFilter
 
ErodeAlphaFilter(float, float, float) - Constructor for class org.meteoinfo.image.filter.ErodeAlphaFilter
 
ErodeFilter - Class in org.meteoinfo.image.filter
Given a binary image, this filter performs binary erosion, setting all removed pixels to the given 'new' color.
ErodeFilter() - Constructor for class org.meteoinfo.image.filter.ErodeFilter
 
err() - Method in class org.meteoinfo.image.GifDecoder
Returns true if an error was encountered during reading/decoding
ERR_17 - Static variable in exception org.meteoinfo.projection.proj4j.ProjectionException
 
errMsg - Static variable in class org.meteoinfo.jts.operation.valid.TopologyValidationError
Messages corresponding to error codes
error(Object) - Method in interface org.meteoinfo.console.ConsoleInterface
 
error(Object) - Method in class org.meteoinfo.console.JConsole
 
error(SAXParseException) - Method in class org.meteoinfo.jts.io.gml2.GMLHandler
 
ERROR - Static variable in class org.meteoinfo.jts.operation.valid.TopologyValidationError
Deprecated. 
es - Static variable in class org.meteoinfo.projection.proj4j.parser.Proj4Keyword
 
es - Variable in class org.meteoinfo.projection.proj4j.proj.Projection
The eccentricity squared
ESRI_ASCII_GRID - org.meteoinfo.data.mapdata.MapDataType
 
esriStringToProj4Params(String) - Method in class org.meteoinfo.projection.proj4j.parser.Proj4Parser
 
ETime - Variable in class org.meteoinfo.data.meteodata.awx.AWXDataInfo
 
EUCLIDEAN - org.meteoinfo.geoprocess.analysis.DistanceType
 
EULER - Static variable in class org.meteoinfo.projection.proj4j.proj.SimpleConicProjection
 
EulerProjection - Class in org.meteoinfo.projection.proj4j.proj
 
EulerProjection() - Constructor for class org.meteoinfo.projection.proj4j.proj.EulerProjection
 
eval(Map) - Method in class org.meteoinfo.table.SQLExpression
 
evaluate(float) - Method in class org.meteoinfo.image.math.CompositeFunction1D
 
evaluate(float) - Method in interface org.meteoinfo.image.math.Function1D
 
evaluate(float) - Method in class org.meteoinfo.image.math.MathFunction1D
 
evaluate(float) - Method in class org.meteoinfo.image.math.Noise
 
evaluate(float) - Method in class org.meteoinfo.image.math.SCNoise
 
evaluate(float, float) - Method in class org.meteoinfo.image.filter.CellularFilter
 
evaluate(float, float) - Method in class org.meteoinfo.image.filter.SkyFilter
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.CellularFunction2D
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.FBM
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.FractalSumFunction
 
evaluate(float, float) - Method in interface org.meteoinfo.image.math.Function2D
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.ImageFunction2D
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.MarbleFunction
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.Noise
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.RidgedFBM
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.SCNoise
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.TurbulenceFunction
 
evaluate(float, float) - Method in class org.meteoinfo.image.math.VLNoise
 
evaluate(float, float, float) - Method in interface org.meteoinfo.image.math.Function3D
 
evaluate(float, float, float) - Method in class org.meteoinfo.image.math.Noise
 
evaluate(float, float, float) - Method in class org.meteoinfo.image.math.SCNoise
 
evaluate(Object[]) - Method in class org.meteoinfo.data.mathparser.FunctionExpression
 
evaluate(Object[]) - Method in interface org.meteoinfo.data.mathparser.IExpression
Math evaluate
evaluate(Object[]) - Method in class org.meteoinfo.data.mathparser.NumberExpression
 
evaluate(Object[]) - Method in class org.meteoinfo.data.mathparser.OperatorExpression
 
evaluate(String) - Method in class org.meteoinfo.data.mathparser.MathParser
Evaluates the specified expression
evaluate(BivariateFunction, Number, Number) - Static method in class org.meteoinfo.math.interpolate.InterpUtil
Compute the value of the function
evaluate(BivariateFunction, Array, Array) - Static method in class org.meteoinfo.math.interpolate.InterpUtil
Compute the value of the function
evaluate(UnivariateFunction, Number) - Static method in class org.meteoinfo.math.interpolate.InterpUtil
Compute the value of the function
evaluate(UnivariateFunction, Array) - Static method in class org.meteoinfo.math.interpolate.InterpUtil
Compute the value of the function
EVEN - Static variable in class org.meteoinfo.image.filter.DeinterlaceFilter
 
EVEREST - Static variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
EVRST48 - Static variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
EVRST56 - Static variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
EVRTS69 - Static variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
EVRTSTSS - Static variable in class org.meteoinfo.projection.proj4j.datum.Ellipsoid
 
EXCHANGE - Static variable in class org.meteoinfo.image.filter.PixelUtils
 
EXCLUSION - Static variable in class org.meteoinfo.image.composite.MiscComposite
 
ExclusionComposite - Class in org.meteoinfo.image.composite
 
ExclusionComposite(float) - Constructor for class org.meteoinfo.image.composite.ExclusionComposite
 
execute(Object) - Method in interface org.meteoinfo.jts.util.CollectionUtil.Function
 
execute(CRSFactory) - Method in class org.meteoinfo.projection.proj4j.io.MetaCRSTestCase
 
exp() - Method in class org.meteoinfo.data.GridData
Calculate e raised specific power value of grid data
exp() - Method in class org.meteoinfo.data.StationData
Calculate e raised specific power value of station data
exp() - Method in class org.meteoinfo.math.Complex
 
exp(Object) - Static method in class org.meteoinfo.data.DataMath
Take e base power value
exp(Array) - Static method in class org.meteoinfo.data.ArrayMath
Exponent function
expand() - Method in class org.meteoinfo.legend.ItemNode
Expand the node
EXPAND_BOX_LEFT_PAD - Static variable in class org.meteoinfo.legend.Constants
 
EXPAND_BOX_SIZE - Static variable in class org.meteoinfo.legend.Constants
 
EXPAND_BOX_TOP_PAD - Static variable in class org.meteoinfo.legend.Constants
 
ExpandBuff(boolean) - Method in class org.meteoinfo.console.JavaCharStream
 
expandBy(double) - Method in class org.meteoinfo.jts.geom.Envelope
Expands this envelope by a given distance in all directions.
expandBy(double) - Method in class org.meteoinfo.jts.geom.OctagonalEnvelope
 
expandBy(double, double) - Method in class org.meteoinfo.jts.geom.Envelope
Expands this envelope by a given distance in all directions.
expandEnvelope(Envelope) - Method in interface org.meteoinfo.jts.geom.CoordinateSequence
Expands the given Envelope to include the coordinates in the sequence.
expandEnvelope(Envelope) - Method in class org.meteoinfo.jts.geom.impl.CoordinateArraySequence
 
expandEnvelope(Envelope) - Method in class org.meteoinfo.jts.geom.impl.PackedCoordinateSequence.Double
 
expandEnvelope(Envelope) - Method in class org.meteoinfo.jts.geom.impl.PackedCoordinateSequence.Float
 
expandEnvelope(Envelope) - Method in class org.meteoinfo.jts.operation.distance3d.AxisPlaneCoordinateSequence
 
expandToInclude(double, double) - Method in class org.meteoinfo.jts.geom.Envelope
Enlarges this Envelope so that it contains the given point.
expandToInclude(double, double) - Method in class org.meteoinfo.jts.geom.OctagonalEnvelope
 
expandToInclude(Coordinate) - Method in class org.meteoinfo.jts.geom.Envelope
Enlarges this Envelope so that it contains the given Coordinate.
expandToInclude(Coordinate) - Method in class org.meteoinfo.jts.geom.OctagonalEnvelope
 
expandToInclude(CoordinateSequence) - Method in class org.meteoinfo.jts.geom.OctagonalEnvelope
 
expandToInclude(Envelope) - Method in class org.meteoinfo.jts.geom.Envelope
Enlarges this Envelope so that it contains the other Envelope.
expandToInclude(Envelope) - Method in class org.meteoinfo.jts.geom.OctagonalEnvelope
 
expandToInclude(Geometry) - Method in class org.meteoinfo.jts.geom.OctagonalEnvelope
 
expandToInclude(OctagonalEnvelope) - Method in class org.meteoinfo.jts.geom.OctagonalEnvelope
 
expandToInclude(Interval) - Method in class org.meteoinfo.jts.index.bintree.Interval
 
expandToInclude(Interval) - Method in class org.meteoinfo.jts.index.strtree.Interval
 
expFit(Array, Array) - Static method in class org.meteoinfo.math.fitting.FittingUtil
Exponent fitting
exponent(double) - Static method in class org.meteoinfo.jts.index.quadtree.DoubleBits
 
EXPONENT_BIAS - Static variable in class org.meteoinfo.jts.index.quadtree.DoubleBits
 
exponents - Variable in class org.meteoinfo.image.math.FBM
 
exportExtentsElement(Document, Element) - Method in class org.meteoinfo.map.MapView
Add extent element
exportGraphics(Document, Element, List<Graphic>) - Method in class org.meteoinfo.map.MapView
Export graphics
exportGridLineElement(Document, Element) - Method in class org.meteoinfo.map.MapView
Export grid line element
exportImageLayer(Document, Element, ImageLayer, String) - Method in class org.meteoinfo.map.MapView
Export image layer element
exportMapPropElement(Document, Element) - Method in class org.meteoinfo.map.MapView
Export map property element
exportMaskOutElement(Document, Element) - Method in class org.meteoinfo.map.MapView
Export maskout element
exportProjectionElement(Document, Element) - Method in class org.meteoinfo.map.MapView
Export projection element
exportProjectXML(Document, Element) - Method in class org.meteoinfo.layout.MapLayout
Export project XML content
exportProjectXML(Document, Element, String) - Method in class org.meteoinfo.legend.LayersLegend
Export project XML content
exportProjectXML(Document, Element, String) - Method in class org.meteoinfo.legend.MapFrame
Export project XML content
exportRasterLayer(Document, Element, RasterLayer, String) - Method in class org.meteoinfo.map.MapView
Export raster layer element
exportToPicture(String) - Method in class org.meteoinfo.layout.MapLayout
Export to a picture file
exportToPicture(String) - Method in class org.meteoinfo.map.MapView
Export to a picture file
exportToPicture(String, Chart, int, int) - Static method in class org.meteoinfo.plot.PlotUtil
Save chart as PNG image file
exportToXML(Document, Element) - Method in class org.meteoinfo.legend.ColorBreak
Export to XML document
exportToXML(Document, Element) - Method in class org.meteoinfo.legend.LegendScheme
Export to xml document
exportToXML(Document, Element) - Method in class org.meteoinfo.legend.PointBreak
Export to xml document
exportToXML(Document, Element) - Method in class org.meteoinfo.shape.ChartGraphic
Export to XML document
exportToXML(Document, Element) - Method in class org.meteoinfo.shape.Graphic
Export to XML document
exportToXMLFile(String) - Method in class org.meteoinfo.legend.LegendScheme
Export to xml file
exportVectorLayerElement(Document, Element, VectorLayer, String) - Method in class org.meteoinfo.map.MapView
Export vector layer element
exportWebMapLayer(Document, Element, WebMapLayer, String) - Method in class org.meteoinfo.map.MapView
Export web map layer element
ExposureFilter - Class in org.meteoinfo.image.filter
A filter which changes the exposure of an image.
ExposureFilter() - Constructor for class org.meteoinfo.image.filter.ExposureFilter
 
ExpressionBase - Class in org.meteoinfo.data.mathparser
 
ExpressionBase() - Constructor for class org.meteoinfo.data.mathparser.ExpressionBase
 
ExpTrendLine - Class in org.meteoinfo.math.fitting
 
ExpTrendLine() - Constructor for class org.meteoinfo.math.fitting.ExpTrendLine
 
extend(double) - Method in class org.meteoinfo.global.Extent
Extends extent by ratio
extend(double) - Method in class org.meteoinfo.global.Extent3D
Extends extent by ratio
extend(double, double) - Method in class org.meteoinfo.global.Extent
Extends extent
extend(double, double, double) - Method in class org.meteoinfo.global.Extent3D
Extends extent
extend(Margin) - Method in class org.meteoinfo.chart.Margin
Extent
extend(CoordinateSequenceFactory, CoordinateSequence, int) - Static method in class org.meteoinfo.jts.geom.CoordinateSequences
 
extendHalfCell(Array, Array) - Static method in class org.meteoinfo.data.ArrayUtil
Extend the grid to half cell, so the grid points are the centers of the cells
extendRect - Variable in class org.meteoinfo.chart.ChartLegend
 
extendToGlobal() - Method in class org.meteoinfo.data.GridData
Extend the grid data to global by add a new column data
extent - Variable in class org.meteoinfo.jts.shape.GeometricShapeBuilder
 
Extent - Class in org.meteoinfo.global
Template
Extent() - Constructor for class org.meteoinfo.global.Extent
Constructor
Extent(double, double, double, double) - Constructor for class org.meteoinfo.global.Extent
Constructor
Extent(Extent) - Constructor for class org.meteoinfo.global.Extent
Constructor
Extent3D - Class in org.meteoinfo.global
 
Extent3D() - Constructor for class org.meteoinfo.global.Extent3D
Constructor
Extent3D(double, double, double, double, double, double) - Constructor for class org.meteoinfo.global.Extent3D
Constructor
EXTERIOR - Static variable in class org.meteoinfo.jts.geom.Location
The location value for the exterior of a geometry.
extraAlpha - Variable in class org.meteoinfo.image.composite.MiscComposite
 
extraAlpha - Variable in class org.meteoinfo.image.composite.RGBComposite
 
extract(double, double, double) - Method in class org.meteoinfo.data.meteodata.Dimension
Extract dimension
extract(double, double, double, double) - Method in class org.meteoinfo.data.GridData
Extract grid data by extent
extract(int, int, int) - Method in class org.meteoinfo.data.meteodata.Dimension
Extract dimension
extract(int, int, int, int) - Method in class org.meteoinfo.data.GridData
Extract grid data by extent index
extract(int, int, int, int, int, int) - Method in class org.meteoinfo.data.GridData
Extract grid data by extent index
extract(List<Integer>) - Method in class org.meteoinfo.data.meteodata.Dimension
Extract dimension
extract(Extent) - Method in class org.meteoinfo.data.GridData
Extract grid data by extent
extract(Coordinate[], int, int) - Static method in class org.meteoinfo.jts.geom.CoordinateArrays
Extracts a subsequence of the input Coordinate array from indices start to end (inclusive).
extract(Geometry, Class) - Static method in class org.meteoinfo.jts.geom.util.GeometryExtracter
Extracts the components of type clz from a Geometry and returns them in a List.
extract(Geometry, Class, List) - Static method in class org.meteoinfo.jts.geom.util.GeometryExtracter
Extracts the components of type clz from a Geometry and adds them to the provided List.
extractFactory(Collection) - Static method in class org.meteoinfo.jts.geom.util.GeometryCombiner
Extracts the GeometryFactory used by the geometries in a collection
extractLine(double, double) - Method in class org.meteoinfo.jts.linearref.LengthIndexedLine
Computes the LineString for the interval on the line between the given indices.
extractLine(LinearLocation, LinearLocation) - Method in class org.meteoinfo.jts.linearref.LocationIndexedLine
Computes the LineString for the interval on the line between the given indices.
extractNodedSegmentStrings(Geometry) - Static method in class org.meteoinfo.jts.noding.SegmentStringUtil
Extracts all linear components from a given Geometry to SegmentStrings.
extractPoint(double) - Method in class org.meteoinfo.jts.linearref.LengthIndexedLine
Computes the Coordinate for the point on the line at the given index.
extractPoint(double, double) - Method in class org.meteoinfo.jts.linearref.LengthIndexedLine
Computes the Coordinate for the point on the line at the given index, offset by the given distance.
extractPoint(LinearLocation) - Method in class org.meteoinfo.jts.linearref.LocationIndexedLine
Computes the Coordinate for the point on the line at the given index.
extractPoint(LinearLocation, double) - Method in class org.meteoinfo.jts.linearref.LocationIndexedLine
Computes the Coordinate for the point on the line at the given index, offset by the given distance.
extractSegmentStrings(Geometry) - Static method in class org.meteoinfo.jts.noding.SegmentStringUtil
Extracts all linear components from a given Geometry to SegmentStrings.
extractStationData(List<String>, List<String>) - Method in class org.meteoinfo.data.meteodata.StationInfoData
Extract station data
extractStationData(List<String>, List<String>, Date) - Method in class org.meteoinfo.data.meteodata.StationInfoData
Extract station data
extractUniqueCoordinates(Geometry) - Static method in class org.meteoinfo.jts.triangulate.DelaunayTriangulationBuilder
Extracts the unique Coordinates from the given Geometry.
eye(int, int, int, String) - Static method in class org.meteoinfo.data.ArrayUtil
Return a 2-D array with ones on the diagonal and zeros elsewhere.
A B C D E F G H I J K L M N O P Q R S T U V W X Y Z _