Package | Description |
---|---|
org.opengis.annotation | |
org.opengis.coverage |
Coverages (generate a value for any point).
|
org.opengis.coverage.grid |
Quadrilateral grid coverages.
|
org.opengis.coverage.processing | |
org.opengis.feature.type |
Feature model ISO 19109 with allowances for usability.
|
org.opengis.filter.capability | |
org.opengis.filter.sort |
An SortBy indicates the ordering requested during a data query.
|
org.opengis.geometry |
Root package for geometries.
|
org.opengis.geometry.aggregate |
Aggregations of geometric objects.
|
org.opengis.geometry.complex |
Set of primitive geometric objects whose interiors are disjoint.
|
org.opengis.geometry.coordinate |
Set of geometric objects.
|
org.opengis.geometry.primitive |
Set of geometric objects that are not decomposed further into
other primitives.
|
org.opengis.metadata |
Root package for metadata.
|
org.opengis.metadata.citation |
Citation and responsible party information.
|
org.opengis.metadata.constraint |
Constraints information (includes legal and
security).
|
org.opengis.metadata.content |
Content information (includes
Feature catalogue and Coverage descriptions).
|
org.opengis.metadata.distribution |
Distribution information.
|
org.opengis.metadata.extent |
Extent information.
|
org.opengis.metadata.identification |
Identification information (includes data and
service identification).
|
org.opengis.metadata.lineage |
Lineage information.
|
org.opengis.metadata.maintenance | |
org.opengis.metadata.quality | |
org.opengis.metadata.spatial |
Spatial representation
information (includes grid and vector representation).
|
org.opengis.parameter |
Description and storage of parameter values.
|
org.opengis.referencing | |
org.opengis.referencing.crs | |
org.opengis.referencing.cs |
Coordinate systems and their axis.
|
org.opengis.referencing.datum |
Geodetic datum (the relationship of a
coordinate system to the earth).
|
org.opengis.referencing.operation |
Coordinate operations
(relationship between any two coordinate reference systems).
|
org.opengis.style |
The following package is an implementation of OGC Symbology Encoding 1.1.0 and ISO 19117 : Portrayal
This package is a merge from package GeoAPI SLD (v1.0.0) and GeoTools styling.
|
org.opengis.temporal | |
org.opengis.util |
A set of base types from ISO 19103 which can not be mapped directly from Java, plus utilities.
|
Modifier and Type | Class and Description |
---|---|
class |
Obligation
Obligation of the element or entity.
|
Modifier and Type | Class and Description |
---|---|
class |
ColorInterpretation
Specifies the mapping of a band to a color model component.
|
interface |
Coverage
A function from a spatial, temporal or spatiotemporal domain to an attribute range.
|
class |
InterpolationMethod
A list of codes that identify interpolation methods that may be used for evaluating continuous coverages.
|
class |
PaletteInterpretation
Describes the color entry in a color table.
|
class |
PointOutsideCoverageException
Thrown when a
evaluate method is invoked
for a location outside the domain of the coverage. |
interface |
SampleDimension
Contains information for an individual sample dimension of coverage.
|
class |
SampleDimensionType
Specifies the various dimension types for coverage values.
|
Modifier and Type | Field and Description |
---|---|
static ColorInterpretation |
ColorInterpretation.ALPHA_BAND
Alpha Band for the RGB color model components.
|
static InterpolationMethod |
InterpolationMethod.BARYCENTRIC
Barycentric interpolation.
|
static InterpolationMethod |
InterpolationMethod.BICUBIC
Interpolation based on the assumption that feature attribute values vary as a bicubic
function of position within the grid cell.
|
static InterpolationMethod |
InterpolationMethod.BILINEAR
Interpolation based on the assumption that feature attribute values vary as a bilinear
function of position within the grid cell.
|
static InterpolationMethod |
InterpolationMethod.BIQUADRATIC
Interpolation based on the assumption that feature attribute values vary as a biquadratic
function of position within the grid cell.
|
static ColorInterpretation |
ColorInterpretation.BLACK_BAND
Black Band for the CMYK color model.
|
static ColorInterpretation |
ColorInterpretation.BLUE_BAND
Blue Band for the RGB color model components.
|
static PaletteInterpretation |
PaletteInterpretation.CMYK
CYMK (Cyan Yellow Magenta blacK) color palette.
|
static InterpolationMethod |
InterpolationMethod.CUBIC
Interpolation based on the assumption that feature attribute values vary as a cubic function
of distance along a value segment.
|
static ColorInterpretation |
ColorInterpretation.CYAN_BAND
Cyan Band for the CMYK color model.
|
static PaletteInterpretation |
PaletteInterpretation.GRAY
Gray Scale color palette.
|
static ColorInterpretation |
ColorInterpretation.GRAY_INDEX
Band is an index into a lookup table.
|
static ColorInterpretation |
ColorInterpretation.GREEN_BAND
Greend Band for the RGB color model components.
|
static PaletteInterpretation |
PaletteInterpretation.HLS
HSL (Hue Saturation Lightness) color palette.
|
static ColorInterpretation |
ColorInterpretation.HUE_BAND
Hue Band for the HLS color model.
|
static ColorInterpretation |
ColorInterpretation.LIGHTNESS_BAND
Lightness Band for the HLS color model.
|
static InterpolationMethod |
InterpolationMethod.LINEAR
Interpolation based on the assumption that feature attribute values vary in proportion to
distance along a value segment.
|
static InterpolationMethod |
InterpolationMethod.LOST_AREA
Lost area interpolation.
|
static ColorInterpretation |
ColorInterpretation.MAGENTA_BAND
Magenta Band for the CMYK color model.
|
static InterpolationMethod |
InterpolationMethod.NEAREST_NEIGHBOUR
Generates a feature attribute value at a direct position by assigning it the feature
attribute value associated with the nearest domain object in the domain of the coverage.
|
static ColorInterpretation |
ColorInterpretation.PALETTE_INDEX
Band is a color index into a color table.
|
static InterpolationMethod |
InterpolationMethod.QUADRATIC
Interpolation based on the assumption that feature attribute values vary as a quadratic
function of distance along a value segment.
|
static SampleDimensionType |
SampleDimensionType.REAL_32BITS
Simple precision floating point numbers.
|
static SampleDimensionType |
SampleDimensionType.REAL_64BITS
Double precision floating point numbers.
|
static ColorInterpretation |
ColorInterpretation.RED_BAND
Red Band for the RGB color model components.
|
static PaletteInterpretation |
PaletteInterpretation.RGB
RGB (Red Green Blue) color palette.
|
static ColorInterpretation |
ColorInterpretation.SATURATION_BAND
Saturation Band for the HLS color model.
|
static SampleDimensionType |
SampleDimensionType.SIGNED_16BITS
Signed 16 bits integers.
|
static SampleDimensionType |
SampleDimensionType.SIGNED_32BITS
Signed 32 bits integers.
|
static SampleDimensionType |
SampleDimensionType.SIGNED_8BITS
Signed 8 bits integers.
|
static ColorInterpretation |
ColorInterpretation.UNDEFINED
Band is not associated with a color model component.
|
static SampleDimensionType |
SampleDimensionType.UNSIGNED_16BITS
Unsigned 16 bits integers.
|
static SampleDimensionType |
SampleDimensionType.UNSIGNED_1BIT
Unsigned 1 bit integers.
|
static SampleDimensionType |
SampleDimensionType.UNSIGNED_2BITS
Unsigned 2 bits integers.
|
static SampleDimensionType |
SampleDimensionType.UNSIGNED_32BITS
Unsigned 32 bits integers.
|
static SampleDimensionType |
SampleDimensionType.UNSIGNED_4BITS
Unsigned 4 bits integers.
|
static SampleDimensionType |
SampleDimensionType.UNSIGNED_8BITS
Unsigned 8 bits integers.
|
static ColorInterpretation |
ColorInterpretation.YELLOW_BAND
Yellow Band for the CMYK color model.
|
Modifier and Type | Method and Description |
---|---|
Object |
Coverage.evaluate(DirectPosition point)
Return the value vector for a given point in the coverage.
|
boolean[] |
Coverage.evaluate(DirectPosition point,
boolean[] destination)
Return a sequence of boolean values for a given point in the coverage.
|
byte[] |
Coverage.evaluate(DirectPosition point,
byte[] destination)
Return a sequence of unsigned byte values for a given point in the coverage.
|
Set<Record> |
Coverage.evaluate(DirectPosition p,
Collection<String> list)
Returns a set of records of feature attribute values for the specified direct position.
|
double[] |
Coverage.evaluate(DirectPosition point,
double[] destination)
Return a sequence of double values for a given point in the coverage.
|
int[] |
Coverage.evaluate(DirectPosition point,
int[] destination)
Return a sequence of integer values for a given point in the coverage.
|
InternationalString[] |
SampleDimension.getCategoryNames()
Sequence of category names for the values contained in a sample dimension.
|
CoordinateReferenceSystem |
Coverage.getCoordinateReferenceSystem()
Returns the coordinate reference system to which the objects in its domain are referenced.
|
InternationalString |
SampleDimension.getDescription()
Sample dimension title or description.
|
Envelope |
Coverage.getEnvelope()
The bounding box for the coverage domain in coordinate reference system coordinates.
|
double |
SampleDimension.getMaximumValue()
The maximum value occurring in the sample dimension.
|
double |
SampleDimension.getMinimumValue()
The minimum value occurring in the sample dimension.
|
double[] |
SampleDimension.getNoDataValues()
Values to indicate no data values for the sample dimension.
|
int |
Coverage.getNumSampleDimensions()
The number of sample dimensions in the coverage.
|
double |
SampleDimension.getOffset()
Offset is the value to add to grid values for this sample dimension.
|
RecordType |
Coverage.getRangeType()
Describes the range of the coverage.
|
SampleDimension |
Coverage.getSampleDimension(int index)
Retrieve sample dimension information for the coverage.
|
SampleDimensionType |
SampleDimension.getSampleDimensionType()
A code value indicating grid value data type.
|
double |
SampleDimension.getScale()
Scale is the value which is multiplied to grid values for this sample dimension.
|
List<? extends Coverage> |
Coverage.getSources()
Returns the sources data for a coverage.
|
Unit<?> |
SampleDimension.getUnits()
The unit information for this sample dimension.
|
Modifier and Type | Interface and Description |
---|---|
interface |
Format
A discovery mechanism to determine the formats supported by a
GridCoverageExchange
implementation. |
interface |
GridCoordinates
Holds the set of grid coordinates that specifies the location of the grid
point within the grid.
|
interface |
GridCoverage
Represent the basic implementation which provides access to grid coverage data.
|
interface |
GridEnvelope
Provides the grid coordinate values for the diametrically opposed
corners of the grid.
|
interface |
GridGeometry
Describes the geometry and georeferencing information of the grid coverage.
|
class |
GridNotEditableException
Thrown when an attempt is made to write in a non-editable grid.
|
class |
InvalidRangeException
Thrown when a grid range is out of grid coverage
bounds.
|
Modifier and Type | Method and Description |
---|---|
int[] |
GridCoordinates.getCoordinateValues()
Returns one integer value for each dimension of the grid.
|
String |
Format.getDescription()
Description of the file format.
|
String |
Format.getDocURL()
Documentation URL for the format.
|
GridGeometry |
GridCoverage.getGridGeometry()
Information for the grid coverage geometry.
|
GridEnvelope |
GridGeometry.getGridRange()
The valid coordinate range of a grid coverage.
|
MathTransform |
GridGeometry.getGridToCRS()
Returns the conversion from grid coordinates to real world earth coordinates.
|
GridCoordinates |
GridEnvelope.getHigh()
Returns the maximal coordinate values for all grid points within the grid.
|
GridCoordinates |
GridEnvelope.getLow()
Returns the minimal coordinate values for all grid points within the grid.
|
String |
Format.getName()
Name of the file format.
|
int |
GridCoverage.getNumOverviews()
Number of predetermined overviews for the grid.
|
int[] |
GridCoverage.getOptimalDataBlockSizes()
Optimal size to use for each dimension when accessing grid values.
|
GridCoverage |
GridCoverage.getOverview(int index)
Returns a pre-calculated overview for a grid coverage.
|
GridGeometry |
GridCoverage.getOverviewGridGeometry(int index)
Returns the grid geometry for an overview.
|
ParameterValueGroup |
Format.getReadParameters()
Retrieve the parameter information for a
read operation. |
String |
Format.getVendor()
Vendor or agency for the format.
|
String |
Format.getVersion()
Version number of the format.
|
ParameterValueGroup |
Format.getWriteParameters()
Retrieve the parameter information for a
write operation. |
boolean |
GridCoverage.isDataEditable()
Returns
true if grid data can be edited. |
Modifier and Type | Interface and Description |
---|---|
interface |
GridCoverageProcessor
Provides operations for different ways of accessing the grid coverage values as well as image
processing functionality.
|
interface |
Operation
This interface provides descriptive information for a grid coverage processing operation.
|
class |
OperationNotFoundException
Throws if an operation name given to
GridCoverageProcessor is not a know operation. |
Modifier and Type | Method and Description |
---|---|
String |
Operation.getDescription()
Description of the processing operation.
|
String |
Operation.getDocURL()
URL for documentation on the processing operation.
|
String |
Operation.getName()
Name of the processing operation.
|
int |
Operation.getNumSources()
Number of source grid coverages required for the operation.
|
Collection<Operation> |
GridCoverageProcessor.getOperations()
Retrieves grid processing operations information.
|
ParameterValueGroup |
Operation.getParameters()
Retrieve the parameters information.
|
String |
Operation.getVendor()
Vendor of the processing operation implementation.
|
String |
Operation.getVersion()
Version number for the implementation.
|
Modifier and Type | Interface and Description |
---|---|
interface |
Namespace
A set of 0 or more names, with no duplicates.
|
Modifier and Type | Method and Description |
---|---|
String |
Name.getNamespaceURI()
Returns the URI of the namespace for this name.
|
String |
Name.getURI()
Convert this name to a complete URI.
|
Modifier and Type | Method and Description |
---|---|
int |
FunctionName.getArgumentCount()
Number of arguments the function accepts.
|
ArithmeticOperators |
ScalarCapabilities.getArithmeticOperators()
Provided arithmetic operators.
|
ComparisonOperators |
ScalarCapabilities.getComparisonOperators()
Provided comparison operators.
|
IdCapabilities |
FilterCapabilities.getIdCapabilities() |
String |
Operator.getName()
Name of supported Operator.
|
ScalarCapabilities |
FilterCapabilities.getScalarCapabilities() |
SpatialCapabilities |
FilterCapabilities.getSpatialCapabilities() |
TemporalCapabilities |
FilterCapabilities.getTemporalCapabilities() |
Modifier and Type | Field and Description |
---|---|
static SortOrder |
SortOrder.ASCENDING
Represents acending order.
|
static SortOrder |
SortOrder.DESCENDING
Represents descending order.
|
Modifier and Type | Interface and Description |
---|---|
interface |
Boundary
The abstract root data type for all the data types used to represent the boundary of geometric
objects.
|
interface |
DirectPosition
Holds the coordinates for a position within some coordinate reference system.
|
interface |
Envelope
A minimum bounding box or rectangle.
|
interface |
Geometry
Root class of the geometric object taxonomy.
|
interface |
TransfiniteSet
A possibly infinite set; restricted only to values.
|
Modifier and Type | Method and Description |
---|---|
double |
Geometry.distance(Geometry geometry)
Returns the distance between this
Geometry and another Geometry . |
Boundary |
Geometry.getBoundary()
Returns a finite set of
Geometry s containing all of the direct positions on the
boundary of this Geometry . |
Geometry |
Geometry.getBuffer(double distance)
Returns a
Geometry containing all points whose distance from this Geometry is
less than or equal to the distance passed as a parameter. |
DirectPosition |
Geometry.getCentroid()
Returns the mathematical centroid for this
Geometry . |
Complex |
Geometry.getClosure()
Returns a finite set of
Geometry s containing all of the points on the boundary of
this Geometry and this object (the union of the object and its boundary). |
Geometry |
Geometry.getConvexHull()
Returns a
Geometry that represents the convex hull of this Geometry . |
double[] |
DirectPosition.getCoordinate()
A copy of the ordinates presented as an array of double values.
|
int |
Geometry.getCoordinateDimension()
Returns the dimension of the coordinates that define this
Geometry , which must be the
same as the coordinate dimension of the coordinate reference system for this Geometry . |
CoordinateReferenceSystem |
Geometry.getCoordinateReferenceSystem()
Returns the coordinate reference system used in direct position
coordinates.
|
CoordinateReferenceSystem |
DirectPosition.getCoordinateReferenceSystem()
The coordinate reference system in which the coordinate is given.
|
int |
DirectPosition.getDimension()
The length of coordinate sequence (the number of entries).
|
int |
Geometry.getDimension(DirectPosition point)
Returns the inherent dimension of this
Geometry , which shall be less than or equal to
the coordinate dimension. |
Envelope |
Geometry.getEnvelope()
Returns the minimum bounding box for this
Geometry . |
DirectPosition |
Envelope.getLowerCorner()
A coordinate position consisting of all the minimal ordinates for each dimension for all
points within the
Envelope . |
Set<? extends Complex> |
Geometry.getMaximalComplex()
Returns the set of maximal complexes within which this
Geometry is contained. |
Geometry |
Geometry.getMbRegion()
Returns a region in the coordinate reference system that contains this
Geometry . |
DirectPosition |
Geometry.getRepresentativePoint()
Returns a point value that is guaranteed to be on this
Geometry . |
DirectPosition |
Envelope.getUpperCorner()
A coordinate position consisting of all the maximal ordinates for each dimension for all
points within the
Envelope . |
boolean |
Geometry.isCycle()
Returns
true if this Geometry has an empty boundary after topological
simplification (removal of overlaps between components in non-structured aggregates, such as
subclasses of Aggregate ). |
boolean |
Boundary.isCycle()
Always returns
true since boundary objects are cycles. |
boolean |
Geometry.isSimple()
Returns
true if this Geometry has no interior point of self-intersection or
selftangency. |
Geometry |
Geometry.transform(CoordinateReferenceSystem newCRS)
Returns a new
Geometry that is the coordinate transformation of this Geometry
into the passed coordinate reference system within the accuracy of the transformation. |
Modifier and Type | Interface and Description |
---|---|
interface |
Aggregate
Geometry that is an aggregate of other geometries.
|
interface |
MultiCurve
An aggregate class containing only instances of
OrientableCurve . |
interface |
MultiPrimitive
|
interface |
MultiSurface
An aggregate class containing only instances of
OrientableSurface . |
Modifier and Type | Method and Description |
---|---|
double |
MultiSurface.getArea()
Returns the accumulated area of all orientable surfaces
contained in this
MultiSurface . |
Set<? extends Geometry> |
Aggregate.getElements()
Returns the set containing the elements that compose this aggregate.
|
Set<? extends Primitive> |
MultiPrimitive.getElements()
Returns the set containing the primitives that compose this aggregate.
|
Set<Point> |
MultiPoint.getElements()
Returns the set containing the elements that compose this
MultiPoint . |
Set<OrientableSurface> |
MultiSurface.getElements()
Returns the set containing the orientable surfaces that
compose this
MultiSurface . |
Set<OrientableCurve> |
MultiCurve.getElements()
Returns the set containing the orientable curves that compose
this
MultiCurve . |
double |
MultiCurve.length()
Returns the accumulated length of all orientable curves
contained in this
MultiCurve . |
Modifier and Type | Interface and Description |
---|---|
interface |
Complex
A collection of geometrically disjoint, simple primitives.
|
interface |
ComplexBoundary
The boundary of complex objects.
|
interface |
Composite
A geometric complex with an underlying core geometry that is isomorphic to a primitive.
|
interface |
CompositeCurve
A complex with all the geometric properties of a curve.
|
interface |
CompositePoint
A separate class for composite point, included for completeness.
|
interface |
CompositeSolid
A complex with all the geometric properties of a solid.
|
interface |
CompositeSurface
A complex with all the geometric properties of a surface.
|
Modifier and Type | Method and Description |
---|---|
Collection<? extends Primitive> |
Complex.getElements()
Returns the collection of primitives contained in this complex.
|
Set<Solid> |
CompositeSolid.getGenerators()
Returns the set of solids that form the core of this complex.
|
List<OrientableCurve> |
CompositeCurve.getGenerators()
Returns the list of orientable curves in this composite.
|
Set<OrientableSurface> |
CompositeSurface.getGenerators()
Returns the set of orientable surfaces that form the core of this complex.
|
Collection<? extends Primitive> |
Composite.getGenerators()
Returns a homogeneous collection of primitives whose union would be
the core geometry of the composite.
|
List<Point> |
CompositePoint.getGenerators()
Returns the single point in this composite.
|
Complex[] |
Complex.getSubComplexes()
Returns a subset of the primitives of that complex that is, in its own right, a geometric
complex.
|
Complex[] |
Complex.getSuperComplexes()
Returns a superset of primitives that is also a complex.
|
boolean |
Complex.isMaximal()
Returns
true if and only if this Complex is maximal. |
Modifier and Type | Interface and Description |
---|---|
interface |
AffinePlacement
A placement defined by linear transformation from the parameter space to the target coordinate
space.
|
interface |
Arc
Arc of the circle determined by 3 points, starting at the first, passing through the second and
terminating at the third.
|
interface |
ArcByBulge
Equivalents to the
Arc , except the bulge representation is maintained. |
interface |
ArcString
Similar to a line string except that the interpolation is by circular
arcs.
|
interface |
ArcStringByBulge
A variant of the arc that stores the parameters of the second constructor of the component
arcs and recalculates the other attributes of the standard arc.
|
interface |
Bezier
Polynomial splines that use Bezier or Bernstein polynomials for interpolation purposes.
|
interface |
BicubicGrid
A gridded surface that uses cubic polynomial splines as the
horizontal and vertical curves.
|
interface |
BilinearGrid
A gridded surface that uses line strings as the horizontal and
vertical curves.
|
interface |
BSplineCurve
A piecewise parametric polynomial or rational curve described in terms of control points and
basis functions.
|
interface |
BSplineSurface
A rational or polynomial parametric surface that is represented by control points, basis
functions and possibly weights.
|
class |
BSplineSurfaceForm
Indicates a particular geometric form represented by a
BSplineSurface . |
interface |
Circle
Same as an arc, but closed to form a full circle.
|
interface |
Clothoid
The clothoid (or Cornu's spiral), a plane curve whose curvature is a fixed function of its
length.
|
interface |
Cone
A gridded surface given as a family of conic sections whose
control points vary linearly.
|
interface |
Conic
Any general conic curve.
|
interface |
CubicSpline
Cubic splines.
|
interface |
Cylinder
A gridded surface given as a family of circles whose positions vary
along a set of parallel lines, keeping the cross sectional horizontal curves of a constant shape.
|
interface |
GenericCurve
Common interface for curve and curve segment.
|
interface |
GenericSurface
Common interface for surface and surface patch.
|
interface |
Geodesic
Two distinct positions joined by a geodesic curve.
|
interface |
GeodesicString
Sequence of geodesic segments.
|
interface |
GriddedSurface
A parametric curve surface defined from a rectangular grid in
the parameter space.
|
interface |
Knot
Controls the constructive parameter space for spline curves and surfaces.
|
class |
KnotType
The type of a B-spline.
|
interface |
LineSegment
|
interface |
LineString
A sequence of line segments, each having a parameterization like the one
LineSegment . |
interface |
OffsetCurve
A curve at a constant distance from the basis curve.
|
interface |
ParametricCurveSurface
The surface patches that make up the parametric curve surfaces.
|
interface |
ParamForPoint
The curve parameter for a point.
|
interface |
Placement
Takes a standard geometric construction and places it in geographic space.
|
interface |
PointArray
A sequence of points.
|
interface |
PointGrid
A grid of points.
|
interface |
Polygon
A surface patch that is defined by a set of boundary curves and an underlying surface to which
these curves adhere.
|
interface |
PolyhedralSurface
A surface composed of polygon surfaces connected along their common boundary
curves.
|
interface |
PolynomialSpline
A polynimal spline.
|
interface |
Position
A type consisting of either a direct position or of a point from which a direct position shall be obtained.
|
interface |
Sphere
A gridded surface given as a family of circles whose positions vary
linearly along the axis of the sphere, and whose radius varies in proportion to the cosine
function of the central angle.
|
interface |
SplineCurve
Root for subtypes of curve segment using some version of spline, either
polynomial or rational functions.
|
class |
SplineCurveForm
Indicates which sort of curve may be approximated by a particular B-spline.
|
interface |
Tin
A triangulated surface that uses the Delaunay algorithm or a similar algorithm complemented with
consideration for breaklines, stoplines and maximum length of triangle sides.
|
interface |
Triangle
A planar polygon defined by 3 corners.
|
interface |
TriangulatedSurface
A polyhedral surface that is composed only of triangles.
|
Modifier and Type | Field and Description |
---|---|
static SplineCurveForm |
SplineCurveForm.CIRCULAR_ARC
An arc of a circle or a complete circle.
|
static BSplineSurfaceForm |
BSplineSurfaceForm.CONICAL
A bounded portion of the surface of a right circular cone represented by a B-spline surface.
|
static BSplineSurfaceForm |
BSplineSurfaceForm.CYLINDRICAL
A bounded portion of a cylindrical surface represented by a B-spline surface.
|
static SplineCurveForm |
SplineCurveForm.ELLIPTICAL_ARC
An arc of an ellipse or a complete ellipse.
|
static SplineCurveForm |
SplineCurveForm.HYPERBOLIC_ARC
An arc of a finite length of one branch of a hyperbola.
|
static SplineCurveForm |
SplineCurveForm.PARABOLIC_ARC
An arc of a finite length of a parabola.
|
static KnotType |
KnotType.PIECEWISE_BEZIER
The form of knots is appropriate for a piecewise Bezier curve.
|
static BSplineSurfaceForm |
BSplineSurfaceForm.PLANAR
A bounded portion of a plane represented by a B-spline surface of degree 1 in each parameter.
|
static SplineCurveForm |
SplineCurveForm.POLYLINE_FORM
A connected sequence of line segments represented by a 1 degree B-spline (a line string).
|
static KnotType |
KnotType.QUASI_UNIFORM
The form of knots is appropriate for a quasi-uniform B-spline.
|
static BSplineSurfaceForm |
BSplineSurfaceForm.SPHERICAL
A bounded portion of a sphere, or a complete sphere represented by a B-spline surface.
|
static BSplineSurfaceForm |
BSplineSurfaceForm.TOROIDAL
A torus or a portion of a torus represented by a B-spline surface.
|
static KnotType |
KnotType.UNIFORM
The form of knots is appropriate for a uniform B-spline.
|
static BSplineSurfaceForm |
BSplineSurfaceForm.UNSPECIFIED
No particular surface is specified..
|
Modifier and Type | Method and Description |
---|---|
List<Arc> |
ArcString.asArcs()
Constructs a sequence of arcs that is the geometric equivalent of this arc string.
|
ArcString |
ArcStringByBulge.asArcString()
Recast as a base arc string.
|
List<Geodesic> |
GeodesicString.asGeodesics()
Decomposes a geodesic string into an equivalent sequence of geodesic segments.
|
List<LineSegment> |
LineString.asLineSegments()
Decomposes a line string into an equivalent sequence of line segments.
|
LineString |
GenericCurve.asLineString(double maxSpacing,
double maxOffset)
Constructs a line string (sequence of line segments) where the control points (ends of the
segments) lie on this curve.
|
Arc |
GeometryFactory.createArc(Position startPoint,
Position endPoint,
double bulge,
double[] normal)
Takes two positions and the offset of the midpoint of the arc from the midpoint of the chord,
given by a distance and direction, and constructs the corresponding arc.
|
Arc |
GeometryFactory.createArc(Position startPoint,
Position midPoint,
Position endPoint)
Takes three positions and constructs the corresponding arc.
|
ArcByBulge |
GeometryFactory.createArcByBulge(Position startPoint,
Position endPoint,
double bulge,
double[] normal)
Equivalents to the second
constructor of arc, except the bulge representation is maintained.
|
ArcString |
GeometryFactory.createArcString(List<Position> points)
Takes a sequence of positions and constructs a sequence of 3-point arcs
jointing them.
|
ArcStringByBulge |
GeometryFactory.createArcStringByBulge(List<Position> points,
double[] bulges,
List<double[]> normals)
Equivalent to the second
constructor of arc, except the bulge representation is maintained internal to the object.
|
BSplineCurve |
GeometryFactory.createBSplineCurve(int degree,
PointArray points,
List<Knot> knots,
KnotType knotSpec)
Constructs a B-spline curve.
|
BSplineSurface |
GeometryFactory.createBSplineSurface(List<PointArray> points,
int[] degree,
List<Knot>[] knots,
KnotType knotSpec)
Constructs a B-spline surface.
|
GeodesicString |
GeometryFactory.createGeodesicString(List<Position> points)
Takes two or more positions, interpolates using a geodesic defined from the geoid (or
ellipsoid) of the coordinate reference system being
used, and creates the appropriate geodesic string joining them.
|
LineSegment |
GeometryFactory.createLineSegment(Position startPoint,
Position endPoint)
Takes two positions and creates the appropriate line segment joining them.
|
LineString |
GeometryFactory.createLineString(List<Position> points)
Takes two or more positions and creates the appropriate line string joining them.
|
Polygon |
GeometryFactory.createPolygon(SurfaceBoundary boundary)
Creates a polygon directly from a set of boundary curves (organized into a surface boundary)
which shall be defined using coplanar positions as control points.
|
Polygon |
GeometryFactory.createPolygon(SurfaceBoundary boundary,
Surface spanSurface)
Creates a polygon lying on a spanning surface.
|
PolyhedralSurface |
GeometryFactory.createPolyhedralSurface(List<Polygon> tiles)
Constructs polyhedral surface from the facet polygons.
|
Tin |
GeometryFactory.createTin(Set<Position> post,
Set<LineString> stopLines,
Set<LineString> breakLines,
double maxLength)
Constructs a restricted Delaunay network from triangle corners (posts), breaklines,
stoplines, and maximum length of a triangle side.
|
DirectPosition |
GenericCurve.forConstructiveParam(double cp)
Returns the direct position for a constructive parameter.
|
DirectPosition |
GenericCurve.forParam(double s)
Returns the direct position for a parameter.
|
double |
GenericSurface.getArea()
Returns the area of this
GenericSurface . |
List<CurveSegment> |
OffsetCurve.getBaseCurves()
Returns the base curves.
|
SurfaceBoundary |
Polygon.getBoundary()
The surface boundary that is the boundary of this polygon.
|
Set<LineString> |
Tin.getBreakLines()
Breaklines are lines of a critical nature to the shape of the surface, representing local
ridges, or depressions (such as drainage lines) in the surface.
|
double[] |
ArcStringByBulge.getBulges()
Returns the offset of each arc's midpoint.
|
DirectPosition |
Arc.getCenter()
Calculates the center of the circle of which this arc is a portion as a direct position.
|
int |
GriddedSurface.getColumns()
Returns the number of columns in the parameter grid.
|
PointArray |
SplineCurve.getControlPoints()
An array of points that are used in the interpolation in this spline curve.
|
PointArray |
LineString.getControlPoints()
Returns a sequence of positions between which the curve is linearly interpolated.
|
PointGrid |
GriddedSurface.getControlPoints()
Returns the doubly indexed sequence of control points, given in row major form.
|
List<Position> |
Tin.getControlPoints()
The corners of the triangles in the TIN are often referred to as posts.
|
PointArray |
GeodesicString.getControlPoints()
Returns a sequence of positions between which this
GeodesicString is interpolated
using geodesics from the geoid or ellipsoid of the coordinate reference system being used. |
PointArray |
ArcString.getControlPoints()
Returns the sequence of points used to control the arcs in this string.
|
List<Position> |
Triangle.getCorners()
Returns the triangle corner.
|
SplineCurveForm |
BSplineCurve.getCurveForm()
Identifies particular types of curve which this spline is being used to approximate.
|
int |
SplineCurve.getDegree()
The degree of the polynomial used for interpolation in a polynomial spline.
|
int |
BSplineCurve.getDegree()
The algebraic degree of the basis functions.
|
int[] |
BSplineSurface.getDegrees()
The algebraic degree of the basis functions for the first and second parameter.
|
DirectPosition |
Position.getDirectPosition()
Returns the direct position.
|
double |
OffsetCurve.getDistance()
Returns the distance at which the offset curve is generated from the basis curve.
|
double |
Conic.getEccentricity()
Returns the value of the eccentricity parameter "e" used in the defining equation
above.
|
Bearing |
Arc.getEndAngle()
Calculates the bearing of the line from the center of the circle of which this arc is a
portion to the end point of the arc.
|
double |
GenericCurve.getEndConstructiveParam()
Indicates the parameter used in the constructive paramerization for the end point.
|
double |
Clothoid.getEndConstructiveParam()
Returns the arc length distance from the inflection point that will be the end point for this curve segment.
|
double |
Conic.getEndConstructiveParam()
Return the end point parameter used in the constructive paramerization.
|
double |
GenericCurve.getEndParam()
Indicates the parameter for the end point.
|
DirectPosition |
GenericCurve.getEndPoint()
Returns the direct position of the last point on the
GenericCurve . |
CurveInterpolation |
ParametricCurveSurface.getHorizontalCurveType()
Indicates the type of surface curves used to traverse the surface horizontally with respect
to the parameter s.
|
List<double[]> |
BicubicGrid.getHorizontalVectorAtEnd()
Returns the initial tangent vectors.
|
List<double[]> |
BicubicGrid.getHorizontalVectorAtStart()
Returns the initial tangent vectors.
|
int |
Placement.getInDimension()
Return the dimension of the input parameter space.
|
CurveInterpolation |
ArcStringByBulge.getInterpolation()
The interpolation for a
ArcStringByBulge is "Circular arc by 2 points and bulge
factor". |
CurveInterpolation |
CubicSpline.getInterpolation()
The interpolation mechanism for a
CubicSpline is CUBIC_SPLINE . |
CurveInterpolation |
PolynomialSpline.getInterpolation()
The interpolation mechanism for a
PolynomialSpline is POLYNOMIAL_SPLINE . |
CurveInterpolation |
GeodesicString.getInterpolation()
The interpolation for a
GeodesicString is "geodesic". |
CurveInterpolation |
ArcString.getInterpolation()
The interpolation for a
ArcString is "circular arc by 3 points". |
List<Knot> |
SplineCurve.getKnots()
The sequence of distinct knots used to define the spline basis functions.
|
List<Knot>[] |
BSplineSurface.getKnots()
Returns two sequences of distinct knots used to define the B-spline basis functions for the
two parameters.
|
KnotType |
BSplineCurve.getKnotSpec()
Gives the type of knot distribution used in defining this spline.
|
KnotType |
BSplineSurface.getKnotSpec()
Gives the type of knot distribution used in defining this spline.
|
Position |
AffinePlacement.getLocation()
Gives the target of the parameter space origin.
|
double |
Tin.getMaxLength()
Maximal length for retention.
|
int |
Knot.getMultiplicity()
The multiplicity of this knot used in the definition of the spline (with the same weight).
|
List<double[]> |
ArcStringByBulge.getNormals()
Returns a vector normal (perpendicular) to the chord of the arc, the line joining the first
and last point of the arc.
|
int |
ArcStringByBulge.getNumArc()
Returns the number of circular arcs in the string.
|
int |
ArcString.getNumArc()
Returns the number of circular arcs in the string.
|
int |
Placement.getOutDimension()
Return the dimension of the output coordinate reference system.
|
ParamForPoint |
GenericCurve.getParamForPoint(DirectPosition p)
Returns the parameter for this
GenericCurve at the passed direct position. |
List<Triangle> |
TriangulatedSurface.getPatches()
Associates this surface with its individual triangles.
|
List<? extends Polygon> |
PolyhedralSurface.getPatches()
Associates this surface with its individual facet polygons.
|
double |
GenericSurface.getPerimeter()
Returns the sum of the lengths of all the boundary components of this
GenericSurface . |
AffinePlacement |
Conic.getPosition()
Returns an affine transformation object that maps the conic from parameter space into the
coordinate space of the target coordinate reference system of the conic corresponding to the
coordinate reference system of the Geometry.
|
double |
Arc.getRadius()
Calculates the radius of the circle of which this arc is a portion.
|
double[] |
OffsetCurve.getReferenceDirection()
Defines the vector direction of the offset curve from the basis curve.
|
double[] |
AffinePlacement.getReferenceDirection(int dimension)
Gives the target directions for the coordinate basis vectors of the parameter space.
|
AffinePlacement |
Clothoid.getReferenceLocation()
Returns an affine mapping that places the curve defined by the Fresnel Integrals into the
coordinate reference system of this object.
|
int |
GriddedSurface.getRows()
Returns the number of rows in the parameter grid.
|
double |
Clothoid.getScaleFactor()
Gives the value for A in the equations above.
|
double |
Conic.getSemiLatusRectum()
Returns the value of the parameter "P" used in the defining equation above.
|
List<Surface> |
Polygon.getSpanningSurface()
Provides a mechanism for spanning the interior of the polygon.
|
Bearing |
Arc.getStartAngle()
Calculates the bearing of the line from the center of the circle of which this arc is a
portion to the start point of the arc.
|
double |
GenericCurve.getStartConstructiveParam()
Indicates the parameter used in the constructive paramerization for the start point.
|
double |
Clothoid.getStartConstructiveParam()
Returns the arc length distance from the inflection point that will be the start point for this curve segment.
|
double |
Conic.getStartConstructiveParam()
Return the start point parameter used in the constructive paramerization.
|
double |
GenericCurve.getStartParam()
Indicates the parameter for the start point.
|
DirectPosition |
GenericCurve.getStartPoint()
Returns the direct position of the first point on the
GenericCurve . |
Set<LineString> |
Tin.getStopLines()
Stoplines are lines where the local continuity or regularity of the surface is questionable.
|
PolyhedralSurface |
Polygon.getSurface()
Returns the patch which own this surface patch.
|
TriangulatedSurface |
Triangle.getSurface()
Returns the patch which own this surface patch.
|
BSplineSurfaceForm |
BSplineSurface.getSurfaceForm()
Identifies particular types of surface which this spline is being used to approximate.
|
double[] |
GenericCurve.getTangent(double s)
Returns the tangent vector along this
GenericCurve at the passed parameter value. |
double[] |
GenericSurface.getUpNormal(DirectPosition point)
Returns a vector perpendicular to the
GenericSurface at the direct position passed, which must be on this GenericSurface . |
double |
Knot.getValue()
The value of the parameter at the knot of the spline.
|
List |
CubicSpline.getVectorAtEnd()
The values used for the final derivative.
|
List |
PolynomialSpline.getVectorAtEnd()
The values used for the final derivative (up to degree - 2) used for
interpolation in this
PolynomialSpline at the end point of the spline. |
List |
CubicSpline.getVectorAtStart()
The values used for the initial derivative.
|
List |
PolynomialSpline.getVectorAtStart()
The values used for the initial derivative (up to degree - 2) used
for interpolation in this
PolynomialSpline at the start point of the spline. |
CurveInterpolation |
ParametricCurveSurface.getVerticalCurveType()
Indicates the type of surface curves used to traverse the surface vertically with respect to
the parameter t.
|
List<double[]> |
BicubicGrid.getVerticalVectorAtEnd()
Returns the initial tangent vectors.
|
List<double[]> |
BicubicGrid.getVerticalVectorAtStart()
Returns the initial tangent vectors.
|
double |
Knot.getWeight()
The value of the averaging weight used for this knot of the spline.
|
Curve |
ParametricCurveSurface.horizontalCurve(double t)
Constructs a curve that traverses the surface horizontally with respect to the parameter
s.
|
boolean |
BSplineCurve.isPolynomial()
true if this is a polynomial spline. |
boolean |
BSplineSurface.isPolynomial()
Returns
true if this is a polynomial spline. |
boolean |
Conic.isShifted()
Returns
false if the affine transformation is used on the unshifted (u,
v) and true if the affine transformation is applied to the shifted
parameters (u', v'). |
double |
GenericCurve.length(double cparam1,
double cparam2)
Returns the length between two constructive parameters.
|
double |
GenericCurve.length(Position point1,
Position point2)
Returns the length between two points.
|
List<PointArray> |
PointGrid.rows()
Returns a view of all rows in this array.
|
DirectPosition |
ParametricCurveSurface.surface(double s,
double t)
Traverses the surface both vertically and horizontally.
|
double[] |
Placement.transform(double[] in)
Maps the parameter coordinate points to the coordinate points in the output Cartesian space.
|
Curve |
ParametricCurveSurface.verticalCurve(double s)
Constructs a curve that traverses the surface vertically with respect to the parameter
t.
|
Modifier and Type | Interface and Description |
---|---|
interface |
Bearing
Represents direction in the coordinate reference system.
|
interface |
Curve
Curve with a positive orientation.
|
interface |
CurveBoundary
The boundary of curves.
|
class |
CurveInterpolation
List of codes that may be used to identify the interpolation mechanisms.
|
interface |
CurveSegment
Defines a homogeneous segment of a curve.
|
interface |
OrientableCurve
A curve and an orientation inherited from
OrientablePrimitive . |
interface |
OrientablePrimitive
Primitives that can be mirrored into new geometric objects in terms of their internal local
coordinate systems (manifold charts).
|
interface |
OrientableSurface
A surface and an orientation inherited from
OrientablePrimitive . |
interface |
Point
Basic data type for a geometric object consisting of one and only one point.
|
interface |
Primitive
Abstract root class of the geometric primitives.
|
interface |
PrimitiveBoundary
The boundary of primitive objects.
|
interface |
Ring
Represent a single connected component of a surface boundary.
|
interface |
Shell
Represents a single connected component of a solid boundary.
|
interface |
Solid
Basis for 3-dimensional geometry.
|
interface |
SolidBoundary
The boundary of solids.
|
interface |
Surface
Surface with a positive orientation.
|
interface |
SurfaceBoundary
The boundary of surfaces.
|
class |
SurfaceInterpolation
List of codes that may be used to identify the interpolation mechanisms.
|
interface |
SurfacePatch
Defines a homogeneous portion of a surface.
|
Modifier and Type | Field and Description |
---|---|
static CurveInterpolation |
CurveInterpolation.CIRCULAR_ARC_2_POINTS_WITH_BULGE
For each consecutive pair of control points, the interpolation mechanism shall return
direct positions on a circular arc passing from the first control
point to the second control point, such that the associated control parameter determines the
offset of the center of the arc from the center point of the chord, positive for leftward and
negative for rightward.
|
static CurveInterpolation |
CurveInterpolation.CIRCULAR_ARC_3_POINTS
For each set of three consecutive control points, the middle one being an even offset from
the beginning of the sequence of control points, the interpolation mechanism shall return
direct positions on a circular arc passing from the first point
through the middle point to the third point.
|
static CurveInterpolation |
CurveInterpolation.CLOTHOID
Uses a Cornu's spiral or clothoid interpolation.
|
static SurfaceInterpolation |
SurfaceInterpolation.CONIC
The surface is a section of a conic surface.
|
static CurveInterpolation |
CurveInterpolation.CONIC
Same as elliptical arc but using 5 consecutive control points to
determine a conic section.
|
static CurveInterpolation |
CurveInterpolation.CUBIC_SPLINE
The control points are interpolated using initial tangents and cubic polynomials, a form of
degree 3 polynomial spline.
|
static SurfaceInterpolation |
SurfaceInterpolation.ELLIPTICAL
The surface is a section of a elliptical surface.
|
static CurveInterpolation |
CurveInterpolation.ELLIPTICAL
For each set of four consecutive control points, the interpolation mechanism shall return
direct positions on an elliptical arc passing from the first
control point through the middle control points in order to the fourth control point.
|
static CurveInterpolation |
CurveInterpolation.GEODESIC
The interpolation mechanism shall return direct positions on a
geodesic curve between each consecutive pair of control points.
|
static CurveInterpolation |
CurveInterpolation.LINEAR
The interpolation mechanism shall return direct positions on a
straight line between each consecutive pair of control points.
|
static SurfaceInterpolation |
SurfaceInterpolation.NONE
The interior of the surface is not specified.
|
static SurfaceInterpolation |
SurfaceInterpolation.PARAMETRIC_CURVE
The control points are organized into a 2-dimensional grid and each cell within the grid is
spanned by a surface which shall be defined by a family of curves.
|
static SurfaceInterpolation |
SurfaceInterpolation.PLANAR
The interpolation method shall return points on a single plane.
|
static SurfaceInterpolation |
SurfaceInterpolation.POLYNOMIAL_SPLINE
The control points are organized into an irregular 2-dimensional grid and each cell within
this grid is spanned by a polynomial spline function.
|
static CurveInterpolation |
CurveInterpolation.POLYNOMIAL_SPLINE
The control points are ordered as in a line-string, but they are spanned by a polynomial
spline function.
|
static SurfaceInterpolation |
SurfaceInterpolation.RATIONAL_SPLINE
The control points are organized into an irregular 2-dimensional grid and each cell within
this grid is spanned by a rational (quotient of polynomials) spline function.
|
static CurveInterpolation |
CurveInterpolation.RATIONAL_SPLINE
The control points are ordered as in a line string, but they are spanned by a rational
(quotient of polynomials) spline function.
|
static SurfaceInterpolation |
SurfaceInterpolation.SPHERICAL
The surface is a section of a spherical surface.
|
static SurfaceInterpolation |
SurfaceInterpolation.TIN
The control points are organized into adjoining triangles, which form small planar segments.
|
static SurfaceInterpolation |
SurfaceInterpolation.TRIANGULATED_SPLINE
The control points are organized into adjoining triangles, each of which is spanned by a
polynomial spline function.
|
Modifier and Type | Method and Description |
---|---|
Curve |
PrimitiveFactory.createCurve(List<CurveSegment> segments)
Takes a list of curve segments with the appropriate end-to-start
relationships and creates a curve.
|
Point |
PrimitiveFactory.createPoint(Position position)
Creates a point at the specified position.
|
Primitive |
PrimitiveFactory.createPrimitive(Envelope envelope)
Returns an envelope as a primitive.
|
Solid |
PrimitiveFactory.createSolid(SolidBoundary boundary)
Constructs a solid by indicating its boundary as a collection of
shells organized into a solid boundary.
|
Surface |
PrimitiveFactory.createSurface(List<SurfacePatch> surfaces)
Takes a list of surface patches with the appropriate side-toside
relationships and creates a surface.
|
Surface |
PrimitiveFactory.createSurface(SurfaceBoundary boundary)
Constructs a surface by indicating its boundary as a collection of
curves organized into the specified surface
boundary.
|
double[] |
Bearing.getAngles()
Returns the azimuth and (optionnaly) the altitude.
|
double |
Solid.getArea()
Returns the sum of the surface areas of all of the boundary components of a solid.
|
Bearing |
Point.getBearing(Position toPoint)
Returns the bearing, as a unit vector, of the tangent (at this
Point ) to the curve
between this Point and a passed position. |
SurfaceBoundary |
OrientableSurface.getBoundary()
Returns the set of circular sequences of orientable curve that
limit the extent of this
OrientableSurface . |
SolidBoundary |
Solid.getBoundary()
Returns a sequence of sets of surfaces that limit the extent of this
Solid . |
PrimitiveBoundary |
Point.getBoundary()
Returns always
null , since point has no boundary. |
CurveBoundary |
CurveSegment.getBoundary()
Returns an ordered pair of points, which are the start point and end point of the curve.
|
CurveBoundary |
OrientableCurve.getBoundary()
Returns an ordered pair of points, which are the start point and end point of the curve.
|
PrimitiveBoundary |
Primitive.getBoundary()
Returns the boundary of a
Primitive as a set of Primitive s. |
SurfaceBoundary |
SurfacePatch.getBoundary()
Returns the boundary of this
SurfacePatch represented as a collection of orientable curves organized into rings by a surface boundary. |
Set<Complex> |
Primitive.getComplexes()
Returns the set of complexes which contains this primitive.
|
CompositeSurface |
OrientableSurface.getComposite()
Returns the owner of this orientable surface.
|
CompositeCurve |
OrientableCurve.getComposite()
Returns the owner of this orientable curve.
|
Composite |
Primitive.getComposite()
Returns the owner of this primitive.
|
Set<Primitive> |
Primitive.getContainedPrimitives()
Returns the
Primitive s which are by definition coincident with this one. |
Set<Primitive> |
Primitive.getContainingPrimitives()
Returns the
Primitive s which are by definition coincident with this one. |
Curve |
CurveSegment.getCurve()
Returns the curve which own this curve segment.
|
double[] |
Bearing.getDirection()
Returns the direction as a vector.
|
DirectPosition |
Point.getDirectPosition()
Returns the direct position of this point.
|
Point |
CurveBoundary.getEndPoint()
Returns the end point.
|
Ring |
SurfaceBoundary.getExterior()
Returns the exterior ring, or
null if none. |
Shell |
SolidBoundary.getExterior()
Returns the exterior shell, or
null if none. |
List<Ring> |
SurfaceBoundary.getInteriors()
Returns the interior rings.
|
Shell[] |
SolidBoundary.getInteriors()
Returns the interior shells.
|
CurveInterpolation |
CurveSegment.getInterpolation()
Specifies the curve interpolation mechanism used for this segment.
|
SurfaceInterpolation |
SurfacePatch.getInterpolation()
Determines the surface interpolation mechanism used for this
SurfacePatch . |
int |
CurveSegment.getNumDerivativesAtEnd()
Specifies the type of continuity between this curve segment and its immediate neighbors.
|
int |
CurveSegment.getNumDerivativesAtStart()
Specifies the type of continuity between this curve segment and its immediate neighbors.
|
int |
CurveSegment.getNumDerivativesInterior()
Specifies the type of continuity that is guaranteed interior to the curve.
|
int |
SurfacePatch.getNumDerivativesOnBoundary()
Specifies the type of continuity between this surface patch and its immediate neighbors with
which it shares a boundary curve.
|
int |
OrientablePrimitive.getOrientation()
Determines which of the two possible orientations this object represents.
|
List<? extends SurfacePatch> |
Surface.getPatches()
Relates this
Surface to a set of surface patches that shall
be joined together to form this surface. |
Surface |
OrientableSurface.getPrimitive()
Returns the primitive associated with this
OrientableSurface . |
Primitive |
OrientablePrimitive.getPrimitive()
Returns the primitive associated with this
OrientablePrimitive . |
Curve |
OrientableCurve.getPrimitive()
Returns the primitive associated with this
OrientableCurve . |
OrientableCurve[] |
Curve.getProxy()
Returns the orientable curves associated with this curve.
|
OrientablePrimitive[] |
Solid.getProxy()
Returns always
null , since solids have no proxy. |
OrientablePrimitive[] |
Point.getProxy()
Returns always
null , since points have no proxy. |
OrientableSurface[] |
Surface.getProxy()
Returns the orientable surfaces associated with this surface.
|
OrientablePrimitive[] |
Primitive.getProxy()
Returns the orientable primitives associated with this primitive.
|
PointArray |
CurveSegment.getSamplePoints()
Returns an ordered array of point values that lie on the curve
segment.
|
List<? extends CurveSegment> |
Curve.getSegments()
Lists the components curve segments of
Curve , each of which
defines the direct position of points along a portion of the curve. |
Point |
CurveBoundary.getStartPoint()
Returns the start point.
|
Surface |
SurfacePatch.getSurface()
Returns the patch which own this surface patch.
|
double |
Solid.getVolume()
Returns the volume of this solid.
|
boolean |
Shell.isSimple()
Always returns
true since shell objects are simples. |
boolean |
Ring.isSimple()
Always returns
true since ring objects are simples. |
CurveSegment |
CurveSegment.reverse()
Reverses the orientation of the parameterizations of the segment.
|
void |
Point.setDirectPosition(DirectPosition position)
Sets the direct position of this point.
|
Modifier and Type | Interface and Description |
---|---|
interface |
ApplicationSchemaInformation
Information about the application schema used to build the dataset.
|
class |
Datatype
Datatype of element or entity.
|
interface |
ExtendedElementInformation
New metadata element, not found in ISO 19115, which is required to describe geographic data.
|
interface |
FeatureTypeList
List of names of feature types with the same spatial representation (same as spatial attributes).
|
interface |
Identifier
Value uniquely identifying an object within a namespace.
|
interface |
MetaData
Root entity which defines metadata about a resource or resources.
|
interface |
MetadataExtensionInformation
Information describing metadata extensions.
|
class |
Obligation
Obligation of the element or entity.
|
interface |
PortrayalCatalogueReference
Information identifying the portrayal catalogue used.
|
interface |
SpatialAttributeSupplement
Spatial attributes in the application schema for the feature types.
|
Modifier and Type | Field and Description |
---|---|
static Datatype |
Datatype.ABSTRACT_CLASS
Class that cannot be directly instantiated.
|
static Datatype |
Datatype.AGGREGATE_CLASS
Class that is composed of classes it is connected to by an aggregate relationship.
|
static Datatype |
Datatype.ASSOCIATION
Semantic relationship between two classes that involves connections among their instances.
|
static Datatype |
Datatype.CHARACTER_STRING
Free text field.
|
static Datatype |
Datatype.CLASS
Descriptor of a set of objects that share the same attributes, operations, methods,
relationships, and behavior.
|
static Datatype |
Datatype.CODE_LIST
Flexible enumeration useful for expressing a long list of values, can be extended.
|
static Datatype |
Datatype.CODE_LIST_ELEMENT
Permissible value for a codelist or enumeration.
|
static Obligation |
Obligation.CONDITIONAL
Element is required when a specific condition is met.
|
static Datatype |
Datatype.DATATYPE_CLASS
Class with few or no operations whose primary purpose is to hold the abstract state of
another class for transmittal, storage, encoding or persistent storage.
|
static Datatype |
Datatype.ENUMERATION
Data type whose instances form a list of named literal values, not extendable.
|
static Datatype |
Datatype.INTEGER
Numerical field.
|
static Datatype |
Datatype.INTERFACE_CLASS
Named set of operations that characterize the behavior of an element.
|
static Obligation |
Obligation.MANDATORY
Element is always required.
|
static Datatype |
Datatype.META_CLASS
Class whose instances are classes.
|
static Obligation |
Obligation.OPTIONAL
Element is not required.
|
static Datatype |
Datatype.SPECIFIED_CLASS
Subclass that may be substituted for its superclass.
|
static Datatype |
Datatype.TYPE_CLASS
Class used for specification of a domain of instances (objects), together with the operations
applicable to the objects.
|
static Datatype |
Datatype.UNION_CLASS
Class describing a selection of one of the specified types.
|
Modifier and Type | Method and Description |
---|---|
Collection<? extends ApplicationSchemaInformation> |
MetaData.getApplicationSchemaInfo()
Provides information about the conceptual schema of a dataset.
|
Citation |
Identifier.getAuthority()
Organization or party responsible for definition and maintenance of the code.
|
CharacterSet |
MetaData.getCharacterSet()
Full name of the character coding standard used for the metadata set.
|
String |
Identifier.getCode()
Alphanumeric value identifying an instance in the namespace.
|
InternationalString |
ExtendedElementInformation.getCondition()
Condition under which the extended element is mandatory.
|
String |
ApplicationSchemaInformation.getConstraintLanguage()
Formal language used in Application Schema.
|
Collection<? extends ResponsibleParty> |
MetaData.getContacts()
Parties responsible for the metadata information.
|
Collection<? extends ContentInformation> |
MetaData.getContentInfo()
Provides information about the feature catalogue and describes the coverage and image data
characteristics.
|
Collection<? extends DataQuality> |
MetaData.getDataQualityInfo()
Provides overall assessment of quality of a resource(s).
|
String |
MetaData.getDataSetUri()
Uniformed Resource Identifier (URI) of the dataset to which the metadata applies.
|
Datatype |
ExtendedElementInformation.getDataType()
Code which identifies the kind of value provided in the extended element.
|
Date |
MetaData.getDateStamp()
Date that the metadata was created.
|
InternationalString |
ExtendedElementInformation.getDefinition()
Definition of the extended element.
|
Distribution |
MetaData.getDistributionInfo()
Provides information about the distributor of and options for obtaining the resource(s).
|
Integer |
ExtendedElementInformation.getDomainCode()
Three digit code assigned to the extended element.
|
InternationalString |
ExtendedElementInformation.getDomainValue()
Valid values that can be assigned to the extended element.
|
Collection<? extends ExtendedElementInformation> |
MetadataExtensionInformation.getExtendedElementInformation()
Provides information about a new metadata element, not found in ISO 19115, which is required
to describe geographic data.
|
OnLineResource |
MetadataExtensionInformation.getExtensionOnLineResource()
Information about on-line sources containing the community profile name and the extended
metadata elements.
|
Collection<FeatureTypeList> |
SpatialAttributeSupplement.getFeatureTypeList()
Provides information about the list of feature types with the same spatial representation.
|
String |
MetaData.getFileIdentifier()
Unique identifier for this metadata file, or
null if none. |
URI |
ApplicationSchemaInformation.getGraphicsFile()
Full application schema given as a graphics file.
|
Collection<String> |
MetaData.getHierarchyLevelNames()
Name of the hierarchy levels for which the metadata is provided.
|
Collection<ScopeCode> |
MetaData.getHierarchyLevels()
Scope to which the metadata applies.
|
Collection<? extends Identification> |
MetaData.getIdentificationInfo()
Basic information about the resource(s) to which the metadata applies.
|
Locale |
MetaData.getLanguage()
Language used for documenting metadata.
|
Collection<Locale> |
MetaData.getLocales()
Provides information about an alternatively used localized character string for a linguistic
extension.
|
Integer |
ExtendedElementInformation.getMaximumOccurrence()
Maximum occurrence of the extended element.
|
Collection<? extends Constraints> |
MetaData.getMetadataConstraints()
Provides restrictions on the access and use of data.
|
Collection<? extends MetadataExtensionInformation> |
MetaData.getMetadataExtensionInfo()
Information describing metadata extensions.
|
MaintenanceInformation |
MetaData.getMetadataMaintenance()
Provides information about the frequency of metadata updates, and the scope of those updates.
|
String |
MetaData.getMetadataStandardName()
Name of the metadata standard (including profile name) used.
|
String |
MetaData.getMetadataStandardVersion()
Version (profile) of the metadata standard used.
|
Citation |
ApplicationSchemaInformation.getName()
Name of the application schema used.
|
String |
ExtendedElementInformation.getName()
Name of the extended metadata element.
|
Obligation |
ExtendedElementInformation.getObligation()
Obligation of the extended element.
|
Collection<String> |
ExtendedElementInformation.getParentEntity()
Name of the metadata entity(s) under which this extended metadata element may appear.
|
String |
MetaData.getParentIdentifier()
File identifier of the metadata to which this metadata is a subset (child).
|
Collection<? extends Citation> |
PortrayalCatalogueReference.getPortrayalCatalogueCitations()
Bibliographic reference to the portrayal catalogue cited.
|
Collection<? extends PortrayalCatalogueReference> |
MetaData.getPortrayalCatalogueInfo()
Provides information about the catalogue of rules defined for the portrayal of a resource(s).
|
Collection<? extends InternationalString> |
ExtendedElementInformation.getRationales()
Reason for creating the extended element.
|
Collection<? extends ReferenceSystem> |
MetaData.getReferenceSystemInfo()
Description of the spatial and temporal reference systems used in the dataset.
|
InternationalString |
ExtendedElementInformation.getRule()
Specifies how the extended element relates to other existing elements and entities.
|
URI |
ApplicationSchemaInformation.getSchemaAscii()
Full application schema given as an ASCII file.
|
String |
ApplicationSchemaInformation.getSchemaLanguage()
Identification of the schema language used.
|
String |
ExtendedElementInformation.getShortName()
Short form suitable for use in an implementation method such as XML or SGML.
|
URI |
ApplicationSchemaInformation.getSoftwareDevelopmentFile()
Full application schema given as a software development file.
|
String |
ApplicationSchemaInformation.getSoftwareDevelopmentFileFormat()
Software dependent format used for the application schema software dependent file.
|
Collection<? extends ResponsibleParty> |
ExtendedElementInformation.getSources()
Name of the person or organization creating the extended element.
|
String |
FeatureTypeList.getSpatialObject()
Instance of a type defined in the spatial schema.
|
Collection<? extends SpatialRepresentation> |
MetaData.getSpatialRepresentationInfo()
Digital representation of spatial information in the dataset.
|
String |
FeatureTypeList.getSpatialSchemaName()
Name of the spatial schema used.
|
Modifier and Type | Interface and Description |
---|---|
interface |
Address
Location of the responsible individual or organization.
|
interface |
Citation
Standardized resource reference.
|
interface |
CitationDate
Reference date and event used to describe it.
|
interface |
Contact
Information required to enable contact with the responsible person and/or organization.
|
class |
DateType
Identification of when a given event occurred
|
class |
OnLineFunction
Class of information to which the referencing entity applies.
|
interface |
OnLineResource
Information about on-line sources from which the dataset, specification, or community profile
name and extended metadata elements can be obtained.
|
class |
PresentationForm
Mode in which the data is represented.
|
interface |
ResponsibleParty
Identification of, and means of communication with, person(s) and organizations associated with
the dataset.
|
class |
Role
Function performed by the responsible party.
|
interface |
Series
Information about the series, or aggregate dataset, to which a dataset belongs.
|
interface |
Telephone
Telephone numbers for contacting the responsible individual or organization.
|
Modifier and Type | Field and Description |
---|---|
static Role |
Role.AUTHOR
Party who authored the resource.
|
static DateType |
DateType.CREATION
Date identifies when the resource was brought into existence.
|
static Role |
Role.CUSTODIAN
Party that accepts accountability and responsibility for the data and ensures appropriate
care and maintenance of the resource.
|
static Role |
Role.DISTRIBUTOR
Party who distributes the resource.
|
static PresentationForm |
PresentationForm.DOCUMENT_DIGITAL
Digital representation of a primarily textual item (can contain illustrations also).
|
static PresentationForm |
PresentationForm.DOCUMENT_HARDCOPY
Representation of a primarily textual item (can contain illustrations also) on paper,
photographic material, or other media.
|
static OnLineFunction |
OnLineFunction.DOWNLOAD
Online instructions for transferring data from one storage device or system to another.
|
static PresentationForm |
PresentationForm.IMAGE_DIGITAL
Likeness of natural or man-made features, objects, and activities acquired through the
sensing of visual or any other segment of the electromagnetic spectrum by sensors, such as
thermal infrared, and high resolution radar and stored in digital format.
|
static PresentationForm |
PresentationForm.IMAGE_HARDCOPY
Likeness of natural or man-made features, objects, and activities acquired through the
sensing of visual or any other segment of the electromagnetic spectrum by sensors, such as
thermal infrared, and high resolution radar and reproduced on paper, photographic material,
or other media for use directly by the human user.
|
static OnLineFunction |
OnLineFunction.INFORMATION
Online information about the resource.
|
static PresentationForm |
PresentationForm.MAP_DIGITAL
Map represented in raster or vector form.
|
static PresentationForm |
PresentationForm.MAP_HARDCOPY
Map printed on paper, photographic material, or other media for use directly by the human
user.
|
static PresentationForm |
PresentationForm.MODEL_DIGITAL
Multi-dimensional digital representation of a feature, process, etc.
|
static PresentationForm |
PresentationForm.MODEL_HARDCOPY
3-dimensional, physical model.
|
static OnLineFunction |
OnLineFunction.OFFLINE_ACCESS
Online instructions for requesting the resource from the provider.
|
static OnLineFunction |
OnLineFunction.ORDER
Online order process for obtaining the resource.
|
static Role |
Role.ORIGINATOR
Party who created the resource.
|
static Role |
Role.OWNER
Party that owns the resource.
|
static Role |
Role.POINT_OF_CONTACT
Party who can be contacted for acquiring knowledge about or acquisition of the resource.
|
static Role |
Role.PRINCIPAL_INVESTIGATOR
Key party responsible for gathering information and conducting research.
|
static Role |
Role.PROCESSOR
Party who has processed the data in a manner such that the resource has been modified.
|
static PresentationForm |
PresentationForm.PROFILE_DIGITAL
Vertical cross-section in digital form.
|
static PresentationForm |
PresentationForm.PROFILE_HARDCOPY
Vertical cross-section printed on paper, etc.
|
static DateType |
DateType.PUBLICATION
Date identifies when the resource was issued.
|
static Role |
Role.PUBLISHER
Party who published the resource.
|
static Role |
Role.RESOURCE_PROVIDER
Party that supplies the resource.
|
static DateType |
DateType.REVISION
Date identifies when the resource was examined or re-examined and improved or amended.
|
static OnLineFunction |
OnLineFunction.SEARCH
Online search interface for seeking out information about the resource.
|
static PresentationForm |
PresentationForm.TABLE_DIGITAL
Digital representation of facts or figures systematically displayed, especially in columns.
|
static PresentationForm |
PresentationForm.TABLE_HARDCOPY
Representation of facts or figures systematically displayed, especially in columns, printed
on paper, photographic material, or other media.
|
static Role |
Role.USER
Party who uses the resource.
|
static PresentationForm |
PresentationForm.VIDEO_DIGITAL
Digital video recording.
|
static PresentationForm |
PresentationForm.VIDEO_HARDCOPY
Video recording on film.
|
Modifier and Type | Method and Description |
---|---|
Address |
Contact.getAddress()
Physical and email address at which the organization or individual may be contacted.
|
InternationalString |
Address.getAdministrativeArea()
State, province of the location.
|
Collection<? extends InternationalString> |
Citation.getAlternateTitles()
Short name or other language name by which the cited information is known.
|
String |
OnLineResource.getApplicationProfile()
Name of an application profile that can be used with the online resource.
|
Collection<? extends ResponsibleParty> |
Citation.getCitedResponsibleParties()
Name and position information for an individual or organization that is responsible for the
resource.
|
InternationalString |
Address.getCity()
The city of the location.
|
InternationalString |
Citation.getCollectiveTitle()
Common title with holdings note.
|
Contact |
ResponsibleParty.getContactInfo()
Address of the responsible party.
|
InternationalString |
Contact.getContactInstructions()
Supplemental instructions on how or when to contact the individual or organization.
|
InternationalString |
Address.getCountry()
Country of the physical address.
|
Date |
CitationDate.getDate()
Reference date for the cited resource.
|
Collection<? extends CitationDate> |
Citation.getDates()
Reference date for the cited resource.
|
DateType |
CitationDate.getDateType()
Event used for reference date.
|
Collection<String> |
Address.getDeliveryPoints()
Address line for the location (as described in ISO 11180, Annex A).
|
InternationalString |
OnLineResource.getDescription()
Detailed text description of what the online resource is/does.
|
InternationalString |
Citation.getEdition()
Version of the cited resource.
|
Date |
Citation.getEditionDate()
Date of the edition, or
null if none. |
Collection<String> |
Address.getElectronicMailAddresses()
Address of the electronic mailbox of the responsible organization or individual.
|
Collection<String> |
Telephone.getFacsimiles()
Telephone numbers of a facsimile machine for the responsible organization or individual.
|
OnLineFunction |
OnLineResource.getFunction()
Code for function performed by the online resource.
|
InternationalString |
Contact.getHoursOfService()
Time period (including time zone) when individuals can contact the organization or
individual.
|
Collection<? extends Identifier> |
Citation.getIdentifiers()
Unique identifier for the resource.
|
String |
ResponsibleParty.getIndividualName()
Name of the responsible person- surname, given name, title separated by a delimiter.
|
String |
Citation.getISBN()
International Standard Book Number, or
null if none. |
String |
Citation.getISSN()
International Standard Serial Number, or
null if none. |
String |
Series.getIssueIdentification()
Information identifying the issue of the series.
|
URI |
OnLineResource.getLinkage()
Location (address) for on-line access using a Uniform Resource Locator address or similar
addressing scheme such as http://www.statkart.no/isotc211.
|
InternationalString |
Series.getName()
Name of the series, or aggregate dataset, of which the dataset is a part.
|
String |
OnLineResource.getName()
Name of the online resource.
|
OnLineResource |
Contact.getOnLineResource()
On-line information that can be used to contact the individual or organization.
|
InternationalString |
ResponsibleParty.getOrganisationName()
Name of the responsible organization.
|
InternationalString |
Citation.getOtherCitationDetails()
Other information required to complete the citation that is not recorded elsewhere.
|
String |
Series.getPage()
Details on which pages of the publication the article was published.
|
Telephone |
Contact.getPhone()
Telephone numbers at which the organization or individual may be contacted.
|
InternationalString |
ResponsibleParty.getPositionName()
Role or position of the responsible person.
|
String |
Address.getPostalCode()
ZIP or other postal code.
|
Collection<PresentationForm> |
Citation.getPresentationForm()
Mode in which the resource is represented, or an empty string if none.
|
String |
OnLineResource.getProtocol()
Connection protocol to be used.
|
Role |
ResponsibleParty.getRole()
Function performed by the responsible party.
|
Series |
Citation.getSeries()
Information about the series, or aggregate dataset, of which the dataset is a part.
|
InternationalString |
Citation.getTitle()
Name by which the cited resource is known.
|
Collection<String> |
Telephone.getVoices()
Telephone numbers by which individuals can speak to the responsible organization or
individual.
|
Modifier and Type | Class and Description |
---|---|
class |
Classification
Name of the handling restrictions on the dataset.
|
interface |
Constraints
Restrictions on the access and use of a resource or metadata.
|
interface |
LegalConstraints
Restrictions and legal prerequisites for accessing and using the resource.
|
class |
Restriction
Limitation(s) placed upon the access or use of the data.
|
interface |
SecurityConstraints
Handling restrictions imposed on the resource for national security or similar security concerns.
|
Modifier and Type | Field and Description |
---|---|
static Classification |
Classification.CONFIDENTIAL
Available for someone who can be entrusted with information.
|
static Restriction |
Restriction.COPYRIGHT
Exclusive right to the publication, production, or sale of the rights to a literary,
dramatic, musical, or artistic work, or to the use of a commercial print or label, granted by
law for a specified period of time to an author, composer, artist, distributor.
|
static Restriction |
Restriction.INTELLECTUAL_PROPERTY_RIGHTS
Rights to financial benefit from and control of distribution of non-tangible property that is
a result of creativity.
|
static Restriction |
Restriction.LICENSE
Formal permission to do something.
|
static Restriction |
Restriction.OTHER_RESTRICTIONS
Limitation not listed.
|
static Restriction |
Restriction.PATENT
Government has granted exclusive right to make, sell, use or license an invention or
discovery.
|
static Restriction |
Restriction.PATENT_PENDING
Produced or sold information awaiting a patent.
|
static Restriction |
Restriction.RESTRICTED
Withheld from general circulation or disclosure.
|
static Classification |
Classification.RESTRICTED
Not for general disclosure.
|
static Classification |
Classification.SECRET
Kept or meant to be kept private, unknown, or hidden from all but a select group of people.
|
static Classification |
Classification.TOP_SECRET
Of the highest secrecy.
|
static Restriction |
Restriction.TRADEMARK
A name, symbol, or other device identifying a product, officially registered and legally
restricted to the use of the owner or manufacturer.
|
static Classification |
Classification.UNCLASSIFIED
Available for general disclosure.
|
Modifier and Type | Method and Description |
---|---|
Collection<Restriction> |
LegalConstraints.getAccessConstraints()
Access constraints applied to assure the protection of privacy or intellectual property, and
any special restrictions or limitations on obtaining the resource.
|
Classification |
SecurityConstraints.getClassification()
Name of the handling restrictions on the resource.
|
InternationalString |
SecurityConstraints.getClassificationSystem()
Name of the classification system.
|
InternationalString |
SecurityConstraints.getHandlingDescription()
Additional information about the restrictions on handling the resource.
|
Collection<? extends InternationalString> |
LegalConstraints.getOtherConstraints()
Other restrictions and legal prerequisites for accessing and using the resource.
|
Collection<Restriction> |
LegalConstraints.getUseConstraints()
Constraints applied to assure the protection of privacy or intellectual property, and any
special restrictions or limitations or warnings on using the resource.
|
Collection<? extends InternationalString> |
Constraints.getUseLimitation()
Limitation affecting the fitness for use of the resource.
|
InternationalString |
SecurityConstraints.getUserNote()
Explanation of the application of the legal constraints or other restrictions and legal
prerequisites for obtaining and using the resource.
|
Modifier and Type | Interface and Description |
---|---|
interface |
Band
Range of wavelengths in the electromagnetic spectrum.
|
interface |
ContentInformation
Description of the content of a dataset.
|
class |
CoverageContentType
Specific type of information represented in the cell.
|
interface |
CoverageDescription
Information about the content of a grid data cell.
|
interface |
FeatureCatalogueDescription
Information identifying the feature catalogue.
|
interface |
ImageDescription
Information about an image's suitability for use.
|
class |
ImagingCondition
Code which indicates conditions which may affect the image.
|
interface |
RangeDimension
Information on the range of each dimension of a cell measurement value.
|
Modifier and Type | Field and Description |
---|---|
static ImagingCondition |
ImagingCondition.BLURRED_IMAGE
Portion of the image is blurred.
|
static ImagingCondition |
ImagingCondition.CLOUD
Portion of the image is partially obscured by cloud cover
|
static ImagingCondition |
ImagingCondition.DEGRADING_OBLIQUITY
Acute angle between the plane of the ecliptic (the plane of the Earth's orbit) and the plane
of the celestial equator.
|
static ImagingCondition |
ImagingCondition.FOG
Portion of the image is partially obscured by fog.
|
static ImagingCondition |
ImagingCondition.HEAVY_SMOKE_OR_DUST
Portion of the image is partially obscured by heavy smoke or dust.
|
static CoverageContentType |
CoverageContentType.IMAGE
Meaningful numerical representation of a physical parameter that is not the actual value of
the physical parameter.
|
static ImagingCondition |
ImagingCondition.NIGHT
Image was taken at night.
|
static CoverageContentType |
CoverageContentType.PHYSICAL_MEASUREMENT
Value in physical units of the quantity being measured.
|
static ImagingCondition |
ImagingCondition.RAIN
Image was taken during rainfall.
|
static ImagingCondition |
ImagingCondition.SEMI_DARKNESS
Image was taken during semi-dark conditions or twilight conditions.
|
static ImagingCondition |
ImagingCondition.SHADOW
Portion of the image is obscured by shadow.
|
static ImagingCondition |
ImagingCondition.SNOW
Portion of the image is obscured by snow.
|
static ImagingCondition |
ImagingCondition.TERRAIN_MASKING
The absence of collection data of a given point or area caused by the relative location of
topographic features which obstruct the collection path between the collector(s) and the
subject(s) of interest.
|
static CoverageContentType |
CoverageContentType.THEMATIC_CLASSIFICATION
Code value with no quantitative meaning, used to represent a physical quantity.
|
Modifier and Type | Method and Description |
---|---|
RecordType |
CoverageDescription.getAttributeDescription()
Description of the attribute described by the measurement value.
|
Integer |
Band.getBitsPerValue()
Maximum number of significant bits in the uncompressed representation for the value in each
band of each pixel.
|
Double |
ImageDescription.getCloudCoverPercentage()
Area of the dataset obscured by clouds, expressed as a percentage of the spatial extent.
|
Integer |
ImageDescription.getCompressionGenerationQuantity()
Count of the number the number of lossy compression cycles performed on the image.
|
CoverageContentType |
CoverageDescription.getContentType()
Type of information represented by the cell value.
|
InternationalString |
RangeDimension.getDescriptor()
Description of the range of a cell measurement value.
|
Collection<? extends RangeDimension> |
CoverageDescription.getDimensions()
Information on the dimensions of the cell measurement value.
|
Collection<? extends Citation> |
FeatureCatalogueDescription.getFeatureCatalogueCitations()
Complete bibliographic reference to one or more external feature catalogues.
|
Collection<? extends GenericName> |
FeatureCatalogueDescription.getFeatureTypes()
Subset of feature types from cited feature catalogue occurring in dataset.
|
Double |
ImageDescription.getIlluminationAzimuthAngle()
Illumination azimuth measured in degrees clockwise from true north at the time the image is
taken.
|
Double |
ImageDescription.getIlluminationElevationAngle()
Illumination elevation measured in degrees clockwise from the target plane at intersection of
the optical line of sight with the Earth's surface.
|
Identifier |
ImageDescription.getImageQualityCode()
Specifies the image quality.
|
ImagingCondition |
ImageDescription.getImagingCondition()
Conditions affected the image.
|
Collection<Locale> |
FeatureCatalogueDescription.getLanguages()
Language(s) used within the catalogue.
|
Double |
Band.getMaxValue()
Longest wavelength that the sensor is capable of collecting within a designated band.
|
Double |
Band.getMinValue()
Shortest wavelength that the sensor is capable of collecting within a designated band.
|
Double |
Band.getOffset()
The physical value corresponding to a cell value of zero.
|
Double |
Band.getPeakResponse()
Wavelength at which the response is the highest.
|
Identifier |
ImageDescription.getProcessingLevelCode()
Image distributor's code that identifies the level of radiometric and geometric processing
that has been applied.
|
Double |
Band.getScaleFactor()
Scale factor which has been applied to the cell value.
|
MemberName |
RangeDimension.getSequenceIdentifier()
Number that uniquely identifies instances of bands of wavelengths on which a sensor operates.
|
Integer |
Band.getToneGradation()
Number of discrete numerical values in the grid data.
|
Boolean |
ImageDescription.getTriangulationIndicator()
Indication of whether or not triangulation has been performed upon the image.
|
Unit<Length> |
Band.getUnits()
Units in which sensor wavelengths are expressed.
|
Boolean |
ImageDescription.isCameraCalibrationInformationAvailable()
Indication of whether or not constants are available which allow for camera calibration
corrections.
|
Boolean |
FeatureCatalogueDescription.isCompliant()
Indication of whether or not the cited feature catalogue complies with ISO 19110.
|
Boolean |
ImageDescription.isFilmDistortionInformationAvailable()
Indication of whether or not Calibration Reseau information is available.
|
boolean |
FeatureCatalogueDescription.isIncludedWithDataset()
Indication of whether or not the feature catalogue is included with the dataset.
|
Boolean |
ImageDescription.isLensDistortionInformationAvailable()
Indication of whether or not lens aberration correction information is available.
|
Boolean |
ImageDescription.isRadiometricCalibrationDataAvailable()
Indication of whether or not the radiometric calibration information for generating the
radiometrically calibrated standard data product is available.
|
Modifier and Type | Interface and Description |
---|---|
interface |
DigitalTransferOptions
Technical means and media by which a resource is obtained from the distributor.
|
interface |
Distribution
Information about the distributor of and options for obtaining the resource.
|
interface |
Distributor
Information about the distributor.
|
interface |
Format
Description of the computer language construct that specifies the representation of data objects
in a record, file, message, storage device or transmission channel.
|
interface |
Medium
Information about the media on which the resource can be distributed.
|
class |
MediumFormat
Method used to write to the medium.
|
class |
MediumName
Name of the medium.
|
interface |
StandardOrderProcess
Common ways in which the resource may be obtained or received, and related instructions and fee
information.
|
Modifier and Type | Field and Description |
---|---|
static MediumName |
MediumName.CARTRIDGE_3480
3480 cartridge tape drive.
|
static MediumName |
MediumName.CARTRIDGE_3490
3490 cartridge tape drive.
|
static MediumName |
MediumName.CARTRIDGE_3580
3580 cartridge tape drive.
|
static MediumName |
MediumName.CARTRIDGE_TAPE_1_QUARTER_INCH
¼ inch magnetic tape.
|
static MediumName |
MediumName.CARTRIDGE_TAPE_4mm
4 millimetre magnetic tape.
|
static MediumName |
MediumName.CARTRIDGE_TAPE_8mm
8 millimetre magnetic tape.
|
static MediumName |
MediumName.CD_ROM
Read-only optical disk.
|
static MediumFormat |
MediumFormat.CPIO
CoPy In / Out (UNIX file format and command).
|
static MediumName |
MediumName.DIGITAL_LINEAR_TAPE
Half inch cartridge streaming tape drive.
|
static MediumName |
MediumName.DVD
Digital versatile disk.
|
static MediumName |
MediumName.DVD_ROM
Digital versatile disk digital versatile disk, read only.
|
static MediumName |
MediumName.FLOPPY_3_HALF_INCH
3½ inch magnetic disk.
|
static MediumName |
MediumName.FLOPPY_5_QUARTER_INCH
5¼ inch magnetic disk.
|
static MediumName |
MediumName.HARD_COPY
Pamphlet or leaflet giving descriptive information.
|
static MediumFormat |
MediumFormat.HIGH_SIERRA
High sierra file system.
|
static MediumFormat |
MediumFormat.ISO_9660
Information processing - volume and file structure of CD-ROM.
|
static MediumFormat |
MediumFormat.ISO_9660_APPLE_HFS
Hierarchical file system (Macintosh).
|
static MediumFormat |
MediumFormat.ISO_9660_ROCK_RIDGE
Rock ridge interchange protocol (UNIX).
|
static MediumName |
MediumName.ON_LINE
Direct computer linkage.
|
static MediumName |
MediumName.SATELLITE
Linkage through a satellite communication system.
|
static MediumName |
MediumName.TAPE_7_TRACK
7 track magnetic tape.
|
static MediumName |
MediumName.TAPE_9_TRACK
9 track magnetic tape.
|
static MediumFormat |
MediumFormat.TAR
Tap ARchive.
|
static MediumName |
MediumName.TELEPHONE_LINK
Communication through a telephone network.
|
Modifier and Type | Method and Description |
---|---|
InternationalString |
Format.getAmendmentNumber()
Amendment number of the format version.
|
Collection<Double> |
Medium.getDensities()
Density at which the data is recorded.
|
Unit<?> |
Medium.getDensityUnits()
Units of measure for the recording density.
|
Collection<? extends Format> |
Distribution.getDistributionFormats()
Provides a description of the format of the data to be distributed.
|
Collection<? extends StandardOrderProcess> |
Distributor.getDistributionOrderProcesses()
Provides information about how the resource may be obtained, and related instructions and fee
information.
|
ResponsibleParty |
Distributor.getDistributorContact()
Party from whom the resource may be obtained.
|
Collection<? extends Format> |
Distributor.getDistributorFormats()
Provides information about the format used by the distributor.
|
Collection<? extends Distributor> |
Distribution.getDistributors()
Provides information about the distributor.
|
Collection<? extends DigitalTransferOptions> |
Distributor.getDistributorTransferOptions()
Provides information about the technical means and media used by the distributor.
|
InternationalString |
StandardOrderProcess.getFees()
Fees and terms for retrieving the resource.
|
InternationalString |
Format.getFileDecompressionTechnique()
Recommendations of algorithms or processes that can be applied to read or expand resources to
which compression techniques have been applied.
|
Collection<? extends Distributor> |
Format.getFormatDistributors()
Provides information about the distributor's format.
|
Collection<MediumFormat> |
Medium.getMediumFormats()
Method used to write to the medium.
|
InternationalString |
Medium.getMediumNote()
Description of other limitations or requirements for using the medium.
|
InternationalString |
Format.getName()
Name of the data transfer format(s).
|
MediumName |
Medium.getName()
Name of the medium on which the resource can be received.
|
Medium |
DigitalTransferOptions.getOffLine()
Information about offline media on which the resource can be obtained.
|
Collection<? extends OnLineResource> |
DigitalTransferOptions.getOnLines()
Information about online sources from which the resource can be obtained.
|
InternationalString |
StandardOrderProcess.getOrderingInstructions()
General instructions, terms and services provided by the distributor.
|
Date |
StandardOrderProcess.getPlannedAvailableDateTime()
Date and time when the dataset will be available.
|
InternationalString |
Format.getSpecification()
Name of a subset, profile, or product specification of the format.
|
Collection<? extends DigitalTransferOptions> |
Distribution.getTransferOptions()
Provides information about technical means and media by which a resource is obtained from the
distributor.
|
Double |
DigitalTransferOptions.getTransferSize()
Estimated size of a unit in the specified transfer format, expressed in megabytes.
|
InternationalString |
StandardOrderProcess.getTurnaround()
Typical turnaround time for the filling of an order.
|
InternationalString |
DigitalTransferOptions.getUnitsOfDistribution()
Tiles, layers, geographic areas, etc.
|
InternationalString |
Format.getVersion()
Version of the format (date, number, etc.
|
Integer |
Medium.getVolumes()
Number of items in the media identified.
|
Modifier and Type | Interface and Description |
---|---|
interface |
BoundingPolygon
Boundary enclosing the dataset, expressed as the closed set of (x,y)
coordinates of the polygon.
|
interface |
Extent
Information about spatial, vertical, and temporal extent.
|
interface |
GeographicBoundingBox
Geographic position of the dataset.
|
interface |
GeographicDescription
Description of the geographic area using identifiers.
|
interface |
GeographicExtent
Base interface for geographic area of the dataset.
|
interface |
SpatialTemporalExtent
Extent with respect to date/time and spatial boundaries.
|
interface |
TemporalExtent
Time period covered by the content of the dataset.
|
interface |
VerticalExtent
Vertical domain of dataset.
|
Modifier and Type | Method and Description |
---|---|
InternationalString |
Extent.getDescription()
Returns the spatial and temporal extent for the referring object.
|
double |
GeographicBoundingBox.getEastBoundLongitude()
Returns the eastern-most coordinate of the limit of the dataset extent.
|
TemporalPrimitive |
TemporalExtent.getExtent()
Returns the date and time for the content of the dataset.
|
Collection<? extends GeographicExtent> |
Extent.getGeographicElements()
Provides geographic component of the extent of the referring object
|
Identifier |
GeographicDescription.getGeographicIdentifier()
Returns the identifier used to represent a geographic area.
|
Boolean |
GeographicExtent.getInclusion()
Indication of whether the bounding polygon encompasses an area covered by the data
(inclusion) or an area where data is not present (exclusion).
|
Double |
VerticalExtent.getMaximumValue()
Returns the highest vertical extent contained in the dataset.
|
Double |
VerticalExtent.getMinimumValue()
Returns the lowest vertical extent contained in the dataset.
|
double |
GeographicBoundingBox.getNorthBoundLatitude()
Returns the northern-most, coordinate of the limit of the dataset extent.
|
Collection<? extends Geometry> |
BoundingPolygon.getPolygons()
Returns the sets of points defining the bounding polygon.
|
double |
GeographicBoundingBox.getSouthBoundLatitude()
Returns the southern-most coordinate of the limit of the dataset extent.
|
Collection<? extends GeographicExtent> |
SpatialTemporalExtent.getSpatialExtent()
Returns the spatial extent component of composite spatial and temporal extent.
|
Collection<? extends TemporalExtent> |
Extent.getTemporalElements()
Provides temporal component of the extent of the referring object
|
VerticalCRS |
VerticalExtent.getVerticalCRS()
Provides information about the vertical coordinate reference system to which the maximum and
minimum elevation values are measured.
|
Collection<? extends VerticalExtent> |
Extent.getVerticalElements()
Provides vertical component of the extent of the referring object
|
double |
GeographicBoundingBox.getWestBoundLongitude()
Returns the western-most coordinate of the limit of the dataset extent.
|
Modifier and Type | Interface and Description |
---|---|
interface |
AggregateInformation
Aggregate dataset information.
|
class |
AssociationType
Justification for the correlation of two datasets.
|
interface |
BrowseGraphic
Graphic that provides an illustration of the dataset (should include a legend for the graphic).
|
class |
CharacterSet
Name of the character coding standard used for the resource.
|
interface |
DataIdentification
Information required to identify a dataset.
|
interface |
Identification
Basic information required to uniquely identify a resource or resources.
|
class |
InitiativeType
Type of aggregation activity in which datasets are related
|
interface |
Keywords
Keywords, their type and reference source.
|
class |
KeywordType
Methods used to group similar keywords.
|
class |
Progress
Status of the dataset or progress of a review.
|
interface |
RepresentativeFraction
A scale defined as the inverse of a denominator.
|
interface |
Resolution
Level of detail expressed as a scale factor or a ground distance.
|
interface |
ServiceIdentification
Identification of capabilities which a service provider makes available to a service user through
a set of interfaces that define a behaviour - See ISO 19119 for further information.
|
class |
TopicCategory
High-level geographic data thematic classification to assist in the grouping and search of
available geographic data sets.
|
interface |
Usage
Brief description of ways in which the resource(s) is/are currently used.
|
Modifier and Type | Field and Description |
---|---|
static CharacterSet |
CharacterSet.BIG_5
Traditional Chinese code set used in Taiwan, Hong Kong, and other areas.
|
static TopicCategory |
TopicCategory.BIOTA
Flora and/or fauna in natural environment.
|
static TopicCategory |
TopicCategory.BOUNDARIES
Legal land descriptions.
|
static InitiativeType |
InitiativeType.CAMPAIGN
Series of organized planned actions.
|
static TopicCategory |
TopicCategory.CLIMATOLOGY_METEOROLOGY_ATMOSPHERE
Processes and phenomena of the atmosphere.
|
static InitiativeType |
InitiativeType.COLLECTION
Accumulation of datasets assembled for a specific purpose.
|
static Progress |
Progress.COMPLETED
Production of the data has been completed.
|
static AssociationType |
AssociationType.CROSS_REFERENCE
Reference from one dataset to another.
|
static KeywordType |
KeywordType.DISCIPLINE
Keyword identifies a branch of instruction or specialized learning.
|
static CharacterSet |
CharacterSet.EBCDIC
IBM mainframe code set.
|
static TopicCategory |
TopicCategory.ECONOMY
Economic activities, conditions and employment.
|
static TopicCategory |
TopicCategory.ELEVATION
Height above or below sea level.
|
static TopicCategory |
TopicCategory.ENVIRONMENT
Environmental resources, protection and conservation.
|
static CharacterSet |
CharacterSet.EUC_JP
Japanese code set used on UNIX based machines.
|
static CharacterSet |
CharacterSet.EUC_KR
Korean code set.
|
static InitiativeType |
InitiativeType.EXERCISE
Specific performance of a function or group of functions.
|
static InitiativeType |
InitiativeType.EXPERIMENT
Process designed to find if something is effective or valid.
|
static TopicCategory |
TopicCategory.FARMING
Rearing of animals and/or cultivation of plants.
|
static CharacterSet |
CharacterSet.GB2312
Simplified Chinese code set.
|
static TopicCategory |
TopicCategory.GEOSCIENTIFIC_INFORMATION
Information pertaining to earth sciences.
|
static TopicCategory |
TopicCategory.HEALTH
Health, health services, human ecology, and safety.
|
static Progress |
Progress.HISTORICAL_ARCHIVE
Data has been stored in an offline storage facility
|
static TopicCategory |
TopicCategory.IMAGERY_BASE_MAPS_EARTH_COVER
Base maps.
|
static TopicCategory |
TopicCategory.INLAND_WATERS
Inland water features, drainage systems and their characteristics.
|
static TopicCategory |
TopicCategory.INTELLIGENCE_MILITARY
Military bases, structures, activities.
|
static InitiativeType |
InitiativeType.INVESTIGATION
Search or systematic inquiry.
|
static CharacterSet |
CharacterSet.ISO_8859_1
ISO/IEC 8859-1, Information technology. 8-bit single-byte coded graphic character sets - Part
1: Latin alphabet No. 1.
|
static CharacterSet |
CharacterSet.ISO_8859_10
ISO/IEC 8859-10, Information technology. 8-bit single-byte coded graphic character sets -
Part 10: Latin alphabet No. 6.
|
static CharacterSet |
CharacterSet.ISO_8859_11
ISO/IEC 8859-11, Information technology. 8-bit single-byte coded graphic character sets -
Part 11: Latin/Thai alphabet.
|
static CharacterSet |
CharacterSet.ISO_8859_12
A future ISO/IEC 8-bit single-byte coded graphic character set.
|
static CharacterSet |
CharacterSet.ISO_8859_13
ISO/IEC 8859-13, Information technology. 8-bit single-byte coded graphic character sets -
Part 13: Latin alphabet No. 7.
|
static CharacterSet |
CharacterSet.ISO_8859_14
ISO/IEC 8859-14, Information technology. 8-bit single-byte coded graphic character sets -
Part 14: Latin alphabet No. 8 (Celtic).
|
static CharacterSet |
CharacterSet.ISO_8859_15
ISO/IEC 8859-15, Information technology. 8-bit single-byte coded graphic character sets -
Part 15: Latin alphabet No. 9.
|
static CharacterSet |
CharacterSet.ISO_8859_16
ISO/IEC 8859-16, Information technology. 8-bit single-byte coded graphic character sets -
Part 16: Latin alphabet No. 10.
|
static CharacterSet |
CharacterSet.ISO_8859_2
ISO/IEC 8859-2, Information technology. 8-bit single-byte coded graphic character sets - Part
2: Latin alphabet No. 2.
|
static CharacterSet |
CharacterSet.ISO_8859_3
ISO/IEC 8859-3, Information technology. 8-bit single-byte coded graphic character sets - Part
3: Latin alphabet No. 3.
|
static CharacterSet |
CharacterSet.ISO_8859_4
ISO/IEC 8859-4, Information technology. 8-bit single-byte coded graphic character sets - Part
4: Latin alphabet No. 4.
|
static CharacterSet |
CharacterSet.ISO_8859_5
ISO/IEC 8859-5, Information technology. 8-bit single-byte coded graphic character sets - Part
5: Latin/Cyrillic alphabet.
|
static CharacterSet |
CharacterSet.ISO_8859_6
ISO/IEC 8859-6, Information technology. 8-bit single-byte coded graphic character sets - Part
6: Latin/Arabic alphabet.
|
static CharacterSet |
CharacterSet.ISO_8859_7
ISO/IEC 8859-7, Information technology. 8-bit single-byte coded graphic character sets - Part
7: Latin/Greek alphabet.
|
static CharacterSet |
CharacterSet.ISO_8859_8
ISO/IEC 8859-8, Information technology. 8-bit single-byte coded graphic character sets - Part
8: Latin/Hebrew alphabet.
|
static CharacterSet |
CharacterSet.ISO_8859_9
ISO/IEC 8859-9, Information technology. 8-bit single-byte coded graphic character sets - Part
9: Latin alphabet No. 5.
|
static CharacterSet |
CharacterSet.JIS
Japanese code set used for electronic transmission.
|
static AssociationType |
AssociationType.LARGER_WORD_CITATION
Reference to a master dataset of which this one is a part.
|
static TopicCategory |
TopicCategory.LOCATION
Positional information and services.
|
static InitiativeType |
InitiativeType.MISSION
Specific operation of a data collection system.
|
static Progress |
Progress.OBSOLETE
Data is no longer relevant.
|
static TopicCategory |
TopicCategory.OCEANS
Features and characteristics of salt water bodies (excluding inland waters).
|
static Progress |
Progress.ON_GOING
Data is continually being updated.
|
static InitiativeType |
InitiativeType.OPERATION
Action that is part of a series of actions.
|
static AssociationType |
AssociationType.PART_OF_SEAMLESS_DATABASE
Part of same structured set of data held in a computer.
|
static KeywordType |
KeywordType.PLACE
Keyword identifies a location.
|
static Progress |
Progress.PLANNED
Fixed date has been established upon or by which the data will be created or updated.
|
static TopicCategory |
TopicCategory.PLANNING_CADASTRE
Information used for appropriate actions for future use of the land.
|
static InitiativeType |
InitiativeType.PLATFORM
Vehicle or other support base that holds a sensor.
|
static InitiativeType |
InitiativeType.PROCESS
Method of doing something involving a number of steps.
|
static InitiativeType |
InitiativeType.PROGRAM
Specific planned activity.
|
static InitiativeType |
InitiativeType.PROJECT
Organized undertaking, research, or development.
|
static Progress |
Progress.REQUIRED
Data needs to be generated or updated.
|
static InitiativeType |
InitiativeType.SENSOR
Device or piece of equipment which detects or records.
|
static CharacterSet |
CharacterSet.SHIFT_JIS
Japanese code set used on MS-DOS based machines.
|
static TopicCategory |
TopicCategory.SOCIETY
Characteristics of society and cultures.
|
static AssociationType |
AssociationType.SOURCE
Mapping and charting information from which the dataset content originates.
|
static AssociationType |
AssociationType.STEREO_MATE
Part of a set of imagery that when used together, provides three-dimensional images.
|
static KeywordType |
KeywordType.STRATUM
Keyword identifies the layer(s) of any deposited substance.
|
static TopicCategory |
TopicCategory.STRUCTURE
Man-made construction.
|
static InitiativeType |
InitiativeType.STUDY
Examination or investigation.
|
static InitiativeType |
InitiativeType.TASK
Piece of work.
|
static KeywordType |
KeywordType.TEMPORAL
Keyword identifies a time period related to the dataset.
|
static KeywordType |
KeywordType.THEME
Keyword identifies a particular subject or topic.
|
static TopicCategory |
TopicCategory.TRANSPORTATION
Means and aids for conveying persons and/or goods.
|
static InitiativeType |
InitiativeType.TRIAL
Process of testing to discover or demonstrate something.
|
static CharacterSet |
CharacterSet.UCS_2
16-bit fixed size Universal Character Set, based on ISO/IEC 10646.
|
static CharacterSet |
CharacterSet.UCS_4
32-bit fixed size Universal Character Set, based on ISO/IEC 10646.
|
static Progress |
Progress.UNDER_DEVELOPMENT
Data is currently in the process of being created.
|
static CharacterSet |
CharacterSet.US_ASCII
United States ASCII code set (ISO 646 US).
|
static CharacterSet |
CharacterSet.UTF_16
16-bit variable size UCS Transfer Format, based on ISO/IEC 10646.
|
static CharacterSet |
CharacterSet.UTF_7
7-bit variable size UCS Transfer Format, based on ISO/IEC 10646.
|
static CharacterSet |
CharacterSet.UTF_8
8-bit variable size UCS Transfer Format, based on ISO/IEC 10646.
|
static TopicCategory |
TopicCategory.UTILITIES_COMMUNICATION
Energy, water and waste systems and communications infrastructure and services.
|
Modifier and Type | Method and Description |
---|---|
InternationalString |
Identification.getAbstract()
Brief narrative summary of the content of the resource(s).
|
Identifier |
AggregateInformation.getAggregateDataSetIdentifier()
Identification information about aggregate dataset.
|
Citation |
AggregateInformation.getAggregateDataSetName()
Citation information about the aggregate dataset.
|
Collection<? extends AggregateInformation> |
Identification.getAggregationInfo()
Provides aggregate dataset information.
|
AssociationType |
AggregateInformation.getAssociationType()
Association type of the aggregate dataset.
|
Collection<CharacterSet> |
DataIdentification.getCharacterSets()
Full name of the character coding standard(s) used for the dataset.
|
Citation |
Identification.getCitation()
Citation data for the resource(s).
|
Collection<String> |
Identification.getCredits()
Recognition of those who contributed to the resource(s).
|
long |
RepresentativeFraction.getDenominator()
The number below the line in a vulgar fraction.
|
Collection<? extends Keywords> |
Identification.getDescriptiveKeywords()
Provides category keywords, their type, and reference source.
|
Double |
Resolution.getDistance()
Ground sample distance.
|
InternationalString |
DataIdentification.getEnvironmentDescription()
Description of the dataset in the producer's processing environment, including items such as
the software, the computer operating system, file name, and the dataset size.
|
RepresentativeFraction |
Resolution.getEquivalentScale()
Level of detail expressed as the scale of a comparable hardcopy map or chart.
|
Collection<? extends Extent> |
DataIdentification.getExtent()
Additional extent information including the bounding polygon, vertical, and temporal extent
of the dataset.
|
InternationalString |
BrowseGraphic.getFileDescription()
Text description of the illustration.
|
URI |
BrowseGraphic.getFileName()
Name of the file that contains a graphic that provides an illustration of the dataset.
|
String |
BrowseGraphic.getFileType()
Format in which the illustration is encoded.
|
Collection<? extends BrowseGraphic> |
Identification.getGraphicOverviews()
Provides a graphic that illustrates the resource(s) (should include a legend for the
graphic).
|
InitiativeType |
AggregateInformation.getInitiativeType()
Type of initiative under which the aggregate dataset was produced.
|
Collection<? extends InternationalString> |
Keywords.getKeywords()
Commonly used word(s) or formalised word(s) or phrase(s) used to describe the subject.
|
Collection<Locale> |
DataIdentification.getLanguage()
Language(s) used within the dataset.
|
Collection<? extends ResponsibleParty> |
Identification.getPointOfContacts()
Identification of, and means of communication with, person(s) and organizations(s) associated
with the resource(s).
|
InternationalString |
Identification.getPurpose()
Summary of the intentions with which the resource(s) was developed.
|
Collection<? extends Constraints> |
Identification.getResourceConstraints()
Provides information about constraints which apply to the resource(s).
|
Collection<? extends Format> |
Identification.getResourceFormat()
Provides a description of the format of the resource(s).
|
Collection<? extends MaintenanceInformation> |
Identification.getResourceMaintenance()
Provides information about the frequency of resource updates, and the scope of those updates.
|
Collection<? extends Usage> |
Identification.getResourceSpecificUsages()
Provides basic information about specific application(s) for which the resource(s) has/have
been or is being used by different users.
|
Collection<SpatialRepresentationType> |
DataIdentification.getSpatialRepresentationTypes()
Method used to spatially represent geographic information.
|
Collection<? extends Resolution> |
DataIdentification.getSpatialResolutions()
Factor which provides a general understanding of the density of spatial data in the dataset.
|
InternationalString |
Usage.getSpecificUsage()
Brief description of the resource and/or resource series usage.
|
Collection<Progress> |
Identification.getStatus()
Status of the resource(s).
|
InternationalString |
DataIdentification.getSupplementalInformation()
Any other descriptive information about the dataset.
|
Citation |
Keywords.getThesaurusName()
Name of the formally registered thesaurus or a similar authoritative source of keywords.
|
Collection<TopicCategory> |
DataIdentification.getTopicCategories()
Main theme(s) of the dataset.
|
KeywordType |
Keywords.getType()
Subject matter used to group similar keywords.
|
Date |
Usage.getUsageDate()
Date and time of the first use or range of uses of the resource and/or resource series.
|
Collection<? extends ResponsibleParty> |
Usage.getUserContactInfo()
Identification of and means of communicating with person(s) and organization(s) using the
resource(s).
|
InternationalString |
Usage.getUserDeterminedLimitations()
Applications, determined by the user for which the resource and/or resource series is not
suitable.
|
Modifier and Type | Interface and Description |
---|---|
interface |
Lineage
Information about the events or source data used in constructing the data specified by the scope
or lack of knowledge about lineage.
|
interface |
ProcessStep
Description of the event, including related parameters or tolerances.
|
interface |
Source
Information about the source data used in creating the data specified by the scope.
|
Modifier and Type | Method and Description |
---|---|
Date |
ProcessStep.getDate()
Date and time or range of date and time on or over which the process step occurred.
|
InternationalString |
Source.getDescription()
Detailed description of the level of the source data.
|
InternationalString |
ProcessStep.getDescription()
Description of the event, including related parameters or tolerances.
|
Collection<? extends ResponsibleParty> |
ProcessStep.getProcessors()
Identification of, and means of communication with, person(s) and organization(s) associated
with the process step.
|
Collection<? extends ProcessStep> |
Lineage.getProcessSteps()
Information about an event in the creation process for the data specified by the scope.
|
InternationalString |
ProcessStep.getRationale()
Requirement or purpose for the process step.
|
RepresentativeFraction |
Source.getScaleDenominator()
Denominator of the representative fraction on a source map.
|
Citation |
Source.getSourceCitation()
Recommended reference to be used for the source data.
|
Collection<? extends Extent> |
Source.getSourceExtents()
Information about the spatial, vertical and temporal extent of the source data.
|
ReferenceSystem |
Source.getSourceReferenceSystem()
Spatial reference system used by the source data.
|
Collection<? extends Source> |
Lineage.getSources()
Information about the source data used in creating the data specified by the scope.
|
Collection<? extends Source> |
ProcessStep.getSources()
Information about the source data used in creating the data specified by the scope.
|
Collection<? extends ProcessStep> |
Source.getSourceSteps()
Information about an event in the creation process for the source data.
|
InternationalString |
Lineage.getStatement()
General explanation of the data producer's knowledge about the lineage of a dataset.
|
Modifier and Type | Class and Description |
---|---|
class |
MaintenanceFrequency
Frequency with which modifications and deletions are made to the data after it is first produced.
|
interface |
MaintenanceInformation
Information about the scope and frequency of updating.
|
class |
ScopeCode
Class of information to which the referencing entity applies.
|
interface |
ScopeDescription
Description of the class of information covered by the information.
|
Modifier and Type | Field and Description |
---|---|
static MaintenanceFrequency |
MaintenanceFrequency.ANNUALLY
Data is updated every year.
|
static MaintenanceFrequency |
MaintenanceFrequency.AS_NEEDED
Data is updated as deemed necessary.
|
static ScopeCode |
ScopeCode.ATTRIBUTE
Information applies to the attribute value.
|
static ScopeCode |
ScopeCode.ATTRIBUTE_TYPE
Information applies to the characteristic of a feature.
|
static MaintenanceFrequency |
MaintenanceFrequency.BIANNUALLY
Data is updated twice each year.
|
static ScopeCode |
ScopeCode.COLLECTION_HARDWARE
Information applies to the collection hardware class.
|
static ScopeCode |
ScopeCode.COLLECTION_SESSION
Information applies to the collection session.
|
static MaintenanceFrequency |
MaintenanceFrequency.CONTINUAL
Data is repeatedly and frequently updated.
|
static MaintenanceFrequency |
MaintenanceFrequency.DAILY
Data is updated each day.
|
static ScopeCode |
ScopeCode.DATASET
Information applies to the dataset.
|
static ScopeCode |
ScopeCode.DIMENSION_GROUP
Information applies to a dimension group.
|
static ScopeCode |
ScopeCode.FEATURE
Information applies to a feature.
|
static ScopeCode |
ScopeCode.FEATURE_TYPE
Information applies to a feature type.
|
static ScopeCode |
ScopeCode.FIELD_SESSION
Information applies to a field session.
|
static MaintenanceFrequency |
MaintenanceFrequency.FORTNIGHTLY
Data is updated every two weeks.
|
static MaintenanceFrequency |
MaintenanceFrequency.IRREGULAR
Data is updated in intervals that are uneven in duration.
|
static ScopeCode |
ScopeCode.MODEL
Information applies to a copy or imitation of an existing or hypothetical object.
|
static MaintenanceFrequency |
MaintenanceFrequency.MONTHLY
Data is updated each month.
|
static ScopeCode |
ScopeCode.NON_GEOGRAPHIC_DATASET
information applies to non-geographic data;
|
static MaintenanceFrequency |
MaintenanceFrequency.NOT_PLANNED
There are no plans to update the data.
|
static ScopeCode |
ScopeCode.PROPERTY_TYPE
Information applies to a property type.
|
static MaintenanceFrequency |
MaintenanceFrequency.QUARTERLY
Data is updated every three months.
|
static ScopeCode |
ScopeCode.SERIES
Information applies to the series.
|
static ScopeCode |
ScopeCode.SERVICE
Information applies to a capability which a service provider entity makes available to a
service user entity through a set of interfaces that define a behaviour, such as a use case.
|
static ScopeCode |
ScopeCode.SOFTWARE
Information applies to a computer program or routine.
|
static ScopeCode |
ScopeCode.TILE
Information applies to a copy or imitation of an existing or hypothetical object.
|
static MaintenanceFrequency |
MaintenanceFrequency.UNKNOW
Frequency of maintenance for the data is not known
|
static MaintenanceFrequency |
MaintenanceFrequency.WEEKLY
Data is updated on a weekly basis.
|
Modifier and Type | Method and Description |
---|---|
Set<? extends AttributeType> |
ScopeDescription.getAttributeInstances()
Attribute instances to which the information applies.
|
Set<? extends AttributeType> |
ScopeDescription.getAttributes()
Attributes to which the information applies.
|
Collection<? extends ResponsibleParty> |
MaintenanceInformation.getContacts()
Identification of, and means of communicating with, person(s) and organization(s) with
responsibility for maintaining the metadata.
|
String |
ScopeDescription.getDataset()
Dataset to which the information applies.
|
Date |
MaintenanceInformation.getDateOfNextUpdate()
Scheduled revision date for resource.
|
Set<? extends FeatureType> |
ScopeDescription.getFeatureInstances()
Feature instances to which the information applies.
|
Set<? extends FeatureType> |
ScopeDescription.getFeatures()
Features to which the information applies.
|
MaintenanceFrequency |
MaintenanceInformation.getMaintenanceAndUpdateFrequency()
Frequency with which changes and additions are made to the resource after the initial
resource is completed.
|
Collection<? extends InternationalString> |
MaintenanceInformation.getMaintenanceNotes()
Information regarding specific requirements for maintaining the resource.
|
String |
ScopeDescription.getOther()
Class of information that does not fall into the other categories to which the information
applies.
|
Collection<? extends ScopeDescription> |
MaintenanceInformation.getUpdateScopeDescriptions()
Additional information about the range or extent of the resource.
|
Collection<ScopeCode> |
MaintenanceInformation.getUpdateScopes()
Scope of data to which maintenance is applied.
|
PeriodDuration |
MaintenanceInformation.getUserDefinedMaintenanceFrequency()
Maintenance period other than those defined.
|
Modifier and Type | Interface and Description |
---|---|
interface |
AbsoluteExternalPositionalAccuracy
Closeness of reported coordinate values to values accepted as or being true.
|
interface |
AccuracyOfATimeMeasurement
Correctness of the temporal references of an item (reporting of error in time measurement).
|
interface |
Completeness
Presence and absence of features, their attributes and their relationships.
|
interface |
CompletenessCommission
Excess data present in the dataset, as described by the scope.
|
interface |
CompletenessOmission
Data absent from the dataset, as described by the scope.
|
interface |
ConceptualConsistency
Adherence to rules of the conceptual schema.
|
interface |
ConformanceResult
Information about the outcome of evaluating the obtained value (or set of values) against a
specified acceptable conformance quality level.
|
interface |
DataQuality
Quality information for the data specified by a data quality scope.
|
interface |
DomainConsistency
Adherence of values to the value domains.
|
interface |
Element
Type of test applied to the data specified by a data quality scope.
|
class |
EvaluationMethodType
Type of method for evaluating an identified data quality measure.
|
interface |
FormatConsistency
Degree to which data is stored in accordance with the physical structure of the dataset, as
described by the scope.
|
interface |
GriddedDataPositionalAccuracy
Closeness of gridded data position values to values accepted as or being true.
|
interface |
LogicalConsistency
Degree of adherence to logical rules of data structure, attribution and relationships (data
structure can be conceptual, logical or physical).
|
interface |
NonQuantitativeAttributeAccuracy
Accuracy of non-quantitative attributes.
|
interface |
PositionalAccuracy
Accuracy of the position of features.
|
interface |
QuantitativeAttributeAccuracy
Accuracy of quantitative attributes.
|
interface |
QuantitativeResult
Information about the value (or set of values) obtained from applying a data quality measure.
|
interface |
RelativeInternalPositionalAccuracy
Closeness of the relative positions of features in the scope to their respective relative
positions accepted as or being true.
|
interface |
Result
Base interface of more specific result classes.
|
interface |
Scope
Description of the data specified by the scope.
|
interface |
TemporalAccuracy
Accuracy of the temporal attributes and temporal relationships of features.
|
interface |
TemporalConsistency
Correctness of ordered events or sequences, if reported.
|
interface |
TemporalValidity
Validity of data specified by the scope with respect to time.
|
interface |
ThematicAccuracy
Accuracy of quantitative attributes and the correctness of non-quantitative attributes and of the
classifications of features and their relationships.
|
interface |
ThematicClassificationCorrectness
Comparison of the classes assigned to features or their attributes to a universe of discourse.
|
interface |
TopologicalConsistency
Correctness of the explicitly encoded topological characteristics of the dataset as described by
the scope.
|
Modifier and Type | Field and Description |
---|---|
static EvaluationMethodType |
EvaluationMethodType.DIRECT_EXTERNAL
Method of evaluating the quality of a dataset based on inspection of items within the
dataset, where reference data external to the dataset being evaluated is required.
|
static EvaluationMethodType |
EvaluationMethodType.DIRECT_INTERNAL
Method of evaluating the quality of a dataset based on inspection of items within the
dataset, where all data required is internal to the dataset being evaluated.
|
static EvaluationMethodType |
EvaluationMethodType.INDIRECT
Method of evaluating the quality of a dataset based on external knowledge.
|
Modifier and Type | Method and Description |
---|---|
Collection<? extends Date> |
Element.getDates()
Date or range of dates on which a data quality measure was applied.
|
InternationalString |
QuantitativeResult.getErrorStatistic()
Statistical method used to determine the value, or
null if none. |
InternationalString |
Element.getEvaluationMethodDescription()
Description of the evaluation method.
|
EvaluationMethodType |
Element.getEvaluationMethodType()
Type of method used to evaluate quality of the dataset, or
null if unspecified. |
Citation |
Element.getEvaluationProcedure()
Reference to the procedure information, or
null if none. |
InternationalString |
ConformanceResult.getExplanation()
Explanation of the meaning of conformance for this result.
|
Extent |
Scope.getExtent()
Information about the spatial, vertical and temporal extent of the data specified by the
scope.
|
ScopeCode |
Scope.getLevel()
Hierarchical level of the data specified by the scope.
|
Collection<? extends ScopeDescription> |
Scope.getLevelDescription()
Detailed description about the level of the data specified by the scope.
|
Lineage |
DataQuality.getLineage()
Non-quantitative quality information about the lineage of the data specified by the scope.
|
InternationalString |
Element.getMeasureDescription()
Description of the measure being determined.
|
Identifier |
Element.getMeasureIdentification()
Code identifying a registered standard procedure, or
null if none. |
Collection<? extends InternationalString> |
Element.getNamesOfMeasure()
Name of the test applied to the data.
|
Collection<? extends Element> |
DataQuality.getReports()
Quantitative quality information for the data specified by the scope.
|
Collection<? extends Result> |
Element.getResults()
Value (or set of values) obtained from applying a data quality measure or the out come of
evaluating the obtained value (or set of values) against a specified acceptable conformance
quality level.
|
Scope |
DataQuality.getScope()
The specific data to which the data quality information applies.
|
Citation |
ConformanceResult.getSpecification()
Citation of product specification or user requirement against which data is being evaluated.
|
Collection<? extends Record> |
QuantitativeResult.getValues()
Quantitative value or values, content determined by the evaluation procedure used.
|
RecordType |
QuantitativeResult.getValueType()
Value type for reporting a data quality result, or
null if none. |
Unit<?> |
QuantitativeResult.getValueUnit()
Value unit for reporting a data quality result, or
null if none. |
boolean |
ConformanceResult.pass()
Indication of the conformance result.
|
Modifier and Type | Class and Description |
---|---|
class |
CellGeometry
Code indicating whether grid data is point or area.
|
interface |
Dimension
Axis properties.
|
class |
DimensionNameType
Name of the dimension.
|
interface |
GeometricObjects
Number of objects, listed by geometric object type, used in the dataset.
|
class |
GeometricObjectType
Name of point and vector spatial objects used to locate zero-, one-, and twodimensional spatial
locations in the dataset.
|
interface |
Georectified
Grid whose cells are regularly spaced in a geographic (i.e., lat / long) or map coordinate system
defined in the Spatial Referencing System (SRS) so that any cell in the grid can be geolocated
given its grid coordinate and the grid origin, cell spacing, and orientation indication of
whether or not geographic.
|
interface |
Georeferenceable
Grid with cells irregularly spaced in any given geographic/map projection coordinate system,
whose individual cells can be geolocated using geolocation information supplied with the data but
cannot be geolocated from the grid properties alone.
|
interface |
GridSpatialRepresentation
Basic information required to uniquely identify a resource or resources.
|
class |
PixelOrientation
Point in a pixel corresponding to the Earth location of the pixel.
|
interface |
SpatialRepresentation
Digital mechanism used to represent spatial information.
|
class |
SpatialRepresentationType
Method used to represent geographic information in the dataset.
|
class |
TopologyLevel
Degree of complexity of the spatial relationships.
|
interface |
VectorSpatialRepresentation
Information about the vector spatial objects in the dataset.
|
Modifier and Type | Field and Description |
---|---|
static TopologyLevel |
TopologyLevel.ABSTRACT
Topological complex without any specified geometric realization.
|
static CellGeometry |
CellGeometry.AREA
Each cell represents an area.
|
static PixelOrientation |
PixelOrientation.CENTER
Point in a pixel corresponding to the Earth location of the pixel.
|
static DimensionNameType |
DimensionNameType.COLUMN
Abscissa (x) axis.
|
static GeometricObjectType |
GeometricObjectType.COMPLEX
Set of geometric primitives such that their boundaries can be represented as a union of other
primitives.
|
static GeometricObjectType |
GeometricObjectType.COMPOSITE
Connected set of curves, solids or surfaces.
|
static DimensionNameType |
DimensionNameType.CROSS_TRACK
Perpendicular to the direction of motion of the scan point.
|
static GeometricObjectType |
GeometricObjectType.CURVE
Bounded, 1-dimensional geometric primitive, representing the continuous image of a line.
|
static TopologyLevel |
TopologyLevel.FULL_PLANAR_GRAPH
2-dimensional topological complex which is planar.
|
static TopologyLevel |
TopologyLevel.FULL_SURFACE_GRAPH
2-dimensional topological complex which is isomorphic to a subset of a surface.
|
static TopologyLevel |
TopologyLevel.FULL_TOPOLOGY_3D
Complete coverage of a 3D coordinate space.
|
static TopologyLevel |
TopologyLevel.GEOMETRY_ONLY
Geometry objects without any additional structure which describes topology.
|
static SpatialRepresentationType |
SpatialRepresentationType.GRID
Grid data is used to represent geographic data.
|
static DimensionNameType |
DimensionNameType.LINE
Scan line of a sensor.
|
static PixelOrientation |
PixelOrientation.LOWER_LEFT
The corner in the pixel closest to the origin of the SRS; if two are at the same distance
from the origin, the one with the smallest x-value.
|
static PixelOrientation |
PixelOrientation.LOWER_RIGHT
Next corner counterclockwise from the lower left.
|
static TopologyLevel |
TopologyLevel.PLANAR_GRAPH
1-dimensional topological complex which is planar.
|
static CellGeometry |
CellGeometry.POINT
Each cell represents a point.
|
static GeometricObjectType |
GeometricObjectType.POINT
Zero-dimensional geometric primitive, representing a position but not having an extent.
|
static DimensionNameType |
DimensionNameType.ROW
Ordinate (y) axis.
|
static DimensionNameType |
DimensionNameType.SAMPLE
Element along a scan line.
|
static GeometricObjectType |
GeometricObjectType.SOLID
Bounded, connected 3-dimensional geometric primitive, representing the continuous image of a
region of space.
|
static SpatialRepresentationType |
SpatialRepresentationType.STEREO_MODEL
Three-dimensional view formed by the intersecting homologous rays of an overlapping pair of
images.
|
static GeometricObjectType |
GeometricObjectType.SURFACE
Bounded, connected 2-dimensional geometric, representing the continuous image of a region of
a plane.
|
static TopologyLevel |
TopologyLevel.SURFACE_GRAPH
1-dimensional topological complex which is isomorphic to a subset of a surface.
|
static SpatialRepresentationType |
SpatialRepresentationType.TEXT_TABLE
Textual or tabular data is used to represent geographic data.
|
static DimensionNameType |
DimensionNameType.TIME
Duration.
|
static SpatialRepresentationType |
SpatialRepresentationType.TIN
Triangulated irregular network.
|
static TopologyLevel |
TopologyLevel.TOPOLOGY_1D
1-dimensional topological complex.
|
static TopologyLevel |
TopologyLevel.TOPOLOGY_3D
3-dimensional topological complex.
|
static DimensionNameType |
DimensionNameType.TRACK
Along the direction of motion of the scan point
|
static PixelOrientation |
PixelOrientation.UPPER_LEFT
Next corner counterclockwise from the upper right.
|
static PixelOrientation |
PixelOrientation.UPPER_RIGHT
Next corner counterclockwise from the lower right.
|
static SpatialRepresentationType |
SpatialRepresentationType.VECTOR
Vector data is used to represent geographic data.
|
static DimensionNameType |
DimensionNameType.VERTICAL
Vertical (z) axis.
|
static SpatialRepresentationType |
SpatialRepresentationType.VIDEO
Scene from a video recording.
|
Modifier and Type | Method and Description |
---|---|
List<? extends Dimension> |
GridSpatialRepresentation.getAxisDimensionsProperties()
Information about spatial-temporal axis properties.
|
CellGeometry |
GridSpatialRepresentation.getCellGeometry()
Identification of grid data as point or cell.
|
Point |
Georectified.getCenterPoint()
Earth location in the coordinate system defined by the Spatial Reference System and the grid
coordinate of the cell halfway between opposite ends of the grid in the spatial dimensions.
|
InternationalString |
Georectified.getCheckPointDescription()
Description of geographic position points used to test the accuracy of the georeferenced grid
data.
|
List<? extends Point> |
Georectified.getCornerPoints()
Earth location in the coordinate system defined by the Spatial Reference System and the grid
coordinate of the cells at opposite ends of grid coverage along two diagonals in the grid
spatial dimensions.
|
DimensionNameType |
Dimension.getDimensionName()
Name of the axis.
|
Integer |
Dimension.getDimensionSize()
Number of elements along the axis.
|
Integer |
GeometricObjects.getGeometricObjectCount()
Total number of the point or vector object type occurring in the dataset.
|
Collection<? extends GeometricObjects> |
VectorSpatialRepresentation.getGeometricObjects()
Information about the geometric objects used in the dataset.
|
GeometricObjectType |
GeometricObjects.getGeometricObjectType()
Name of point and vector spatial objects used to locate zero-, one-, and twodimensional
spatial locations in the dataset.
|
Record |
Georeferenceable.getGeoreferencedParameters()
Terms which support grid data georeferencing.
|
Integer |
GridSpatialRepresentation.getNumberOfDimensions()
Number of independent spatial-temporal axes.
|
InternationalString |
Georeferenceable.getOrientationParameterDescription()
Description of parameters used to describe sensor orientation.
|
Collection<? extends Citation> |
Georeferenceable.getParameterCitation()
Reference providing description of the parameters.
|
PixelOrientation |
Georectified.getPointInPixel()
Point in a pixel corresponding to the Earth location of the pixel.
|
Double |
Dimension.getResolution()
Degree of detail in the grid dataset.
|
TopologyLevel |
VectorSpatialRepresentation.getTopologyLevel()
Code which identifies the degree of complexity of the spatial relationships.
|
InternationalString |
Georectified.getTransformationDimensionDescription()
Description of the information about which grid dimensions are the spatial dimensions.
|
Collection<? extends InternationalString> |
Georectified.getTransformationDimensionMapping()
Information about which grid dimensions are the spatial dimensions.
|
boolean |
Georectified.isCheckPointAvailable()
Indication of whether or not geographic position points are available to test the accuracy of
the georeferenced grid data.
|
boolean |
Georeferenceable.isControlPointAvailable()
Indication of whether or not control point(s) exists.
|
boolean |
Georeferenceable.isOrientationParameterAvailable()
Indication of whether or not orientation parameters are available.
|
boolean |
GridSpatialRepresentation.isTransformationParameterAvailable()
Indication of whether or not parameters for transformation exists.
|
Modifier and Type | Interface and Description |
---|---|
interface |
GeneralParameterDescriptor
Abstract definition of a parameter or group of parameters used by an operation method.
|
interface |
GeneralParameterValue
Abstract parameter value or group of parameter values.
|
class |
InvalidParameterNameException
Thrown when an unexpected parameter was found in a parameter
group.
|
class |
InvalidParameterValueException
Thrown when an invalid value was given to a parameter.
|
interface |
ParameterDescriptor<T>
The definition of a parameter used by an operation method.
|
interface |
ParameterDescriptorGroup
The definition of a group of related parameters used by an operation method.
|
interface |
ParameterValue<T>
A parameter value used by an operation method.
|
interface |
ParameterValueGroup
A group of related parameter values.
|
Modifier and Type | Method and Description |
---|---|
boolean |
ParameterValue.booleanValue()
Returns the boolean value of an operation parameter A boolean value does not have an
associated unit of measure.
|
List<GeneralParameterDescriptor> |
ParameterDescriptorGroup.descriptors()
Returns the parameters in this group.
|
double |
ParameterValue.doubleValue()
Returns the numeric value of the coordinate operation parameter with its associated
unit of measure.
|
double[] |
ParameterValue.doubleValueList()
Returns an ordered sequence of two or more numeric values of an operation parameter list,
where each value has the same associated unit of measure.
|
T |
ParameterDescriptor.getDefaultValue()
Returns the default value for the parameter.
|
ParameterDescriptorGroup |
ParameterValueGroup.getDescriptor()
The abstract definition of this group of parameters.
|
int |
GeneralParameterDescriptor.getMaximumOccurs()
The maximum number of times that values for this parameter group or parameter can be
included.
|
Comparable<T> |
ParameterDescriptor.getMaximumValue()
Returns the maximum parameter value.
|
int |
GeneralParameterDescriptor.getMinimumOccurs()
The minimum number of times that values for this parameter group or parameter are required.
|
Comparable<T> |
ParameterDescriptor.getMinimumValue()
Returns the minimum parameter value.
|
T |
ParameterValue.getValue()
Returns the parameter value as an object.
|
Class<T> |
ParameterDescriptor.getValueClass()
Returns the class that describe the type of the parameter.
|
int |
ParameterValue.intValue()
Returns the positive integer value of an operation parameter, usually used for a count.
|
int[] |
ParameterValue.intValueList()
Returns an ordered sequence of two or more integer values of an operation parameter list,
usually used for counts.
|
String |
ParameterValue.stringValue()
Returns the string value of an operation parameter.
|
URI |
ParameterValue.valueFile()
Returns a reference to a file or a part of a file containing one or more parameter values.
|
List<GeneralParameterValue> |
ParameterValueGroup.values()
Returns the values in this group.
|
Modifier and Type | Interface and Description |
---|---|
interface |
AuthorityFactory
Base interface for all authority factories.
|
interface |
IdentifiedObject
Supplementary identification and remarks information for a CRS or CRS-related object.
|
interface |
ReferenceIdentifier
Identifier used for reference systems.
|
interface |
ReferenceSystem
Description of a spatial and temporal reference system used by a dataset.
|
interface |
SpatialReferenceSystemUsingGeographicIdentifier
Spatial reference system using geographic identifier, a reference to a feature with a known
spatial location.
|
Modifier and Type | Method and Description |
---|---|
Collection<GenericName> |
IdentifiedObject.getAlias()
An alternative name by which this object is identified.
|
Citation |
AuthorityFactory.getAuthority()
Returns the organization or party responsible for definition and maintenance of the database.
|
String |
ReferenceIdentifier.getCodeSpace()
Name or identifier of the person or organization responsible for namespace.
|
InternationalString |
AuthorityFactory.getDescriptionText(String code)
Gets a description of the object corresponding to a code.
|
Extent |
ReferenceSystem.getDomainOfValidity()
Area or region or timeframe in which this (coordinate) reference system is valid.
|
Set<ReferenceIdentifier> |
IdentifiedObject.getIdentifiers()
An identifier which references elsewhere the object's defining information.
|
ReferenceIdentifier |
IdentifiedObject.getName()
The primary name by which this object is identified.
|
InternationalString |
IdentifiedObject.getRemarks()
Comments on or information about this object, including data source information.
|
InternationalString |
ReferenceSystem.getScope()
Description of domain of usage, or limitations of usage, for which this (coordinate)
reference system object is valid.
|
String |
ReferenceIdentifier.getVersion()
Version identifier for the namespace, as specified by the code authority.
|
Modifier and Type | Interface and Description |
---|---|
interface |
CompoundCRS
A coordinate reference system describing the position of points through two or more independent
coordinate reference systems.
|
interface |
CoordinateReferenceSystem
Abstract coordinate reference system, usually defined by a coordinate system and a datum.
|
interface |
CRSAuthorityFactory
Creates coordinate reference systems using authority
codes.
|
interface |
CRSFactory
Builds up complex coordinate reference systems from
simpler objects or values.
|
interface |
DerivedCRS
A coordinate reference system that is defined by its coordinate conversion from another
coordinate reference system but is not a projected coordinate reference system.
|
interface |
EngineeringCRS
A contextually local coordinate reference system.
|
interface |
GeneralDerivedCRS
A coordinate reference system that is defined by its coordinate conversion from another coordinate reference system (not by a datum).
|
interface |
GeocentricCRS
A 3D coordinate reference system with the origin at the approximate centre of mass of the earth.
|
interface |
GeodeticCRS
A coordinate reference system associated with a geodetic datum.
|
interface |
GeographicCRS
A coordinate reference system based on an ellipsoidal approximation of the geoid; this provides
an accurate representation of the geometry of geographic features for a large portion of the
earth's surface.
|
interface |
ImageCRS
An engineering coordinate reference system applied to locations in images.
|
interface |
ProjectedCRS
A 2D coordinate reference system used to approximate the shape of the earth on a planar surface.
|
interface |
SingleCRS
Abstract coordinate reference system, consisting of a single Coordinate System and a single Datum (as opposed to Compound CRS).
|
interface |
TemporalCRS
A 1D coordinate reference system used for the recording of time.
|
interface |
VerticalCRS
A 1D coordinate reference system used for recording heights or depths.
|
Modifier and Type | Method and Description |
---|---|
CompoundCRS |
CRSFactory.createCompoundCRS(Map<String,?> properties,
CoordinateReferenceSystem... elements)
Creates a compound coordinate reference system from an ordered list of
CoordinateReferenceSystem objects. |
CompoundCRS |
CRSAuthorityFactory.createCompoundCRS(String code)
Creates a 3D coordinate reference system from a code.
|
CoordinateReferenceSystem |
CRSAuthorityFactory.createCoordinateReferenceSystem(String code)
Returns an arbitrary coordinate reference system from
a code.
|
DerivedCRS |
CRSFactory.createDerivedCRS(Map<String,?> properties,
CoordinateReferenceSystem baseCRS,
Conversion conversionFromBase,
CoordinateSystem derivedCS)
Creates a derived coordinate reference system.
|
EngineeringCRS |
CRSFactory.createEngineeringCRS(Map<String,?> properties,
EngineeringDatum datum,
CoordinateSystem cs)
Creates a engineering coordinate reference system.
|
CoordinateReferenceSystem |
CRSFactory.createFromWKT(String wkt)
Creates a coordinate reference system object from a string.
|
CoordinateReferenceSystem |
CRSFactory.createFromXML(String xml)
Creates a coordinate reference system object from a XML string.
|
GeographicCRS |
CRSFactory.createGeographicCRS(Map<String,?> properties,
GeodeticDatum datum,
EllipsoidalCS cs)
Creates a geographic coordinate reference system.
|
GeographicCRS |
CRSAuthorityFactory.createGeographicCRS(String code)
Returns a geographic coordinate reference system from a code.
|
ProjectedCRS |
CRSFactory.createProjectedCRS(Map<String,?> properties,
GeographicCRS baseCRS,
Conversion conversionFromBase,
CartesianCS derivedCS)
Creates a projected coordinate reference system from a defining conversion.
|
ProjectedCRS |
CRSAuthorityFactory.createProjectedCRS(String code)
Returns a projected coordinate reference system from a code.
|
VerticalCRS |
CRSFactory.createVerticalCRS(Map<String,?> properties,
VerticalDatum datum,
VerticalCS cs)
Creates a vertical coordinate reference system.
|
VerticalCRS |
CRSAuthorityFactory.createVerticalCRS(String code)
Create a vertical coordinate reference system from a code.
|
CoordinateReferenceSystem |
GeneralDerivedCRS.getBaseCRS()
Returns the base coordinate reference system.
|
Conversion |
GeneralDerivedCRS.getConversionFromBase()
Returns the conversion from the base CRS to this CRS.
|
List<CoordinateReferenceSystem> |
CompoundCRS.getCoordinateReferenceSystems()
The ordered list of coordinate reference systems.
|
CartesianCS |
ProjectedCRS.getCoordinateSystem()
Returns the coordinate system, which must be cartesian.
|
TimeCS |
TemporalCRS.getCoordinateSystem()
Returns the coordinate system, which must be temporal.
|
AffineCS |
ImageCRS.getCoordinateSystem()
Returns the cartesian coordinate system.
|
CoordinateSystem |
SingleCRS.getCoordinateSystem()
Returns the coordinate system.
|
CoordinateSystem |
GeocentricCRS.getCoordinateSystem()
|
VerticalCS |
VerticalCRS.getCoordinateSystem()
Returns the coordinate system, which must be vertical.
|
EllipsoidalCS |
GeographicCRS.getCoordinateSystem()
Returns the coordinate system, which must be ellipsoidal.
|
TemporalDatum |
TemporalCRS.getDatum()
Returns the datum, which must be temporal.
|
ImageDatum |
ImageCRS.getDatum()
Returns the datum, which must be an image one.
|
Datum |
SingleCRS.getDatum()
Returns the datum.
|
VerticalDatum |
VerticalCRS.getDatum()
Returns the datum, which must be vertical.
|
GeodeticDatum |
GeodeticCRS.getDatum()
Returns the datum, which must be geodetic.
|
EngineeringDatum |
EngineeringCRS.getDatum()
Returns the datum, which must be an engineering one.
|
Modifier and Type | Interface and Description |
---|---|
interface |
AffineCS
A two- or three-dimensional coordinate system with straight axes that are not necessarily
orthogonal.
|
class |
AxisDirection
The direction of positive increments in the coordinate value for a coordinate system axis.
|
interface |
CartesianCS
A 1-, 2-, or 3-dimensional coordinate system.
|
interface |
CoordinateSystem
The set of coordinate system axes that spans a given coordinate space.
|
interface |
CoordinateSystemAxis
Definition of a coordinate system axis.
|
interface |
CylindricalCS
A three-dimensional coordinate system consisting of a polar coordinate
system extended by a straight coordinate axis perpendicular to the plane spanned by the polar
coordinate system.
|
interface |
EllipsoidalCS
A two- or three-dimensional coordinate system in which position is specified by geodetic
latitude, geodetic longitude, and (in the three-dimensional case) ellipsoidal height.
|
interface |
LinearCS
A one-dimensional coordinate system that consists of the points that lie on the single axis
described.
|
interface |
PolarCS
A two-dimensional coordinate system in which position is specified by the distance from the
origin and the angle between the line from the origin to a point and a reference direction.
|
class |
RangeMeaning
Meaning of the axis value range specified through minimum value and maximum value.
|
interface |
SphericalCS
A three-dimensional coordinate system with one distance measured from the origin and two angular
coordinates.
|
interface |
TimeCS
A one-dimensional coordinate system containing a single time axis, used to describe the temporal
position of a point in the specified time units from a specified time origin.
|
interface |
UserDefinedCS
A two- or three-dimensional coordinate system that consists of any combination of coordinate axes
not covered by any other Coordinate System type.
|
interface |
VerticalCS
A one-dimensional coordinate system used to record the heights (or depths) of points.
|
Modifier and Type | Field and Description |
---|---|
static AxisDirection |
AxisDirection.COLUMN_NEGATIVE
Axis positive direction is towards lower pixel column.
|
static AxisDirection |
AxisDirection.COLUMN_POSITIVE
Axis positive direction is towards higher pixel column.
|
static AxisDirection |
AxisDirection.DISPLAY_DOWN
Axis positive direction is towards bottom of approximately vertical display surface.
|
static AxisDirection |
AxisDirection.DISPLAY_LEFT
Axis positive direction is left in display.
|
static AxisDirection |
AxisDirection.DISPLAY_RIGHT
Axis positive direction is right in display.
|
static AxisDirection |
AxisDirection.DISPLAY_UP
Axis positive direction is towards top of approximately vertical display surface.
|
static AxisDirection |
AxisDirection.DOWN
Axis positive direction is down relative to gravity.
|
static AxisDirection |
AxisDirection.EAST
Axis positive direction is π/2 radians clockwise from north.
|
static AxisDirection |
AxisDirection.EAST_NORTH_EAST
Axis positive direction is approximately east-north-east.
|
static AxisDirection |
AxisDirection.EAST_SOUTH_EAST
Axis positive direction is approximately east-south-east.
|
static RangeMeaning |
RangeMeaning.EXACT
Any value between and including minimum
value and maximum value is valid.
|
static AxisDirection |
AxisDirection.FUTURE
Axis positive direction is towards the future.
|
static AxisDirection |
AxisDirection.GEOCENTRIC_X
Axis positive direction is in the equatorial plane from the centre of the modelled earth
towards the intersection of the equator with the prime meridian.
|
static AxisDirection |
AxisDirection.GEOCENTRIC_Y
Axis positive direction is in the equatorial plane from the centre of the modelled earth
towards the intersection of the equator and the meridian π/2 radians eastwards from the
prime meridian.
|
static AxisDirection |
AxisDirection.GEOCENTRIC_Z
Axis positive direction is from the centre of the modelled earth parallel to its rotation
axis and towards its north pole.
|
static AxisDirection |
AxisDirection.NORTH
Axis positive direction is north.
|
static AxisDirection |
AxisDirection.NORTH_EAST
Axis positive direction is approximately north-east.
|
static AxisDirection |
AxisDirection.NORTH_NORTH_EAST
Axis positive direction is approximately north-north-east.
|
static AxisDirection |
AxisDirection.NORTH_NORTH_WEST
Axis positive direction is approximately north-north-west.
|
static AxisDirection |
AxisDirection.NORTH_WEST
Axis positive direction is approximately north-west.
|
static AxisDirection |
AxisDirection.OTHER
Unknown or unspecified axis orientation.
|
static AxisDirection |
AxisDirection.PAST
Axis positive direction is towards the past.
|
static AxisDirection |
AxisDirection.ROW_NEGATIVE
Axis positive direction is towards lower pixel row.
|
static AxisDirection |
AxisDirection.ROW_POSITIVE
Axis positive direction is towards higher pixel row.
|
static AxisDirection |
AxisDirection.SOUTH
Axis positive direction is π radians clockwise from north.
|
static AxisDirection |
AxisDirection.SOUTH_EAST
Axis positive direction is approximately south-east.
|
static AxisDirection |
AxisDirection.SOUTH_SOUTH_EAST
Axis positive direction is approximately south-south-east.
|
static AxisDirection |
AxisDirection.SOUTH_SOUTH_WEST
Axis positive direction is approximately south-south-west.
|
static AxisDirection |
AxisDirection.SOUTH_WEST
Axis positive direction is approximately south-west.
|
static AxisDirection |
AxisDirection.UP
Axis positive direction is up relative to gravity.
|
static AxisDirection |
AxisDirection.WEST
Axis positive direction is 3π/2 radians clockwise from north.
|
static AxisDirection |
AxisDirection.WEST_NORTH_WEST
Axis positive direction is approximately west-north-west.
|
static AxisDirection |
AxisDirection.WEST_SOUTH_WEST
Axis positive direction is approximately west-south-west.
|
static RangeMeaning |
RangeMeaning.WRAPAROUND
The axis is continuous with values wrapping around at the minimum value and maximum value.
|
Modifier and Type | Method and Description |
---|---|
Unit<?> |
CSAuthorityFactory.createUnit(String code)
Returns an unit from a code.
|
String |
CoordinateSystemAxis.getAbbreviation()
The abbreviation used for this coordinate system axes.
|
CoordinateSystemAxis |
CoordinateSystem.getAxis(int dimension)
Returns the axis for this coordinate system at the specified dimension.
|
AxisDirection |
CoordinateSystemAxis.getDirection()
Direction of this coordinate system axis.
|
double |
CoordinateSystemAxis.getMaximumValue()
Returns the maximum value normally allowed for this axis, in the unit of
measure for the axis.
|
double |
CoordinateSystemAxis.getMinimumValue()
Returns the minimum value normally allowed for this axis, in the unit of
measure for the axis.
|
RangeMeaning |
CoordinateSystemAxis.getRangeMeaning()
|
Unit<?> |
CoordinateSystemAxis.getUnit()
The unit of measure used for this coordinate system axis.
|
Modifier and Type | Interface and Description |
---|---|
interface |
Datum
Specifies the relationship of a coordinate system to the earth, thus creating a coordinate reference system.
|
interface |
DatumAuthorityFactory
Creates datum objects using authority codes.
|
interface |
DatumFactory
Builds up complex datums from simpler objects or values.
|
interface |
Ellipsoid
Geometric figure that can be used to describe the approximate shape of the earth.
|
interface |
EngineeringDatum
Defines the origin of an engineering coordinate reference system.
|
interface |
GeodeticDatum
Defines the location and precise orientation in 3-dimensional space of a defined ellipsoid (or
sphere) that approximates the shape of the earth.
|
interface |
ImageDatum
Defines the origin of an image coordinate reference system.
|
class |
PixelInCell
Specification of the way the image grid is associated with the image data attributes.
|
interface |
PrimeMeridian
A prime meridian defines the origin from which longitude values are determined.
|
interface |
TemporalDatum
A temporal datum defines the origin of a temporal coordinate reference system.
|
interface |
VerticalDatum
A textual description and/or a set of parameters identifying a particular reference level surface
used as a zero-height surface.
|
class |
VerticalDatumType
Type of a vertical datum.
|
Modifier and Type | Field and Description |
---|---|
static VerticalDatumType |
VerticalDatumType.BAROMETRIC
Atmospheric pressure is the basis for the definition of the origin of the associated vertical
coordinate system axis.
|
static PixelInCell |
PixelInCell.CELL_CENTER
The origin of the image coordinate system is the centre of a grid cell or image pixel.
|
static PixelInCell |
PixelInCell.CELL_CORNER
The origin of the image coordinate system is the corner of a grid cell, or half-way between
the centres of adjacent image pixels.
|
static VerticalDatumType |
VerticalDatumType.DEPTH
The zero point of the vertical axis is defined by a surface that has meaning for the purpose
which the associated vertical measurements are used for.
|
static VerticalDatumType |
VerticalDatumType.ELLIPSOIDAL
A vertical datum for ellipsoidal heights that are measured along the normal to the ellipsoid
used in the definition of horizontal datum.
|
static VerticalDatumType |
VerticalDatumType.GEOIDAL
The zero value of the associated vertical coordinate system axis is defined to approximate a
constant potential surface, usually the geoid.
|
static VerticalDatumType |
VerticalDatumType.ORTHOMETRIC
A vertical datum for orthometric heights that are measured along the plumb line.
|
static VerticalDatumType |
VerticalDatumType.OTHER_SURFACE
In some cases, e.g. oil exploration and production, a geological feature, such as the top or
bottom of a geologically identifiable and meaningful subsurface layer, is used as a vertical
datum.
|
Modifier and Type | Method and Description |
---|---|
Ellipsoid |
DatumFactory.createEllipsoid(Map<String,?> properties,
double semiMajorAxis,
double semiMinorAxis,
Unit<Length> unit)
Creates an ellipsoid from radius values.
|
Ellipsoid |
DatumAuthorityFactory.createEllipsoid(String code)
Returns an ellipsoid from a code.
|
EngineeringDatum |
DatumFactory.createEngineeringDatum(Map<String,?> properties)
Creates an engineering datum.
|
Ellipsoid |
DatumFactory.createFlattenedSphere(Map<String,?> properties,
double semiMajorAxis,
double inverseFlattening,
Unit<Length> unit)
Creates an ellipsoid from an major radius, and inverse flattening.
|
GeodeticDatum |
DatumFactory.createGeodeticDatum(Map<String,?> properties,
Ellipsoid ellipsoid,
PrimeMeridian primeMeridian)
Creates geodetic datum from ellipsoid and (optionaly) Bursa-Wolf parameters.
|
GeodeticDatum |
DatumAuthorityFactory.createGeodeticDatum(String code)
Returns a geodetic datum from a code.
|
PrimeMeridian |
DatumFactory.createPrimeMeridian(Map<String,?> properties,
double longitude,
Unit<Angle> unit)
Creates a prime meridian, relative to Greenwich.
|
PrimeMeridian |
DatumAuthorityFactory.createPrimeMeridian(String code)
Returns a prime meridian from a code.
|
VerticalDatum |
DatumFactory.createVerticalDatum(Map<String,?> properties,
VerticalDatumType type)
Creates a vertical datum from an enumerated type value.
|
VerticalDatum |
DatumAuthorityFactory.createVerticalDatum(String code)
Creates a vertical datum from a code.
|
InternationalString |
Datum.getAnchorPoint()
Description, possibly including coordinates, of the point or points used to anchor the datum
to the Earth.
|
InternationalString |
TemporalDatum.getAnchorPoint()
This attribute is defined in the
Datum parent interface, but is not used by a
temporal datum. |
Unit<Angle> |
PrimeMeridian.getAngularUnit()
Returns the angular unit of the Greenwich longitude.
|
Unit<Length> |
Ellipsoid.getAxisUnit()
Returns the linear unit of the semi-major and semi-minor axis values.
|
Extent |
Datum.getDomainOfValidity()
Area or region or timeframe in which this datum is valid.
|
Ellipsoid |
GeodeticDatum.getEllipsoid()
Returns the ellipsoid.
|
double |
PrimeMeridian.getGreenwichLongitude()
Longitude of the prime meridian measured from the Greenwich meridian, positive eastward.
|
double |
Ellipsoid.getInverseFlattening()
Returns the value of the inverse of the flattening constant.
|
Date |
TemporalDatum.getOrigin()
The date and time origin of this temporal datum.
|
PixelInCell |
ImageDatum.getPixelInCell()
Specification of the way the image grid is associated with the image data attributes.
|
PrimeMeridian |
GeodeticDatum.getPrimeMeridian()
Returns the prime meridian.
|
Date |
Datum.getRealizationEpoch()
The time after which this datum definition is valid.
|
Date |
TemporalDatum.getRealizationEpoch()
This attribute is defined in the
Datum parent interface, but is not used by a
temporal datum. |
InternationalString |
Datum.getScope()
Description of domain of usage, or limitations of usage, for which this datum object is
valid.
|
double |
Ellipsoid.getSemiMajorAxis()
Length of the semi-major axis of the ellipsoid.
|
double |
Ellipsoid.getSemiMinorAxis()
Length of the semi-minor axis of the ellipsoid.
|
VerticalDatumType |
VerticalDatum.getVerticalDatumType()
The type of this vertical datum.
|
boolean |
Ellipsoid.isIvfDefinitive()
Indicates if the inverse flattening is definitive for this
ellipsoid.
|
boolean |
Ellipsoid.isSphere()
true if the ellipsoid is degenerate and is actually a sphere. |
Modifier and Type | Interface and Description |
---|---|
interface |
ConcatenatedOperation
An ordered sequence of two or more single coordinate operations.
|
interface |
Conversion
An operation on coordinates that does not include any change of Datum.
|
interface |
CoordinateOperation
A mathematical operation on coordinates that transforms or converts coordinates to another
coordinate reference system.
|
interface |
CoordinateOperationAuthorityFactory
Creates coordinate transformation objects from codes.
|
interface |
CoordinateOperationFactory
Creates coordinate operations.
|
interface |
MathTransform
Transforms multi-dimensional coordinate points.
|
interface |
MathTransformFactory
Low level factory for creating math transforms.
|
interface |
Matrix
A two dimensional array of numbers.
|
interface |
Operation
A parameterized mathematical operation on coordinates that transforms or converts coordinates to
another coordinate reference system.
|
interface |
OperationMethod
Definition of an algorithm used to perform a coordinate operation.
|
interface |
PassThroughOperation
A pass-through operation specifies that a subset of a coordinate tuple is subject to a specific
coordinate operation.
|
interface |
SingleOperation
A single (not concatenated) coordinate operation.
|
interface |
Transformation
An operation on coordinates that usually includes a change of Datum.
|
Modifier and Type | Method and Description |
---|---|
MathTransform |
MathTransformFactory.createAffineTransform(Matrix matrix)
Creates an affine transform from a matrix.
|
MathTransform |
MathTransformFactory.createConcatenatedTransform(MathTransform transform1,
MathTransform transform2)
Creates a transform by concatenating two existing transforms.
|
CoordinateOperation |
CoordinateOperationAuthorityFactory.createCoordinateOperation(String code)
Creates an operation from a single operation code.
|
Set<CoordinateOperation> |
CoordinateOperationAuthorityFactory.createFromCoordinateReferenceSystemCodes(String sourceCRS,
String targetCRS)
Creates operations from coordinate reference system
codes.
|
MathTransform |
MathTransformFactory.createFromWKT(String wkt)
Creates a math transform object from a string.
|
MathTransform |
MathTransformFactory.createFromXML(String xml)
Creates a math transform object from a XML string.
|
CoordinateOperation |
CoordinateOperationFactory.createOperation(CoordinateReferenceSystem sourceCRS,
CoordinateReferenceSystem targetCRS)
Returns an operation for conversion or transformation between two coordinate reference
systems.
|
MathTransform |
MathTransformFactory.createParameterizedTransform(ParameterValueGroup parameters)
Creates a transform from a group of parameters.
|
MathTransform |
MathTransformFactory.createPassThroughTransform(int firstAffectedOrdinate,
MathTransform subTransform,
int numTrailingOrdinates)
Creates a transform which passes through a subset of ordinates to another transform.
|
Matrix |
MathTransform.derivative(DirectPosition point)
Gets the derivative of this transform at a point.
|
Set<CoordinateOperation> |
CoordinateOperationFactory.findOperations(CoordinateReferenceSystem sourceCRS,
CoordinateReferenceSystem targetCRS)
Returns all the available operations for conversion or transformation between two coordinate
reference systems.
|
Collection<PositionalAccuracy> |
CoordinateOperation.getCoordinateOperationAccuracy()
Estimate(s) of the impact of this operation on point accuracy.
|
Extent |
CoordinateOperation.getDomainOfValidity()
Area or region or timeframe in which this coordinate operation is valid.
|
InternationalString |
OperationMethod.getFormula()
Formula(s) or procedure used by this operation method.
|
MathTransform |
CoordinateOperation.getMathTransform()
Gets the math transform.
|
OperationMethod |
Operation.getMethod()
Returns the operation method.
|
int[] |
PassThroughOperation.getModifiedCoordinates()
Ordered sequence of positive integers defining the positions in a coordinate tuple of the
coordinates affected by this pass-through operation.
|
Operation |
PassThroughOperation.getOperation()
Returns the operation to apply on the subset of a coordinate tuple.
|
List<SingleOperation> |
ConcatenatedOperation.getOperations()
Returns the sequence of operations.
|
String |
Conversion.getOperationVersion()
This attribute is declared in
CoordinateOperation but is not used in a conversion. |
String |
Transformation.getOperationVersion()
Version of the coordinate transformation (i.e., instantiation due to the stochastic nature of
the parameters).
|
String |
CoordinateOperation.getOperationVersion()
Version of the coordinate transformation (i.e., instantiation due to the stochastic nature of
the parameters).
|
ParameterDescriptorGroup |
OperationMethod.getParameters()
The set of parameters.
|
ParameterValueGroup |
Operation.getParameterValues()
Returns the parameter values.
|
InternationalString |
CoordinateOperation.getScope()
Description of domain of usage, or limitations of usage, for which this operation is valid.
|
CoordinateReferenceSystem |
Conversion.getSourceCRS()
Returns the source CRS.
|
CoordinateReferenceSystem |
Transformation.getSourceCRS()
Returns the source CRS.
|
CoordinateReferenceSystem |
CoordinateOperation.getSourceCRS()
Returns the source CRS.
|
int |
OperationMethod.getSourceDimensions()
Number of dimensions in the source CRS of this operation method.
|
int |
MathTransform.getSourceDimensions()
Gets the dimension of input points.
|
CoordinateReferenceSystem |
Conversion.getTargetCRS()
Returns the target CRS.
|
CoordinateReferenceSystem |
Transformation.getTargetCRS()
Returns the target CRS.
|
CoordinateReferenceSystem |
CoordinateOperation.getTargetCRS()
Returns the target CRS.
|
int |
OperationMethod.getTargetDimensions()
Number of dimensions in the target CRS of this operation method.
|
int |
MathTransform.getTargetDimensions()
Gets the dimension of output points.
|
MathTransform |
MathTransform.inverse()
Creates the inverse transform of this object.
|
boolean |
MathTransform.isIdentity()
Tests whether this transform does not move any points.
|
String |
MathTransform.toWKT()
Returns a Well Known Text (WKT) for this object.
|
DirectPosition |
MathTransform.transform(DirectPosition ptSrc,
DirectPosition ptDst)
Transforms the specified
ptSrc and stores the result in ptDst . |
void |
MathTransform.transform(double[] srcPts,
int srcOff,
double[] dstPts,
int dstOff,
int numPts)
Transforms a list of coordinate point ordinal values.
|
Modifier and Type | Interface and Description |
---|---|
interface |
FeatureTypeStyle
Represents a style that applies to features or coverage.
|
interface |
Rule
A rule consists of two important parts: a filter and a list of symbols.
|
interface |
Style
A UserStyle is at the same semantic level as a NamedStyle used in the context of a WMS.
|
interface |
Symbolizer
Abstract superclass of the symbolizers defined by the Symbology Encoding specification.
|
Modifier and Type | Method and Description |
---|---|
Set<Name> |
FeatureTypeStyle.featureTypeNames()
Returns the names of the feature type that this style is meant to act upon.
|
List<? extends FeatureTypeStyle> |
Style.featureTypeStyles()
Returns a collection of feature type style.
|
Symbolizer |
Style.getDefaultSpecification()
Returns the default specification used if no rule return true.
|
Description |
Rule.getDescription()
Returns the description of this rule.
|
Description |
FeatureTypeStyle.getDescription()
Returns the description of this style.
|
Id |
FeatureTypeStyle.getFeatureInstanceIDs()
Returns a collection of Object identifying features object.
|
Filter |
Rule.getFilter()
Returns the filter that will limit the features for which this
Rule will fire. |
String |
Rule.getName()
Returns a name for this rule.
|
List<? extends Rule> |
FeatureTypeStyle.rules()
Returns the list of rules contained by this style.
|
List<? extends Symbolizer> |
Rule.symbolizers()
This method returns the list of Symbolizer objects contained by this
Rule . |
Modifier and Type | Interface and Description |
---|---|
interface |
Calendar
A discrete temporal reference system that provides a basis for defining temporal position to a
resolution of one day.
|
interface |
CalendarDate
A data type that shall be used to identify temporal position within a calendar.
|
interface |
CalendarEra
Characteristics of each calendar era.
|
interface |
Clock
Provides a basis for defining temporal position within a day.
|
interface |
ClockTime
A data type that shall be used to identify a temporal position within a day.
|
interface |
DateAndTime
Provides a single data type for identifying a temporal position with a resolution of less than a
day.
|
interface |
Duration
A data type to be used for describing length or distance in the temporal dimension.
|
class |
IndeterminateValue
Provides 4 values for indeterminate positions.
|
interface |
Instant
A zero-dimensional geometric primitive that represents position in time, equivalent to a point in
space.
|
interface |
IntervalLength
A data type for intervals of time which supports the expression of duration in terms of a
specified multiple of a single unit of time.
|
interface |
JulianDate
The Julian day numbering system is a temporal coordinate system that has its origin at noon on 1
January 4713 BC in the Julian proleptic calendar.
|
interface |
OrdinalEra
Provides a reference to the ordinal era in which the instant occurs.
|
interface |
OrdinalPosition
A data type that shall be used for identifying temporal position within an ordinal temporal
reference system.
|
interface |
Period
A one-dimensional geometric primitive that represent extent in time.
|
interface |
PeriodDuration
Uses the format specified by ISO 8601 for exchanging information about the duration of a period.
|
interface |
Position
A union class that consists of one of the data types listed as its attributes.
|
class |
RelativePosition
Values for relative temporal position based on the 13 temporal relationships identified by Allen
(1993).
|
interface |
Separation
Provides operations for calculating temporal length and distance.
|
interface |
TemporalCoordinate
A data type that shall be used for identifying temporal position within a temporal coordinate
system.
|
interface |
TemporalCoordinateSystem
A temporal coordinate system to simplify the computation of temporal distances between points and
the functional description of temporal operations.
|
interface |
TemporalEdge
One-dimensional topological primitive in time.
|
interface |
TemporalGeometricPrimitive
An abstract class with two subclasses for representing a temporal instant and a temporal period.
|
interface |
TemporalNode
A zero dimensional topological primitive in time.
|
interface |
TemporalObject
Base interface for temporal object.
|
interface |
TemporalOrder
Provides an operation for determining the position of this temporal
primitive relative to another temporal primitive.
|
interface |
TemporalPosition
Used for describing temporal positions referenced to other temporal reference systems.
|
interface |
TemporalPrimitive
An abstract class that represents a non-decomposed element of geometry or topology of time.
|
interface |
TemporalReferenceSystem
Provides information about a temporal reference system.
|
interface |
TemporalTopologicalComplex
An aggregation of connected temporal topological
primitives.
|
interface |
TemporalTopologicalPrimitive
Represents a single non-decomposable element of topology and its relationships to other
topological primitives within a topological complex.
|
Modifier and Type | Method and Description |
---|---|
TemporalPosition |
Position.anyOther()
TemporalPosition and its subtypes shall be used for describing temporal
positions referenced to other reference systems, and may be used for temporal positions
referenced to any calendar or clock, including the Gregorian calendar and UTC.
|
ClockTime |
Clock.clkTrans(ClockTime clkTime)
Converts UTC time to a time on this clock.
|
JulianDate |
Calendar.dateTrans(CalendarDate date,
ClockTime time)
Converts a date in this calendar to a julian
date.
|
Duration |
Separation.distance(TemporalGeometricPrimitive other)
Returns the distance from this temporal geometric
primitive to another temporal geometric primitive.
|
Collection<CalendarEra> |
Calendar.getBasis()
links this calendar to the calendar eras that it uses as a reference
for dating.
|
Instant |
Period.getBeginning()
Links this period to the instant at which it starts.
|
Date |
OrdinalEra.getBeginning()
The beginning at which the ordinal era began if it's known.
|
Collection<Period> |
Instant.getBegunBy()
Get the Collection of temporal
Period s, for which this Instant is the beginning. |
int[] |
CalendarDate.getCalendarDate()
Provides a sequence of integers in which the first integer identifies a specific instance of
the unit used at the highest level of the calendar hierarchy, the second integer identifies a
specific instance of the unit used at the next lower level in the hierarchy, and so on.
|
InternationalString |
CalendarDate.getCalendarEraName()
Provides the name of the calendar era to which the date is
referenced.
|
Clock |
Calendar.getClock()
Links this calendar to the clock that is used for specifying temporal
positions within the smallest calendar interval.
|
Number[] |
ClockTime.getClockTime()
A sequence of numbers with a structure similar to that of
CalendarDate . |
Collection<OrdinalEra> |
OrdinalEra.getComposition()
Ordinal eras that subdivide this ordinal era.
|
Number |
TemporalCoordinate.getCoordinateValue()
Returns the distance from the scale origin expressed as a multiple of the standard interval
associated with the temporal coordinate system.
|
Date |
Position.getDate()
May be used for describing temporal positions in ISO8601 format referenced to the Gregorian
calendar and UTC.
|
InternationalString |
Position.getDateTime()
May be used for describing temporal positions in ISO8601 format referenced to the Gregorian
calendar and UTC.
|
InternationalString |
PeriodDuration.getDays()
A positive integer, followed by the character "D", which indicated the number of days in the
period.
|
InternationalString |
PeriodDuration.getDesignator()
A mandatory element which designates that the returned string represents the duration of a
period.
|
Extent |
TemporalReferenceSystem.getDomainOfValidity()
Identifies the space and time within which the reference system is applicable.
|
TemporalNode |
TemporalEdge.getEnd()
Links this edge to the node that is its end.
|
Date |
OrdinalEra.getEnd()
The end at which the ordinal era began if it's known.
|
Collection<Period> |
Instant.getEndedBy()
Get the Collection of temporal
Period s, for which this Instant is the end. |
Instant |
Period.getEnding()
Links this period to the instant at which it ends.
|
Period |
CalendarEra.getEpochOfUse()
Identifies the period for which the calendar era was used as a reference
fro dating.
|
int |
IntervalLength.getFactor()
The exponent of the base.
|
InternationalString |
PeriodDuration.getHours()
A positive integer, followed by the character "H", which indicated the number of hours in the
period.
|
IndeterminateValue |
TemporalPosition.getIndeterminatePosition()
This attribute provides the only value for temporal position unless a subtype of
TemporalPosition is used as the data type. |
InternationalString |
TemporalCoordinateSystem.getInterval()
Identifies the base interval for this temporal coordinate system as a unit of measure
specified by ISO 31-1, or a multiple of one of those units, as specified by ISO 1000.
|
JulianDate |
CalendarEra.getJulianReference()
Provides the julian date that corresponds to the reference date.
|
InternationalString |
PeriodDuration.getMinutes()
A positive integer, followed by the character "M", which indicated the number of minutes in
the period.
|
InternationalString |
PeriodDuration.getMonths()
A positive integer, followed by the character "M", which indicated the number of months in
the period.
|
ReferenceIdentifier |
TemporalReferenceSystem.getName()
Provides a name that uniquely identifies the temporal referece system.
|
InternationalString |
CalendarEra.getName()
Uniquely identifies the calendar era within this calendar.
|
InternationalString |
OrdinalEra.getName()
The unique name of the ordinal era within the ordinal reference system.
|
TemporalEdge |
TemporalNode.getNextEdge()
Links this temporal node to the next temporal edge.
|
Collection<OrdinalEra> |
OrdinalReferenceSystem.getOrdinalEraSequence()
Get the set of ordinal eras of which this ordinal reference system consists of.
|
OrdinalEra |
OrdinalPosition.getOrdinalPosition()
Provides a reference to the ordinal era in which the instant occurs.
|
Date |
TemporalCoordinateSystem.getOrigin()
Position of the origin of the scale on which the temporal coordinate system is based
expressed as a date in the Gregorian calendar and time of day in UTC.
|
Position |
Instant.getPosition()
Get the position of this instant.
|
TemporalEdge |
TemporalNode.getPreviousEdge()
Links this temporal node to the previous temporal edge.
|
int |
IntervalLength.getRadix()
A positive integer that is the base of the mulitplier of the unit.
|
Period |
TemporalEdge.getRealization()
An optional association that links this edge to the corresponding period.
|
Instant |
TemporalNode.getRealization()
An optional association that may link this temporal node to its corresponding instant.
|
CalendarDate |
CalendarEra.getReferenceDate()
Provides the date of the reference event expressed as a date in the given calendar.
|
InternationalString |
Clock.getReferenceEvent()
Event used as the datum for this clock.
|
InternationalString |
CalendarEra.getReferenceEvent()
Provides the name or description of a mythical or historic event which fixes the position of
the base scale of the calendar era.
|
ClockTime |
Clock.getReferenceTime()
Time of the reference Event for this clock, usually the origin of the clock scale.
|
InternationalString |
PeriodDuration.getSeconds()
A positive integer, followed by the character "S", which indicated the number of seconds in
the period.
|
TemporalNode |
TemporalEdge.getStart()
Links this edge to the node that is its start.
|
Time |
Position.getTime()
May be used for describing temporal positions in ISO8601 format referenced to the Gregorian
calendar and UTC.
|
InternationalString |
PeriodDuration.getTimeIndicator()
Included whenever the sequence includes values for units less than a day.
|
Unit |
IntervalLength.getUnit()
The unit of measure used to express the length of the interval.
|
ClockTime |
Clock.getUTCReference()
Provides the 24-hour local or UTC time that corresponds to the reference time.
|
int |
IntervalLength.getValue()
|
InternationalString |
PeriodDuration.getYears()
A positive integer, followed by the character "Y", which indicated the number of years in the
period.
|
CalendarDate |
Calendar.julTrans(JulianDate julian)
Converts a julian date to a date in this
calendar.
|
Duration |
Separation.length()
Return the duration of this temporal geometric
primitive.
|
RelativePosition |
TemporalOrder.relativePosition(TemporalPrimitive other)
Determines the position of this primitive relative to another primitive.
|
Date |
TemporalCoordinateSystem.transformCoord(TemporalCoordinate coordinates)
Transforms a value of a coordinate within this temporal
coordinate system and returns the equivalent date and time in the
Gregorian Calendar and UTC
|
TemporalCoordinate |
TemporalCoordinateSystem.transformDateTime(Date datetime)
Transforms a date and time in the Gregorian Calendar and UTC to an
equivalent coordinate within this temporal coordinate system.
|
ClockTime |
Clock.utcTrans(ClockTime uTime)
Converts UTC time to a time on this clock.
|
Modifier and Type | Interface and Description |
---|---|
interface |
GenericName
A sequence of identifiers rooted within the context of a namespace.
|
interface |
LocalName
Identifier within a name space for a local object.
|
interface |
MemberName
The name to identify a member of a record.
|
interface |
NameSpace
A domain in which names given by character strings are defined.
|
interface |
Record
A list of logically related elements as (name, value) pairs in a
dictionary.
|
interface |
RecordSchema
A collection of record types.
|
interface |
RecordType
The type definition of a record.
|
interface |
ScopedName
A composite of a local name (as head) for locating
another name space, and a generic name (as
tail) valid in that name space.
|
interface |
TypeName
The name of an attribute type.
|
class |
UnlimitedInteger
An integer with associated infinite flag.
|
Modifier and Type | Method and Description |
---|---|
int |
GenericName.depth()
Indicates the number of levels specified by this name.
|
Map<MemberName,Object> |
Record.getAttributes()
Returns the dictionary of all (name, value) pairs in this record.
|
TypeName |
MemberName.getAttributeType()
Returns the type of the data associated with the record member.
|
Map<MemberName,TypeName> |
RecordType.getAttributeTypes()
Returns the dictionary of all (name, type) pairs in this record type.
|
RecordSchema |
RecordType.getContainer()
Returns the schema that contains this record type.
|
Map<TypeName,RecordType> |
RecordSchema.getDescription()
Returns the dictionary of all (name, record type) pairs in this schema.
|
Collection<RecordType> |
RecordSchema.getElements()
Returns all record types declared in this schema.
|
List<? extends LocalName> |
GenericName.getParsedNames()
Returns the sequence of local names making this generic name.
|
List<? extends LocalName> |
LocalName.getParsedNames()
Returns the sequence of local name.
|
RecordType |
Record.getRecordType()
Returns the type definition of record.
|
LocalName |
RecordSchema.getSchemaName()
Returns the schema name.
|
TypeName |
RecordType.getTypeName()
Returns the name that identifies this record type.
|
LocalName |
ScopedName.head()
Returns the first element in the sequence of parsed names.
|
LocalName |
GenericName.head()
Returns the first element in the sequence of parsed names.
|
boolean |
NameSpace.isGlobal()
Indicates whether this namespace is a "top level" namespace.
|
TypeName |
RecordType.locate(MemberName name)
Looks up the provided attribute name and returns the associated type name.
|
Object |
Record.locate(MemberName name)
Returns the value for an attribute of the specified name.
|
RecordType |
RecordSchema.locate(TypeName name)
Looks up the provided type name and returns the associated record type.
|
GenericName |
NameSpace.name()
Represents the identifier of this namespace.
|
ScopedName |
GenericName.push(GenericName scope)
Returns this name expanded with the specified scope.
|
NameSpace |
GenericName.scope()
Returns the scope (name space) in which this name is local.
|
GenericName |
ScopedName.tail()
Returns every elements of the parsed names list except for the
head.
|
String |
ScopedName.toString()
Returns a locale-independent string representation of this scoped name.
|
String |
LocalName.toString()
Returns a locale-independant string representation of this local name.
|
Copyright © 1996–2023 Geotools. All rights reserved.