Package | Description |
---|---|
agi.foundation |
Contains commonly used types.
|
agi.foundation.access.constraints |
Contains types used in modeling constraints applied to the calculation of access.
|
agi.foundation.celestial |
Contains types used in modeling characteristics of celestial objects and celestial phenomena.
|
agi.foundation.cesium |
Contains types used for defining graphical properties of definitional objects to be written out as CZML.
|
agi.foundation.communications |
Contains types for representing electromagnetic signals and propagating them along communication links.
|
agi.foundation.communications.antennas |
Contains types for representing antennas, defining gain patterns, and processing electromagnetic signals.
|
agi.foundation.coordinates |
Contains types for quantifying and converting between various coordinate representations.
|
agi.foundation.geometry |
Contains types for expressing the motion of fundamental geometric objects such as points, axes, and reference frames;
the manner in which they are related; and transformations between representations.
|
agi.foundation.geometry.shapes |
Contains types for representing geometric shapes such as curves, surfaces, and solids.
|
agi.foundation.graphics |
Provides commonly used and instantiated graphics types related to 3D scene management, terrain and imagery, and more.
|
agi.foundation.terrain |
Contains types for reading and analyzing terrain data.
|
Modifier and Type | Method and Description |
---|---|
static double |
SphericalDescriptiveStatistics.dispersionAboutPosition(List<UnitCartesian> dataList,
UnitSpherical position)
Calculates the dispersion about a given input position.
|
static UnitSpherical |
SphericalDescriptiveStatistics.meanDirection(List<UnitCartesian> dataList)
Calculates the mean direction of a list of data.
|
static double |
SphericalDescriptiveStatistics.meanResultantLength(List<UnitCartesian> dataList)
Calculates the mean resultant length of a list of data.
|
static Spherical |
SphericalDescriptiveStatistics.meanVector(List<UnitCartesian> dataList)
Computes the mean vector.
|
static UnitSpherical |
SphericalDescriptiveStatistics.medianDirection(List<UnitCartesian> dataList)
Calculates the median direction of the data by using a simplex heuristic optimizer.
|
static UnitSpherical |
SphericalDescriptiveStatistics.medianDirection(List<UnitCartesian> dataList,
SphericalMedianCalculationMethod calculationMethod)
Calculates the median direction of the data by using a simplex heuristic optimizer.
|
static UnitSpherical |
SphericalDescriptiveStatistics.medianDirection(List<UnitCartesian> dataList,
SphericalMedianCalculationMethod calculationMethod,
MultivariableFunctionSolverResults<MultivariableFunctionSolverIterationResults>[] results)
Calculates the median direction of the data by using a simplex heuristic optimizer.
|
static Matrix3By3Symmetric |
SphericalDescriptiveStatistics.scatterMatrix(List<UnitCartesian> dataList)
Calculates the scatter matrix based upon the input data.
|
static double |
SphericalDescriptiveStatistics.variance(List<UnitCartesian> dataList)
Calculates the variance of a list of data.
|
Modifier and Type | Method and Description |
---|---|
static Cartesian |
CircularEquatorialOrbitGrazingAngleConstraint.determineClosestPoint(Cartesian position,
UnitCartesian direction,
double radius)
Determines the point on a circular equatorial orbit with the provided
radius
that has the smallest angular separation to a directed line segment starting at the provided position
and along the indicated direction . |
static double |
AngleInPlaneConstraint.getAngleInPlane(UnitCartesian vector,
PlaneIndicator plane)
Gets the angle formed by a projection of a vector into an axis-aligned plane.
|
Modifier and Type | Method and Description |
---|---|
UnitCartesian |
ReactionWheelTorque.getSpinAxis()
Gets the body-fixed spin axis of the reaction wheel.
|
UnitCartesian |
SolarRadiationOneDofSolarPanelPlate.getUnitAxisCartesian()
Gets a parameter that specifies the axis of rotation of this solar panel in
body-fixed coordinates.
|
UnitCartesian |
DragOneDofSolarPanelPlate.getUnitAxisCartesian()
Gets a parameter that specifies the axis of rotation of this solar panel in
body-fixed coordinates.
|
UnitCartesian |
SolarRadiationBodyPlate.getUnitNormalCartesian()
Gets a parameter that specifies the direction of this plate in
body-fixed or pointing axis-fixed coordinates.
|
UnitCartesian |
DragBodyPlate.getUnitNormalCartesian()
Gets a parameter that specifies the direction of this plate in
body-fixed or pointing axis-fixed coordinates.
|
Modifier and Type | Method and Description |
---|---|
void |
ReactionWheelTorque.setSpinAxis(UnitCartesian value)
Sets the body-fixed spin axis of the reaction wheel.
|
void |
SolarRadiationOneDofSolarPanelPlate.setUnitAxisCartesian(UnitCartesian value)
Sets a parameter that specifies the axis of rotation of this solar panel in
body-fixed coordinates.
|
void |
DragOneDofSolarPanelPlate.setUnitAxisCartesian(UnitCartesian value)
Sets a parameter that specifies the axis of rotation of this solar panel in
body-fixed coordinates.
|
void |
SolarRadiationBodyPlate.setUnitNormalCartesian(UnitCartesian value)
Sets a parameter that specifies the direction of this plate in
body-fixed or pointing axis-fixed coordinates.
|
void |
DragBodyPlate.setUnitNormalCartesian(UnitCartesian value)
Sets a parameter that specifies the direction of this plate in
body-fixed or pointing axis-fixed coordinates.
|
Constructor and Description |
---|
DragBodyPlate(String plateName,
String groupName,
double referenceArea,
UnitCartesian unitNormalCartesian,
double dragCoefficient)
Initializes a new instance.
|
DragBodyPlate(String plateName,
String groupName,
double referenceArea,
UnitCartesian unitNormalCartesian,
double dragCoefficient,
Axes pointingAxes)
Initializes a new instance.
|
DragOneDofSolarPanelPlate(String plateName,
String groupName,
double referenceArea,
UnitCartesian unitAxisCartesian,
double dragCoefficient)
Initializes a new instance.
|
OffAxisTorque(Scalar thrustMagnitude,
UnitCartesian thrustAxis,
Cartesian offset,
Axes bodyAxes)
Initializes a model of the torque generated by a thruster that is not aligned with the center of mass of a vehicle.
|
ReactionWheelTorque(Scalar spinMagnitude,
UnitCartesian spinAxis,
double spinAxisInertia,
Axes bodyAxes)
Initializes the reaction wheel torque model.
|
SolarRadiationBodyPlate(String plateName,
String groupName,
double referenceArea,
UnitCartesian unitNormalCartesian,
double specularReflectivity,
double diffuseReflectivity)
Initializes a new instance.
|
SolarRadiationBodyPlate(String plateName,
String groupName,
double referenceArea,
UnitCartesian unitNormalCartesian,
double specularReflectivity,
double diffuseReflectivity,
Axes pointingAxes)
Initializes a new instance.
|
SolarRadiationOneDofSolarPanelPlate(String plateName,
String groupName,
double referenceArea,
UnitCartesian unitAxisCartesian,
double specularReflectivity,
double diffuseReflectivity)
Initializes a new instance.
|
Modifier and Type | Method and Description |
---|---|
CesiumProperty<UnitCartesian> |
BillboardGraphics.getAlignedAxis()
Gets the aligned axis, which is the unit vector, in world coordinates,
that the billboard up vector points towards.
|
Modifier and Type | Method and Description |
---|---|
void |
BillboardGraphics.setAlignedAxis(CesiumProperty<UnitCartesian> value)
Sets the aligned axis, which is the unit vector, in world coordinates,
that the billboard up vector points towards.
|
Modifier and Type | Method and Description |
---|---|
static UnitCartesian |
Polarization.getRotatedReferenceAxis(PolarizationReferenceAxis referenceAxis,
double tiltAngle)
Gets the polarization reference axis rotated by the specified tilt angle.
|
Modifier and Type | Method and Description |
---|---|
Signal |
SphericalTabularMonostaticCrossSectionScatteringCoefficient.applyScatteringCoefficient(UnitCartesian incidentDirection,
UnitCartesian reflectedDirection,
UnitQuaternion sourceToSinkRotation,
Signal inputSignal)
Applies the scattering coefficient to the input signal.
|
abstract Signal |
ScatteringCoefficient.applyScatteringCoefficient(UnitCartesian incidentDirection,
UnitCartesian reflectedDirection,
UnitQuaternion sourceToSinkRotation,
Signal inputSignal)
Applies the scattering coefficient to the input signal.
|
Signal |
ConstantCrossSectionScatteringCoefficient.applyScatteringCoefficient(UnitCartesian incidentDirection,
UnitCartesian reflectedDirection,
UnitQuaternion sourceToSinkRotation,
Signal inputSignal)
Applies the scattering coefficient to the input signal.
|
SignalCollection |
SphericalTabularMonostaticCrossSectionScatteringCoefficient.applyScatteringCoefficient(UnitCartesian incidentDirection,
UnitCartesian reflectedDirection,
UnitQuaternion sourceToSinkRotation,
Signal primaryPolarizationInputSignal,
Signal orthogonalPolarizationInputSignal)
Applies the scattering coefficient to the input signals.
|
SignalCollection |
ScatteringCoefficient.applyScatteringCoefficient(UnitCartesian incidentDirection,
UnitCartesian reflectedDirection,
UnitQuaternion sourceToSinkRotation,
Signal primaryPolarizationInputSignal,
Signal orthogonalPolarizationInputSignal)
Applies the scattering coefficient to the input signals.
|
static double |
Polarization.computeEfficiency(Polarization source,
Polarization sink,
UnitQuaternion sourceToSinkRotation,
UnitCartesian sinkToSourceDirection,
double crossPolarizationLeakage)
Computes the polarization efficiency.
|
static double |
Polarization.computeRotation(Polarization source,
Polarization sink,
UnitQuaternion sourceToSinkRotation,
UnitCartesian sinkToSourceDirection)
Computes the rotation angle between the source and sink polarizations.
|
static double |
Polarization.computeRotation(PolarizationReferenceAxis sourcePolarizationReferenceAxis,
double sourcePolarizationTiltAngle,
PolarizationReferenceAxis sinkPolarizationReferenceAxis,
UnitQuaternion sourceToSinkRotation,
UnitCartesian sinkToSourceDirection)
Computes the rotation angle between the source and sink polarizations.
|
protected ComplexCrossSectionScatteringCoefficient |
SphericalTabularMonostaticCrossSectionScatteringCoefficient.computeScatteringCoefficient(UnitCartesian monoStaticDirection)
Computes the scattering coefficient in the supplied monostatic direction.
|
protected ComplexCrossSectionScatteringCoefficient |
AnsysHfssCrossSectionScatteringCoefficient.computeScatteringCoefficient(UnitCartesian monoStaticDirection)
Computes the scattering coefficient in the supplied monostatic direction.
|
Modifier and Type | Method and Description |
---|---|
UnitCartesian |
WeightedDirection.getDirection()
Gets the direction.
|
UnitCartesian |
StaticDirection.getDirection()
Gets the direction.
|
Modifier and Type | Method and Description |
---|---|
void |
StaticDirection.setDirection(UnitCartesian value)
Sets the direction.
|
Constructor and Description |
---|
StaticDirection(UnitCartesian direction)
Initializes a new instance.
|
StaticDirection(UnitCartesian direction,
TimeIntervalCollection availability)
Initializes a new instance.
|
StaticDirection(UnitCartesian direction,
TimeIntervalCollection availability,
double weightingMetric)
Initializes a new instance.
|
StaticDirection(UnitCartesian direction,
TimeIntervalCollection availability,
Scalar weightingMetric)
Initializes a new instance.
|
WeightedDirection(UnitCartesian direction)
Initializes a new instance.
|
WeightedDirection(UnitCartesian direction,
double weightingMetric)
Initializes a new instance.
|
Modifier and Type | Method and Description |
---|---|
UnitCartesian |
AngleAxisRotation.getAxis()
Gets the unit vector representation the axis of rotation.
|
UnitCartesian |
OrthonormalBasis.getFirstAxis()
Gets the first axis.
|
UnitCartesian |
UnitCartesian.getMostOrthogonalAxis()
Gets the axis which is most orthogonal to this instance.
|
UnitCartesian |
Cartesian.getMostOrthogonalAxis()
Gets the axis which is most orthogonal to this instance.
|
UnitCartesian |
UnitCartesian.getMostParallelAxis()
Gets the axis which is most parallel to this instance.
|
UnitCartesian |
Cartesian.getMostParallelAxis()
Gets the axis which is most parallel to this instance.
|
UnitCartesian |
OrthonormalBasis.getSecondAxis()
Gets the second axis.
|
UnitCartesian |
OrthonormalBasis.getThirdAxis()
Gets the third axis.
|
static UnitCartesian |
UnitCartesian.getUndefined()
Gets a set of
UnitCartesian coordinates with values of Double.NaN . |
static UnitCartesian |
UnitCartesian.getUnitX()
Gets a set of
UnitCartesian coordinates representing the x-axis. |
static UnitCartesian |
UnitCartesian.getUnitY()
Gets a set of
UnitCartesian coordinates representing the y-axis. |
static UnitCartesian |
UnitCartesian.getUnitZ()
Gets a set of
UnitCartesian coordinates representing the z-axis. |
UnitCartesian |
UnitCartesian.invert()
Inverts this instance.
|
static UnitCartesian |
UnitCartesian.negate(UnitCartesian coordinates)
Negates the specified
UnitCartesian , yielding a new UnitCartesian . |
UnitCartesian |
Cartesian.normalize()
Forms a set of
UnitCartesian coordinates from this instance. |
UnitCartesian |
Cartesian.normalize(double[] magnitude)
Forms a set of
UnitCartesian coordinates from this instance
and returns the Magnitude (get ) of the original instance in the provided parameter. |
UnitCartesian |
UnitCartesian.rotate(ElementaryRotation rotation)
Produces a set of
UnitCartesian coordinates representing this instance, which results from rotating
the original axes used to represent this instance by the provided ElementaryRotation rotation. |
UnitCartesian |
UnitCartesian.rotate(Matrix3By3 rotation)
Produces a set of
UnitCartesian coordinates representing this instance which results from rotating
the original axes used to represent this instance by the provided Matrix3By3 rotation. |
UnitCartesian |
UnitCartesian.rotate(UnitQuaternion rotation)
Produces a set of
UnitCartesian coordinates representing this instance which results from rotating
the original axes used to represent this instance by the provided UnitQuaternion rotation. |
Modifier and Type | Method and Description |
---|---|
static Motion2<UnitCartesian,Cartesian> |
UnitCartesian.convertMotion(Motion1<Cartesian> motion,
int order)
Converts the motion given in terms of a set of
Cartesian coordinates to motion
of the corresponding set of UnitCartesian coordinates. |
Modifier and Type | Method and Description |
---|---|
static Cartesian |
UnitCartesian.add(Cartesian left,
UnitCartesian right)
Adds a specified set of
UnitCartesian coordinates to a specified set of Cartesian coordinates. |
Cartesian |
UnitCartesian.add(UnitCartesian other)
Adds the specified set of
UnitCartesian coordinates to this instance. |
static Cartesian |
UnitCartesian.add(UnitCartesian left,
Cartesian right)
Adds a specified set of
Cartesian coordinates to a specified set of UnitCartesian coordinates. |
static Cartesian |
UnitCartesian.add(UnitCartesian left,
UnitCartesian right)
Adds a specified set of
UnitCartesian coordinates to another specified set of UnitCartesian coordinates. |
double |
UnitCartesian.angleBetween(UnitCartesian other)
Determines the angle in radians between the specified set of
UnitCartesian coordinates and this instance. |
Cartesian |
UnitCartesian.cross(UnitCartesian other)
Forms the cross product of the specified set of
UnitCartesian coordinates with this instance. |
static Matrix3By3 |
Matrix3By3.crossProductEquivalentMatrix(UnitCartesian vector)
Forms a
Matrix3By3 from the input vector such that the result of the cross product of the input unit vector
with another vector is equivalent to premultiplying the other vector by the returned matrix. |
static Matrix3By3Symmetric |
Matrix3By3Symmetric.diagonalMatrix(UnitCartesian vector)
Forms a diagonal matrix from the input unit vector.
|
static Matrix3By3 |
Matrix3By3.diagonalMatrix(UnitCartesian vector)
Forms a diagonal matrix from the input unit vector.
|
static double |
UnitCartesian.dihedralAngle(UnitCartesian cartFrom,
UnitCartesian cartTo,
UnitCartesian cartAxis)
Calculates the scalar dihedral angle of the three given values.
|
static Cartesian |
UnitCartesian.divide(UnitCartesian left,
double right)
Divides a specified set of
UnitCartesian coordinates by a scalar. |
double |
UnitCartesian.dot(UnitCartesian other)
Forms the dot product of the specified set of
UnitCartesian coordinates with this instance. |
static boolean |
UnitCartesian.equals(UnitCartesian left,
UnitCartesian right)
Returns
true if the two instances are exactly equal. |
boolean |
UnitCartesian.equalsEpsilon(UnitCartesian other,
double epsilon)
Indicates whether each coordinate value of another instance of this type
is within the required tolerance of the corresponding coordinate value of this instance.
|
boolean |
UnitCartesian.equalsType(UnitCartesian other)
Indicates whether another instance of this type is exactly equal to this instance.
|
static UnitQuaternion |
AlignedConstrained.getMotion(UnitCartesian principal,
UnitCartesian reference)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static Cartesian |
UnitCartesian.multiply(double left,
UnitCartesian right)
Multiplies a scalar by a specified set of
UnitCartesian coordinates. |
static Cartesian |
UnitCartesian.multiply(UnitCartesian left,
double right)
Multiplies a specified set of
UnitCartesian coordinates by a scalar. |
static UnitCartesian |
UnitCartesian.negate(UnitCartesian coordinates)
Negates the specified
UnitCartesian , yielding a new UnitCartesian . |
static boolean |
UnitCartesian.notEquals(UnitCartesian left,
UnitCartesian right)
Returns
true if the two instances are not exactly equal. |
static Cartesian |
UnitCartesian.subtract(Cartesian left,
UnitCartesian right)
Subtracts a specified set of
UnitCartesian coordinates from a specified set of Cartesian coordinates. |
Cartesian |
UnitCartesian.subtract(UnitCartesian other)
Subtracts the specified set of
UnitCartesian coordinates from this instance. |
static Cartesian |
UnitCartesian.subtract(UnitCartesian left,
Cartesian right)
Subtracts a specified set of
Cartesian coordinates from a specified set of UnitCartesian coordinates. |
static Cartesian |
UnitCartesian.subtract(UnitCartesian left,
UnitCartesian right)
Subtracts a specified set of
UnitCartesian coordinates from another specified set of UnitCartesian coordinates. |
static Cartesian |
Cartesian.toCartesian(UnitCartesian coordinates)
Converts a set of
UnitCartesian coordinates to a set of Cartesian coordinates. |
Modifier and Type | Method and Description |
---|---|
static Motion1<Double> |
UnitCartesian.dihedralAngle(Motion2<UnitCartesian,Cartesian> motFrom,
Motion2<UnitCartesian,Cartesian> motTo,
Motion2<UnitCartesian,Cartesian> motAxis,
int order)
Calculates the scalar dihedral angle (and derivatives) of the three given values with
Cartesian derivative information.
|
static Motion1<Double> |
UnitCartesian.dihedralAngle(Motion2<UnitCartesian,Cartesian> motFrom,
Motion2<UnitCartesian,Cartesian> motTo,
Motion2<UnitCartesian,Cartesian> motAxis,
int order)
Calculates the scalar dihedral angle (and derivatives) of the three given values with
Cartesian derivative information.
|
static Motion1<Double> |
UnitCartesian.dihedralAngle(Motion2<UnitCartesian,Cartesian> motFrom,
Motion2<UnitCartesian,Cartesian> motTo,
Motion2<UnitCartesian,Cartesian> motAxis,
int order)
Calculates the scalar dihedral angle (and derivatives) of the three given values with
Cartesian derivative information.
|
static Motion2<UnitQuaternion,Cartesian> |
AlignedConstrained.getMotion(Motion2<UnitCartesian,Cartesian> principal,
Motion2<UnitCartesian,Cartesian> reference,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static Motion2<UnitQuaternion,Cartesian> |
AlignedConstrained.getMotion(Motion2<UnitCartesian,Cartesian> principal,
Motion2<UnitCartesian,Cartesian> reference,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
Constructor and Description |
---|
AngleAxisRotation(double angle,
UnitCartesian axis)
Initializes a set of
AngleAxisRotation coordinates from the provided values. |
OrthonormalBasis(UnitCartesian direction)
Initializes an orthonormal bases with the input direction.
|
OrthonormalBasis(UnitCartesian principal,
UnitCartesian reference)
Initializes an orthonormal bases with the input direction and reference.
|
UnitSpherical(UnitCartesian coordinates)
Initializes a set of
UnitSpherical coordinates from the provided set of UnitCartesian coordinates. |
Modifier and Type | Method and Description |
---|---|
UnitCartesian |
NormalizedVectorEvaluator.evaluate(JulianDate date)
Evaluates the function.
|
UnitCartesian |
AxesLinearRate.getSpinAxis()
Gets the spin axis with respect to the reference axes.
|
Modifier and Type | Method and Description |
---|---|
Motion2<UnitCartesian,Cartesian> |
NormalizedVectorEvaluator.evaluate(JulianDate date,
int order)
Evaluates the function.
|
Modifier and Type | Method and Description |
---|---|
void |
AxesLinearRate.setSpinAxis(UnitCartesian value)
Sets the spin axis with respect to the reference axes.
|
Modifier and Type | Method and Description |
---|---|
static Motion2<UnitQuaternion,Cartesian> |
AxesAlignedConstrained.computeTransformation(Motion2<UnitCartesian,Cartesian> principal,
AxisIndicator principalAxis,
Motion2<UnitCartesian,Cartesian> reference,
AxisIndicator referenceAxis,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static Motion2<UnitQuaternion,Cartesian> |
AxesAlignedConstrained.computeTransformation(Motion2<UnitCartesian,Cartesian> principal,
AxisIndicator principalAxis,
Motion2<UnitCartesian,Cartesian> reference,
AxisIndicator referenceAxis,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static Motion2<UnitQuaternion,Cartesian> |
AxesAlignedConstrained.computeTransformation(Motion2<UnitCartesian,Cartesian> principal,
Motion2<UnitCartesian,Cartesian> reference,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static Motion2<UnitQuaternion,Cartesian> |
AxesAlignedConstrained.computeTransformation(Motion2<UnitCartesian,Cartesian> principal,
Motion2<UnitCartesian,Cartesian> reference,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
Constructor and Description |
---|
AxesLinearRate(Axes referenceAxes,
JulianDate epoch,
UnitQuaternion initialRotation,
UnitCartesian spinAxis,
double initialRotationalVelocity,
double rotationalAcceleration)
Initializes a new instance with the specified parameters.
|
VectorNormalized(Axes axes,
UnitCartesian direction)
Construct a new unit vector based on a direction and an axes.
|
Modifier and Type | Method and Description |
---|---|
static UnitCartesian |
Ellipsoid.surfaceNormal(Cartographic position)
The unit Cartesian vector directed along the surface normal at the provided cartographic position.
|
static UnitCartesian |
Ellipsoid.surfaceNormal(double longitude,
double latitude)
The unit Cartesian vector directed along the surface normal at the provided cartographic longitude and latitude.
|
UnitCartesian |
Ellipsoid.surfaceNormalMotion(Cartesian surfacePosition)
Converts the position given in terms of a surface point to the surface normal vector.
|
Modifier and Type | Method and Description |
---|---|
Motion2<UnitCartesian,Cartesian> |
Ellipsoid.surfaceNormalMotion(Motion1<Cartesian> surfaceMotion,
int order)
Converts the motion given in terms of a surface point to motion of the surface normal vector.
|
Modifier and Type | Method and Description |
---|---|
double |
Ellipsoid.grazingAltitude(Cartesian position,
UnitCartesian direction)
Provides the nearest distance between the ellipsoid and the line segment
from the provided position and along the indicated direction.
|
double |
Ellipsoid.grazingAltitude(Cartographic location,
UnitCartesian direction)
Provides the nearest distance between the ellipsoid and the line segment
from the provided location and along the indicated direction.
|
Cartographic |
Ellipsoid.grazingAltitudeLocation(Cartesian position,
UnitCartesian direction)
Provides the point on the line segment from the provided position and along
the indicated direction which is nearest to the ellipsoid.
|
Cartographic |
Ellipsoid.grazingAltitudeLocation(Cartographic location,
UnitCartesian direction)
Provides the point on the line segment from the provided location and along
the indicated direction which is nearest to the ellipsoid.
|
Cartesian[] |
Ellipsoid.grazingAngleLocations(Cartesian point,
UnitCartesian direction)
Provides the two points on the limb of the ellipsoid with the smallest and largest apparent
angular separation with respect to the indicated direction, as viewed from the provided
point.
|
double[] |
Ellipsoid.grazingAngles(Cartesian point,
UnitCartesian direction)
Provides the angles from the indicated direction to the two points on the limb
of the ellipsoid with the smallest and largest apparent angular separation, as
viewed from the provided point.
|
double[] |
Ellipsoid.intersections(Cartesian position,
UnitCartesian direction)
Computes the intersection of the line of sight vector emanating from a given external point with the ellipsoid.
|
Cartesian[] |
Ellipsoid.tangents(Cartesian position,
UnitCartesian normal)
From the indicated position, provides the points of tangency on an ellipsoid which also lie in
the plane defined by the indicated normal.
|
Cartesian[] |
Ellipsoid.tangents(Cartesian position,
UnitCartesian axis,
double halfAngle)
From the indicated position, provides the points of tangency on an ellipsoid which also lie on an
axisymmetric cone defined by the indicated axis and half angle.
|
boolean |
Ellipsoid.tangentTotal(Cartesian sensorPosition,
UnitCartesian sensorHeading,
double halfAngle)
Determines whether the cone emanating from sensor at the given position and with the given
heading and half angle lies completely tangent to the Ellipsoid.
|
Modifier and Type | Method and Description |
---|---|
UnitCartesian |
Camera.getDirection()
Gets the direction of the camera in
Axes . |
UnitCartesian |
Camera.getUpVector()
Gets the up direction of the camera in
Axes . |
Modifier and Type | Method and Description |
---|---|
BaseCollection<UnitCartesian> |
ProjectedRaster.getDirections()
Gets the direction vectors in the projection's reference frame that define the
Projection's frustum. |
Modifier and Type | Method and Description |
---|---|
void |
Camera.setDirection(UnitCartesian value)
Sets the direction of the camera in
Axes . |
void |
Camera.setUpVector(UnitCartesian value)
Sets the up direction of the camera in
Axes . |
void |
Camera.view(Axes axes,
Point cameraPosition,
Point referencePoint,
UnitCartesian upAxis)
Views from a point to a point.
|
void |
Camera.viewDirection(Axes axes,
Point cameraPosition,
Vector direction,
UnitCartesian upAxis)
Views from a point to a direction.
|
void |
Camera.viewOffset(Axes axes,
Point referencePoint,
Cartesian offset,
UnitCartesian upAxis)
Sets the camera's reference point - the point the camera is looking at.
|
void |
Camera.viewOffsetDirection(Axes axes,
Point referencePoint,
Vector direction,
UnitCartesian upAxis)
Sets the camera's reference point - the point the camera is looking at.
|
Modifier and Type | Method and Description |
---|---|
UnitCartesian |
TerrainProvider.getNormal(double longitude,
double latitude)
Get the normal vector to the terrain surface at the specified location.
|
Modifier and Type | Method and Description |
---|---|
static Cartographic |
TerrainAlongLine.computeTerrainIntersection(Cartesian cartesian,
Cartographic cartographic,
UnitCartesian direction,
double granularity,
double maximumDistance,
TerrainProvider terrainProvider)
Computes the location of the first intersection with terrain from the provided location along the indicated direction.
|
static Cartographic |
TerrainAlongLine.computeTerrainIntersection(Cartesian cartesian,
Cartographic cartographic,
UnitCartesian direction,
double granularity,
double maximumDistance,
TerrainProvider terrainProvider,
double minimumTerrainHeight,
double maximumTerrainHeight)
Computes the location of the first intersection with terrain from the provided location along the indicated direction.
|
static Cartographic |
TerrainAlongLine.computeTerrainIntersection(Cartesian cartesian,
UnitCartesian direction,
double granularity,
double maximumDistance,
TerrainProvider terrainProvider)
Computes the location of the first intersection with terrain from the provided location along the indicated direction.
|
static Cartographic |
TerrainAlongLine.computeTerrainIntersection(Cartesian cartesian,
UnitCartesian direction,
double granularity,
double maximumDistance,
TerrainProvider terrainProvider,
double minimumTerrainHeight,
double maximumTerrainHeight)
Computes the location of the first intersection with terrain from the provided location along the indicated direction.
|
static Cartographic |
TerrainAlongLine.computeTerrainIntersection(Cartographic cartographic,
UnitCartesian direction,
double granularity,
double maximumDistance,
TerrainProvider terrainProvider)
Computes the location of the first intersection with terrain from the provided location along the indicated direction.
|
static Cartographic |
TerrainAlongLine.computeTerrainIntersection(Cartographic cartographic,
UnitCartesian direction,
double granularity,
double maximumDistance,
TerrainProvider terrainProvider,
double minimumTerrainHeight,
double maximumTerrainHeight)
Computes the location of the first intersection with terrain from the provided location along the indicated direction.
|