A B C D E F G H I J K L M N O P Q R S T U V W X Y Z Α Ε Μ Π Σ Φ   

A

a0 - Static variable in class org.jscience.physics.amount.Constants
Holds the Bohr radius (α/(4π·Rinf))
abs() - Method in class org.jscience.mathematics.number.Float64
Returns the absolute value of this number.
abs() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the absolute value of this floating point number.
abs() - Method in class org.jscience.mathematics.number.Integer64
Returns the absolute value of this number.
abs() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the absolute value of this large integer.
abs() - Method in class org.jscience.mathematics.number.Rational
Returns the absolute value of this rational number.
abs() - Method in class org.jscience.mathematics.number.Real
Returns the absolute value of this real number.
abs() - Method in class org.jscience.physics.amount.Amount
Returns the absolute value of this measure.
absolute() - Method in class org.opengis.referencing.cs.AxisDirection
 
Acceleration - Interface in javax.measure.quantity
This interface represents the rate of change of velocity with respect to time.
AddConverter - Class in javax.measure.converter
This class represents a converter adding a constant offset (approximated as a double) to numeric values.
AddConverter(double) - Constructor for class javax.measure.converter.AddConverter
Creates an add converter with the specified offset.
adjoint() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
adjoint() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
adjoint() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
adjoint() - Method in class org.jscience.mathematics.vector.Matrix
Returns the adjoint of this matrix.
adjoint() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
AffineCS - Interface in org.opengis.referencing.cs
 
alias(Unit<?>, String) - Method in class javax.measure.unit.UnitFormat
Attaches a system-wide alias to this unit.
alias(Unit<?>, String) - Method in class javax.measure.unit.UnitFormat.DefaultFormat
 
ALIAS_KEY - Static variable in interface org.opengis.referencing.IdentifiedObject
 
alternate(String) - Method in class javax.measure.unit.Unit
Returns a unit equivalent to this unit but used in expressions to distinguish between quantities of a different nature but of the same dimensions.
AlternateUnit<Q extends Quantity> - Class in javax.measure.unit
This class represents the units used in expressions to distinguish between quantities of a different nature but of the same dimensions.
Altitude - Class in org.jscience.geography.coordinates
This class represents the Mean-Sea-Level vertical altitude (MSL).
Amount<Q extends Quantity> - Class in org.jscience.physics.amount
This class represents a determinate or estimated amount for which operations such as addition, subtraction, multiplication and division can be performed (it implements the Field interface).
AMOUNT_OF_SUBSTANCE - Static variable in class javax.measure.unit.Dimension
Holds amount of substance dimension (N).
AmountException - Exception in org.jscience.physics.amount
Signals that an illegal measure operation has been performed.
AmountException() - Constructor for exception org.jscience.physics.amount.AmountException
Constructs a measure exception with no detail message.
AmountException(String) - Constructor for exception org.jscience.physics.amount.AmountException
Constructs a measure exception with the specified message.
AmountFormat - Class in org.jscience.physics.amount
This class provides the interface for formatting and parsing measures instances.
AmountFormat() - Constructor for class org.jscience.physics.amount.AmountFormat
Default constructor.
AmountOfSubstance - Interface in javax.measure.quantity
This interface represents the number of elementary entities (molecules, for example) of a substance.
AMPERE - Static variable in class javax.measure.unit.SI
The base unit for electric current quantities (A).
amu - Static variable in class org.jscience.physics.amount.Constants
Holds the unified atomic mass unit (0.001 kg/mol)/N
Angle - Interface in javax.measure.quantity
This interface represents the figure formed by two lines diverging from a common point.
ANGSTROM - Static variable in class javax.measure.unit.NonSI
A unit of length equal to 1E-10 m (standard name Å).
AngularAcceleration - Interface in javax.measure.quantity
This interface represents the rate of change of angular velocity with respect to time.
AngularVelocity - Interface in javax.measure.quantity
This interface represents the rate of change of angular displacement with respect to time.
approximates(Real) - Method in class org.jscience.mathematics.number.Real
Indicates if this real approximates the one specified.
approximates(Amount) - Method in class org.jscience.physics.amount.Amount
Indicates if this measure approximates that measure.
ARE - Static variable in class javax.measure.unit.NonSI
A unit of area equal to 100 m² (standard name a).
Area - Interface in javax.measure.quantity
This interface represents the extent of a planar region or of the surface of a solid measured in square units.
argument() - Method in class org.jscience.mathematics.number.Complex
Returns the argument of this complex number.
ASTRONOMICAL_UNIT - Static variable in class javax.measure.unit.NonSI
A unit of length equal to the average distance from the center of the Earth to the center of the Sun (standard name ua).
asType(Class<T>) - Method in class javax.measure.unit.Unit
Casts this unit to a parameterized unit of specified nature or throw a ClassCastException if the dimension of the specified quantity and this unit's dimension do not match.
ATMOSPHERE - Static variable in class javax.measure.unit.NonSI
A unit of pressure equal to the average pressure of the Earth's atmosphere at sea level (standard name atm).
ATOM - Static variable in class javax.measure.unit.NonSI
A unit of amount of substance equals to one atom (standard name atom).
ATOMIC_MASS - Static variable in class javax.measure.unit.NonSI
A unit of mass equal to 1/12 the mass of the carbon-12 atom (standard name u).
ATTO(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-18
AUD - Static variable in class org.jscience.economics.money.Currency
The Australian Dollar currency unit.
AUTHORITY_KEY - Static variable in interface org.opengis.metadata.Identifier
 
AxisDirection - Class in org.opengis.referencing.cs
 
AxisDirection(String) - Constructor for class org.opengis.referencing.cs.AxisDirection
 

B

BAR - Static variable in class javax.measure.unit.NonSI
A unit of pressure equal to 100 kPa (standard name bar).
BASE_UNIT - Static variable in interface org.jscience.economics.money.Money
Holds the base unit for money quantities (symbol "¤", currency symbol).
BaseUnit<Q extends Quantity> - Class in javax.measure.unit
This class represents the building blocks on top of which all others units are created.
BaseUnit(String) - Constructor for class javax.measure.unit.BaseUnit
Creates a base unit having the specified symbol.
BECQUEREL - Static variable in class javax.measure.unit.SI
The derived unit for activity of a radionuclide (Bq).
BIT - Static variable in class javax.measure.unit.SI
The unit for binary information (bit).
bitLength() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the minimal number of bits to represent this large integer in the minimal two's-complement (sign excluded).
BOTTOM - Static variable in class org.opengis.referencing.cs.AxisDirection
Deprecated. 
BYTE - Static variable in class javax.measure.unit.NonSI
A unit of data amount equal to 8 SI.BIT (BinarY TErm, standard name byte).
byteValue() - Method in class org.jscience.mathematics.number.Number
Returns the value of this number as a byte.

C

C - Static variable in class javax.measure.unit.NonSI
A unit of velocity relative to the speed of light (standard name c).
c - Static variable in class org.jscience.physics.amount.Constants
Holds the speed of light in vacuum (exact).
c_square - Static variable in class org.jscience.physics.amount.Constants
Holds Constants.c².
CAD - Static variable in class org.jscience.economics.money.Currency
The Canadian Dollar currency unit.
CANDELA - Static variable in class javax.measure.unit.SI
The base unit for luminous intensity quantities (cd).
CartesianCS - Interface in org.opengis.referencing.cs
 
CatalyticActivity - Interface in javax.measure.quantity
This interface represents a catalytic activity.
CELSIUS - Static variable in class javax.measure.unit.SI
The derived unit for Celsius temperature ().
CENTI(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-2
CENTIMETER - Static variable in class javax.measure.unit.SI
Equivalent to SI.CENTIMETRE.
CENTIMETRE - Static variable in class javax.measure.unit.SI
Equivalent to CENTI(METRE).
CENTIRADIAN - Static variable in class javax.measure.unit.NonSI
A unit of angle equal to 0.01 SI.RADIAN (standard name centiradian).
Citation - Interface in org.opengis.metadata.citation
 
clone() - Method in class org.jscience.geography.coordinates.Coordinates
OpenGIS® - Makes an exact copy of this coordinate.
clone() - Method in interface org.opengis.spatialschema.geometry.DirectPosition
 
clone() - Method in interface org.opengis.util.Cloneable
 
Cloneable - Interface in org.opengis.util
 
CNY - Static variable in class org.jscience.economics.money.Currency
The China Yan currency.
CODE_KEY - Static variable in interface org.opengis.metadata.Identifier
 
CodeList - Class in org.opengis.util
 
CodeList(String, Collection) - Constructor for class org.opengis.util.CodeList
 
cofactor(int, int) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
cofactor(int, int) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
cofactor(int, int) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
cofactor(int, int) - Method in class org.jscience.mathematics.vector.Matrix
Returns the cofactor of an element in this matrix.
cofactor(int, int) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
COLUMN_NEGATIVE - Static variable in class org.opengis.referencing.cs.AxisDirection
 
COLUMN_POSITIVE - Static variable in class org.opengis.referencing.cs.AxisDirection
 
compareTo(Measurable<Q>) - Method in class javax.measure.Measure
Compares this measure to the specified measurable quantity.
compareTo(Measurable<Length>) - Method in class org.jscience.geography.coordinates.Altitude
 
compareTo(Measurable<Length>) - Method in class org.jscience.geography.coordinates.Height
 
compareTo(Measurable<Duration>) - Method in class org.jscience.geography.coordinates.Time
 
compareTo(Term) - Method in class org.jscience.mathematics.function.Term
Compares this term with the one specified for order.
compareTo(Complex) - Method in class org.jscience.mathematics.number.Complex
Compares two complex numbers, the real components are compared first, then if equal, the imaginary components.
compareTo(double) - Method in class org.jscience.mathematics.number.Float64
Compares this number with the specified value for order.
compareTo(Float64) - Method in class org.jscience.mathematics.number.Float64
 
compareTo(FloatingPoint) - Method in class org.jscience.mathematics.number.FloatingPoint
Compares two floating point number numerically.
compareTo(long) - Method in class org.jscience.mathematics.number.Integer64
Compares this number with the specified value for order.
compareTo(Integer64) - Method in class org.jscience.mathematics.number.Integer64
 
compareTo(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Compares two large integers numerically.
compareTo(long) - Method in class org.jscience.mathematics.number.LargeInteger
Compares this large integer to the specified long value.
compareTo(ModuloInteger) - Method in class org.jscience.mathematics.number.ModuloInteger
 
compareTo(T) - Method in class org.jscience.mathematics.number.Number
Compares this number with the specified number for order.
compareTo(Rational) - Method in class org.jscience.mathematics.number.Rational
Compares two rational number numerically.
compareTo(Real) - Method in class org.jscience.mathematics.number.Real
Compares two real numbers numerically.
compareTo(Measurable<Q>) - Method in class org.jscience.physics.amount.Amount
Compares this measure with the specified measurable object.
compareTo(Object) - Method in class org.opengis.util.CodeList
 
Complex - Class in org.jscience.mathematics.number
This class represents an immutable complex number.
ComplexMatrix - Class in org.jscience.mathematics.vector
This class represents an optimized matrix implementation for complex numbers.
ComplexVector - Class in org.jscience.mathematics.vector
This class represents an optimized vector implementation for complex numbers elements.
compose(Function<Z, X>) - Method in class org.jscience.mathematics.function.Function
Returns the composition of this function with the one specified.
compose(Polynomial<R>) - Method in class org.jscience.mathematics.function.Polynomial
Returns the composition of this polynomial with the one specified.
compose(Function<Z, R>) - Method in class org.jscience.mathematics.function.Polynomial
 
compound(Unit<Q>) - Method in class javax.measure.unit.Unit
Returns the combination of this unit with the specified sub-unit.
CompoundCoordinates<C1 extends Coordinates<?>,C2 extends Coordinates<?>> - Class in org.jscience.geography.coordinates
This class represents a coordinates made up by combining two coordinates objects together.
CompoundCRS<C1 extends Coordinates<?>,C2 extends Coordinates<?>> - Class in org.jscience.geography.coordinates.crs
This class represents a coordinate reference system combining two or more distinct reference systems.
CompoundCRS(CoordinateReferenceSystem<C1>, CoordinateReferenceSystem<C2>) - Constructor for class org.jscience.geography.coordinates.crs.CompoundCRS
 
CompoundUnit<Q extends Quantity> - Class in javax.measure.unit
This class represents the multi-radix units (such as "hour:min:sec").
COMPUTER_POINT - Static variable in class javax.measure.unit.NonSI
Equivalent NonSI.PIXEL
concatenate(UnitConverter) - Method in class javax.measure.converter.AddConverter
 
concatenate(UnitConverter) - Method in class javax.measure.converter.MultiplyConverter
 
concatenate(UnitConverter) - Method in class javax.measure.converter.RationalConverter
 
concatenate(UnitConverter) - Method in class javax.measure.converter.UnitConverter
Concatenates this converter with another converter.
conjugate() - Method in class org.jscience.mathematics.number.Complex
Returns the conjugate of this complex number.
Constant<R extends Ring<R>> - Class in org.jscience.mathematics.function
This class represents a constant function (polynomial of degree 0).
Constants - Class in org.jscience.physics.amount
This class provides most accurate physical constants measurement; the more accurate the constants, the higher the precision of the calculations making use of these constants.
ConversionException - Exception in javax.measure.converter
Signals that a problem of some sort has occurred either when creating a converter between two units or during the conversion itself.
ConversionException() - Constructor for exception javax.measure.converter.ConversionException
Constructs a ConversionException with no detail message.
ConversionException(String) - Constructor for exception javax.measure.converter.ConversionException
Constructs a ConversionException with the specified detail message.
convert(double) - Method in class javax.measure.converter.AddConverter
 
convert(double) - Method in class javax.measure.converter.LogConverter
 
convert(double) - Method in class javax.measure.converter.MultiplyConverter
 
convert(double) - Method in class javax.measure.converter.RationalConverter
 
convert(double) - Method in class javax.measure.converter.UnitConverter
Converts a double value.
convert(S) - Method in interface org.jscience.geography.coordinates.crs.CoordinatesConverter
Converts the specified coordinates.
CoordinateReferenceSystem<C extends Coordinates<?>> - Class in org.jscience.geography.coordinates.crs
This class represents an arbitrary system of reference for which coordinates of same significance can be stated.
CoordinateReferenceSystem() - Constructor for class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
 
CoordinateReferenceSystem - Interface in org.opengis.referencing.crs
 
CoordinateReferenceSystem.AbsolutePosition - Class in org.jscience.geography.coordinates.crs
This class represents an absolute position (can be be extended)
CoordinateReferenceSystem.AbsolutePosition() - Constructor for class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem.AbsolutePosition
 
Coordinates<R extends CoordinateReferenceSystem<?>> - Class in org.jscience.geography.coordinates
This class designates the position that a point occupies in a given n-dimensional reference frame or system.
Coordinates() - Constructor for class org.jscience.geography.coordinates.Coordinates
Default constructor.
CoordinatesConverter<S extends Coordinates<?>,T extends Coordinates<?>> - Interface in org.jscience.geography.coordinates.crs
This interface represents a converter between coordinates.
coordinatesOf(CoordinateReferenceSystem.AbsolutePosition) - Method in class org.jscience.geography.coordinates.crs.CompoundCRS
 
coordinatesOf(CoordinateReferenceSystem.AbsolutePosition) - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
Returns the coordinates in this reference system of the specified absolute position.
CoordinateSystem - Interface in org.opengis.referencing.cs
 
CoordinateSystemAxis - Interface in org.opengis.referencing.cs
Definition of a coordinate system axis.
copy() - Method in class org.jscience.geography.coordinates.Altitude
 
copy() - Method in class org.jscience.geography.coordinates.CompoundCoordinates
 
copy() - Method in class org.jscience.geography.coordinates.Coordinates
Returns a copy of these coordinates allocated by the calling thread (possibly on the stack).
copy() - Method in class org.jscience.geography.coordinates.Height
 
copy() - Method in class org.jscience.geography.coordinates.LatLong
 
copy() - Method in class org.jscience.geography.coordinates.Time
 
copy() - Method in class org.jscience.geography.coordinates.UTM
 
copy() - Method in class org.jscience.geography.coordinates.XYZ
 
copy() - Method in class org.jscience.mathematics.function.Polynomial
Returns a copy of this polynomial allocated by the calling thread (possibly on the stack).
copy() - Method in class org.jscience.mathematics.function.RationalFunction
Returns a copy of this rational function.
copy() - Method in class org.jscience.mathematics.function.Term
Returns an entierely new copy of this term allocated by the calling thread (possibly on the stack).
copy() - Method in class org.jscience.mathematics.number.Complex
 
copy() - Method in class org.jscience.mathematics.number.Float64
 
copy() - Method in class org.jscience.mathematics.number.FloatingPoint
 
copy() - Method in class org.jscience.mathematics.number.Integer64
 
copy() - Method in class org.jscience.mathematics.number.LargeInteger
 
copy() - Method in class org.jscience.mathematics.number.ModuloInteger
 
copy() - Method in class org.jscience.mathematics.number.Number
Returns a copy of this number allocated by the calling thread (possibly on the stack).
copy() - Method in class org.jscience.mathematics.number.Rational
 
copy() - Method in class org.jscience.mathematics.number.Real
 
copy() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
copy() - Method in class org.jscience.mathematics.vector.ComplexVector
 
copy() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
copy() - Method in class org.jscience.mathematics.vector.DenseVector
 
copy() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
copy() - Method in class org.jscience.mathematics.vector.Float64Vector
 
copy() - Method in class org.jscience.mathematics.vector.Matrix
Returns a copy of this matrix allocated by the calling thread (possibly on the stack).
copy() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
copy() - Method in class org.jscience.mathematics.vector.SparseVector
 
copy() - Method in class org.jscience.mathematics.vector.Vector
Returns a copy of this vector allocated by the calling thread (possibly on the stack).
copy() - Method in class org.jscience.physics.amount.Amount
 
COULOMB - Static variable in class javax.measure.unit.SI
The derived unit for electric charge, quantity of electricity (C).
cross(Vector<Float64>) - Method in class org.jscience.mathematics.vector.Float64Vector
 
cross(Vector<F>) - Method in class org.jscience.mathematics.vector.Vector
Returns the cross product of two 3-dimensional vectors.
CRS - Static variable in class org.jscience.geography.coordinates.Altitude
Holds the coordinate reference system for all instances of this class.
CRS - Static variable in class org.jscience.geography.coordinates.Height
Holds the coordinate reference system for all instances of this class.
CRS - Static variable in class org.jscience.geography.coordinates.LatLong
Holds the coordinate reference system for all instances of this class.
CRS - Static variable in class org.jscience.geography.coordinates.Time
Holds the coordinate reference system for all instances of this class.
CRS - Static variable in class org.jscience.geography.coordinates.UTM
Holds the coordinate reference system for all instances of this class.
CRS - Static variable in class org.jscience.geography.coordinates.XYZ
Holds the coordinate reference system for all instances of this class.
CUBIC_INCH - Static variable in class javax.measure.unit.NonSI
A unit of volume equal to one cubic inch (in³).
CUBIC_METRE - Static variable in class javax.measure.unit.SI
The metric unit for volume quantities ().
CURIE - Static variable in class javax.measure.unit.NonSI
A unit of radioctive activity equal to the activity of a gram of radium (standard name Ci).
Currency - Class in org.jscience.economics.money
This class represents a currency Unit.
Currency(String) - Constructor for class org.jscience.economics.money.Currency
Creates the currency unit for the given currency code.
current() - Static method in class org.jscience.physics.model.PhysicalModel
Returns the current physical model (default: instance of StandardModel).
CylindricalCS - Interface in org.opengis.referencing.cs
 

D

DataAmount - Interface in javax.measure.quantity
This interface represents a measure of data amount.
DataRate - Interface in javax.measure.quantity
This interface represents the speed of data-transmission.
DAY - Static variable in class javax.measure.unit.NonSI
A unit of duration equal to 24 NonSI.HOUR (standard name d).
DAY_SIDEREAL - Static variable in class javax.measure.unit.NonSI
A unit of duration equal to the time required for a complete rotation of the earth in reference to any star or to the vernal equinox at the meridian, equal to 23 hours, 56 minutes, 4.09 seconds (standard name day_sidereal).
DECI(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-1
DECIBEL - Static variable in class javax.measure.unit.NonSI
A logarithmic unit used to describe a ratio (standard name dB).
DecimalMeasure<Q extends Quantity> - Class in javax.measure
This class represents a measure whose value is an arbitrary-precision decimal number.
DecimalMeasure(BigDecimal, Unit<Q>) - Constructor for class javax.measure.DecimalMeasure
Creates a decimal measure for the specified number stated in the specified unit.
DEGREE_ANGLE - Static variable in class javax.measure.unit.NonSI
A unit of angle equal to 1/360 NonSI.REVOLUTION (standard name °).
DEKA(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 101
DenseMatrix<F extends Field<F>> - Class in org.jscience.mathematics.vector
This class represents a matrix made of dense vectors (as rows).
DenseVector<F extends Field<F>> - Class in org.jscience.mathematics.vector
This class represents a dense vector.
DerivedUnit<Q extends Quantity> - Class in javax.measure.unit
This class identifies the units created by combining or transforming other units.
DerivedUnit() - Constructor for class javax.measure.unit.DerivedUnit
Default constructor.
determinant() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
determinant() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
determinant() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
determinant() - Method in class org.jscience.mathematics.vector.LUDecomposition
Returns the determinant of the Matrix having this decomposition.
determinant() - Method in class org.jscience.mathematics.vector.Matrix
Returns the determinant of this matrix.
determinant() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
differentiate(Variable<X>) - Method in class org.jscience.mathematics.function.Function
Returns the first derivative of this function with respect to the specified variable.
differentiate(Variable<R>) - Method in class org.jscience.mathematics.function.Polynomial
 
differentiate(Variable<F>) - Method in class org.jscience.mathematics.function.RationalFunction
 
digitLength() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the minimal number of decimal digits necessary to represent this large integer (sign excluded).
Dimension - Class in javax.measure.unit
This class represents the dimension of an unit.
Dimension(char) - Constructor for class javax.measure.unit.Dimension
Creates a new dimension associated to the specified symbol.
Dimension.Model - Interface in javax.measure.unit
This interface represents the mapping between base units and dimensions.
DimensionException - Exception in org.jscience.mathematics.vector
Signals that an operation is performed upon vectors or matrices whose dimensions disagree.
DimensionException() - Constructor for exception org.jscience.mathematics.vector.DimensionException
Constructs a dimension exception with no detail message.
DimensionException(String) - Constructor for exception org.jscience.mathematics.vector.DimensionException
Constructs a dimension exception with the specified message.
Dimensionless - Interface in javax.measure.quantity
This interface represents a dimensionless quantity.
DirectPosition - Interface in org.opengis.spatialschema.geometry
 
DiscreteFunction<X,Y> - Class in org.jscience.mathematics.function
This class represents a function defined from a mapping betweem two sets (points and values).
DiscreteFunction(SortedMap<X, Y>, Interpolator<X, Y>, Variable<X>) - Constructor for class org.jscience.mathematics.function.DiscreteFunction
Creates the discrete function for the specified point-value entries.
DISPLAY_DOWN - Static variable in class org.opengis.referencing.cs.AxisDirection
 
DISPLAY_LEFT - Static variable in class org.opengis.referencing.cs.AxisDirection
 
DISPLAY_RIGHT - Static variable in class org.opengis.referencing.cs.AxisDirection
 
DISPLAY_UP - Static variable in class org.opengis.referencing.cs.AxisDirection
 
divide(Dimension) - Method in class javax.measure.unit.Dimension
Returns the quotient of this dimension with the one specified.
divide(long) - Method in class javax.measure.unit.Unit
Returns the result of dividing this unit by an exact divisor.
divide(double) - Method in class javax.measure.unit.Unit
Returns the result of dividing this unit by an approximate divisor.
divide(Unit<?>) - Method in class javax.measure.unit.Unit
Returns the quotient of this unit with the one specified.
divide(Function<X, Y>) - Method in class org.jscience.mathematics.function.Function
Returns the quotient of this function with the one specified.
divide(RationalFunction<F>) - Method in class org.jscience.mathematics.function.RationalFunction
Returns the quotient of two rational functions.
divide(Function<F, F>) - Method in class org.jscience.mathematics.function.RationalFunction
 
divide(Term) - Method in class org.jscience.mathematics.function.Term
Return the division of this term with the one specified.
divide(double) - Method in class org.jscience.mathematics.number.Complex
Returns this complex divided by the specified factor.
divide(Complex) - Method in class org.jscience.mathematics.number.Complex
Returns this complex divided by the specified complex.
divide(Float64) - Method in class org.jscience.mathematics.number.Float64
Returns this number divided by the one specified.
divide(double) - Method in class org.jscience.mathematics.number.Float64
Returns this number divided by the specified value.
divide(FloatingPoint) - Method in class org.jscience.mathematics.number.FloatingPoint
Returns this floating point number divided by the one specified.
divide(Integer64) - Method in class org.jscience.mathematics.number.Integer64
Returns this number divided by the one specified.
divide(long) - Method in class org.jscience.mathematics.number.Integer64
Returns this number divided by the specified value.
divide(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Returns this large integer divided by the one specified (integer division).
divide(int) - Method in class org.jscience.mathematics.number.LargeInteger
Returns this large integer divided by the specified int divisor.
divide(Rational) - Method in class org.jscience.mathematics.number.Rational
Returns this rational number divided by the one specified.
divide(long) - Method in class org.jscience.mathematics.number.Real
Returns this real number divided by the specified int divisor.
divide(Real) - Method in class org.jscience.mathematics.number.Real
Returns this real number divided by the one specified.
divide(Matrix<F>) - Method in class org.jscience.mathematics.vector.Matrix
Returns this matrix divided by the one specified.
divide(long) - Method in class org.jscience.physics.amount.Amount
Returns this measure divided by the specified exact divisor (dimensionless).
divide(double) - Method in class org.jscience.physics.amount.Amount
Returns this measure divided by the specified approximate divisor (dimensionless).
divide(Amount) - Method in class org.jscience.physics.amount.Amount
Returns this measure divided by the one specified.
doubleValue(Unit<Q>) - Method in class javax.measure.DecimalMeasure
 
doubleValue(Unit<Q>) - Method in interface javax.measure.Measurable
Returns the value of this measurable stated in the specified unit as a double.
doubleValue(Unit<Q>) - Method in class javax.measure.Measure
Returns the value of this measure stated in the specified unit as a double.
doubleValue(Unit<Q>) - Method in class javax.measure.VectorMeasure
Returns the norm of this measurement vector stated in the specified unit.
doubleValue(Unit<Length>) - Method in class org.jscience.geography.coordinates.Altitude
 
doubleValue(Unit<Length>) - Method in class org.jscience.geography.coordinates.Height
 
doubleValue(Unit<Duration>) - Method in class org.jscience.geography.coordinates.Time
 
doubleValue() - Method in class org.jscience.mathematics.number.Complex
Returns the real component of this Complex number as a double.
doubleValue() - Method in class org.jscience.mathematics.number.Float64
 
doubleValue() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the value of this floating point number as a double.
doubleValue() - Method in class org.jscience.mathematics.number.Integer64
 
doubleValue() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the value of this large integer as a double.
doubleValue() - Method in class org.jscience.mathematics.number.ModuloInteger
 
doubleValue() - Method in class org.jscience.mathematics.number.Number
Returns the value of this number as a double.
doubleValue() - Method in class org.jscience.mathematics.number.Rational
Returns the value of this rational number as a double.
doubleValue() - Method in class org.jscience.mathematics.number.Real
Returns the value of this real number as a double.
doubleValue(Unit<Q>) - Method in class org.jscience.physics.amount.Amount
 
DOWN - Static variable in class org.opengis.referencing.cs.AxisDirection
 
Duration - Interface in javax.measure.quantity
This interface represents a period of existence or persistence.
DynamicViscosity - Interface in javax.measure.quantity
This interface represents the dynamic viscosity.
DYNE - Static variable in class javax.measure.unit.NonSI
A unit of force equal to 1E-5 N (standard name dyn).

E

E - Static variable in class javax.measure.unit.NonSI
A unit of electric charge equal to the charge on one electron (standard name e).
e - Static variable in class org.jscience.physics.amount.Constants
Holds the elementary charge (positron charge).
EAST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
EAST_NORTH_EAST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
EAST_SOUTH_EAST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
EASTING_NORTHING_CS - Static variable in class org.jscience.geography.coordinates.crs.ProjectedCRS
Holds the Easting/Northing coordinate system.
eastingValue(Unit<Length>) - Method in class org.jscience.geography.coordinates.UTM
Returns the projected distance of the position from the central meridian.
Eh - Static variable in class org.jscience.physics.amount.Constants
Holds the Hartree energy (2Rinf·h·c)
ELECTRIC_CURRENT - Static variable in class javax.measure.unit.Dimension
Holds electric current dimension (I).
ElectricCapacitance - Interface in javax.measure.quantity
This interface represents an electric capacitance.
ElectricCharge - Interface in javax.measure.quantity
This interface represents an electric charge.
ElectricConductance - Interface in javax.measure.quantity
This interface represents an electric conductance.
ElectricCurrent - Interface in javax.measure.quantity
This interface represents the amount of electric charge flowing past a specified circuit point per unit time.
ElectricInductance - Interface in javax.measure.quantity
This interface represents an electric inductance.
ElectricPotential - Interface in javax.measure.quantity
This interface represents an electric potential or electromotive force.
ElectricResistance - Interface in javax.measure.quantity
This interface represents an electric resistance.
ELECTRON_MASS - Static variable in class javax.measure.unit.NonSI
A unit of mass equal to the mass of the electron (standard name me).
ELECTRON_VOLT - Static variable in class javax.measure.unit.NonSI
A unit of energy equal to one electron-volt (standard name eV, also recognized keV, MeV, GeV).
EllipsoidalCS - Interface in org.opengis.referencing.cs
 
endTime(int) - Static method in class org.jscience.JScience
Ends measuring time and display the execution time per iteration.
Energy - Interface in javax.measure.quantity
This interface represents the capacity of a physical system to do work.
equals(Object) - Method in class javax.measure.converter.UnitConverter
Indicates whether this converter is considered the same as the converter specified.
equals(Object) - Method in class javax.measure.Measure
Compares this measure against the specified object for strict equality (same unit and amount).
equals(Object) - Method in class javax.measure.unit.AlternateUnit
Indicates if this alternate unit is considered equals to the specified object (both are alternate units with equal symbol, equal base units and equal converter to base units).
equals(Object) - Method in class javax.measure.unit.BaseUnit
Indicates if this base unit is considered equals to the specified object (both are base units with equal symbol, standard dimension and standard transform).
equals(Object) - Method in class javax.measure.unit.CompoundUnit
Indicates if this compound unit is considered equals to the specified object (both are compound units with same composing units in the same order).
equals(Object) - Method in class javax.measure.unit.Dimension
Indicates if the specified dimension is equals to the one specified.
equals(Object) - Method in class javax.measure.unit.ProductUnit
Indicates if this product unit is considered equals to the specified object.
equals(Object) - Method in class javax.measure.unit.TransformedUnit
Indicates if this transformed unit is considered equals to the specified object (both are transformed units with equal parent unit and equal converter to parent unit).
equals(Object) - Method in class javax.measure.unit.Unit
Indicates if the specified unit can be considered equals to the one specified.
equals(Object) - Method in class org.jscience.economics.money.Currency
 
equals(Object) - Method in class org.jscience.mathematics.function.Function
Indicates if this function is equals to the specified object.
equals(Object) - Method in class org.jscience.mathematics.function.Polynomial
 
equals(Object) - Method in class org.jscience.mathematics.function.RationalFunction
 
equals(Object) - Method in class org.jscience.mathematics.function.Term
Indicates if this term is equal to the object specified.
equals(Complex, double) - Method in class org.jscience.mathematics.number.Complex
Indicates if two complexes are "sufficiently" alike to be considered equal.
equals(Object) - Method in class org.jscience.mathematics.number.Complex
Compares this complex against the specified Object.
equals(Object) - Method in class org.jscience.mathematics.number.Float64
Compares this number against the specified object.
equals(double) - Method in class org.jscience.mathematics.number.Float64
Indicates if this number is equal to the specified value.
equals(Object) - Method in class org.jscience.mathematics.number.FloatingPoint
Compares this floating point number against the specified object.
equals(Object) - Method in class org.jscience.mathematics.number.Integer64
Compares this number against the specified object.
equals(long) - Method in class org.jscience.mathematics.number.Integer64
Compares this number against the specified value.
equals(Object) - Method in class org.jscience.mathematics.number.LargeInteger
Compares this large integer against the specified object.
equals(long) - Method in class org.jscience.mathematics.number.LargeInteger
Compares this large integer against the specified long value.
equals(Object) - Method in class org.jscience.mathematics.number.ModuloInteger
Compares this modulo integer against the specified object independently of the current modulus.
equals(Object) - Method in class org.jscience.mathematics.number.Number
Indicates if this number is equals to the specified object.
equals(Object) - Method in class org.jscience.mathematics.number.Rational
Compares this rational number against the specified object.
equals(Object) - Method in class org.jscience.mathematics.number.Real
Compares this real number against the specified object.
equals(Matrix<F>, Comparator<F>) - Method in class org.jscience.mathematics.vector.Matrix
Indicates if this matrix can be considered equals to the one specified using the specified comparator when testing for element equality.
equals(Object) - Method in class org.jscience.mathematics.vector.Matrix
Indicates if this matrix is strictly equal to the object specified.
equals(Vector<F>, Comparator<F>) - Method in class org.jscience.mathematics.vector.Vector
Indicates if this vector can be considered equals to the one specified using the specified comparator when testing for element equality.
equals(Object) - Method in class org.jscience.mathematics.vector.Vector
Indicates if this vector is equal to the object specified.
equals(Object) - Method in class org.jscience.physics.amount.Amount
Compares this measure against the specified object for strict equality (same value interval and same units).
ERG - Static variable in class javax.measure.unit.NonSI
A unit of energy equal to 1E-7 J (standard name erg).
EUR - Static variable in class org.jscience.economics.money.Currency
The Euro currency.
evaluate() - Method in class org.jscience.mathematics.function.DiscreteFunction
 
evaluate() - Method in class org.jscience.mathematics.function.Function
Evaluates this function using its variables current values.
evaluate(X) - Method in class org.jscience.mathematics.function.Function
Evaluates this function for the specified argument value (convenience method).
evaluate(X...) - Method in class org.jscience.mathematics.function.Function
Evaluates this function for the specified arguments values (convenience method).
evaluate() - Method in class org.jscience.mathematics.function.Polynomial
 
evaluate() - Method in class org.jscience.mathematics.function.RationalFunction
 
EXA(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 1018
exp() - Method in class org.jscience.mathematics.number.Complex
Returns the exponential number e raised to the power of this complex.
exp() - Method in class org.jscience.mathematics.number.Float64
Returns the exponential number e raised to the power of this number.
Extent - Interface in org.opengis.metadata.extent
 

F

F - Static variable in class org.jscience.physics.amount.Constants
Holds the Faraday constant (N·e)
FAHRENHEIT - Static variable in class javax.measure.unit.NonSI
A unit of temperature equal to degree Rankine minus 459.67 °R (standard name °F).
family() - Method in class org.opengis.referencing.cs.AxisDirection
 
family() - Method in class org.opengis.util.CodeList
 
FARAD - Static variable in class javax.measure.unit.SI
The derived unit for capacitance (F).
FARADAY - Static variable in class javax.measure.unit.NonSI
A unit of electric charge equal to equal to the product of Avogadro's number (see SI.MOLE) and the charge (1 e) on a single electron (standard name Fd).
FEMTO(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-15
Field<F> - Interface in org.jscience.mathematics.structure
This interface represents an algebraic structure in which the operations of addition, subtraction, multiplication and division (except division by zero) may be performed.
Float64 - Class in org.jscience.mathematics.number
This class represents a 64 bits floating point number.
Float64Matrix - Class in org.jscience.mathematics.vector
This class represents an optimized matrix implementation for 64 bits floating-point numbers.
Float64Vector - Class in org.jscience.mathematics.vector
This class represents an optimized vector implementation for 64 bits floating point elements.
FloatingPoint - Class in org.jscience.mathematics.number
This class represents a floating point number of arbitrary precision.
floatValue(Unit<Q>) - Method in class javax.measure.Measure
Returns the value of this measure stated in the specified unit as a float.
floatValue() - Method in class org.jscience.mathematics.number.Number
Returns the value of this number as a float.
FOOT - Static variable in class javax.measure.unit.NonSI
A unit of length equal to 0.3048 m (standard name ft).
FOOT_SURVEY_US - Static variable in class javax.measure.unit.NonSI
A unit of length equal to 1200/3937 m (standard name foot_survey_us).
Force - Interface in javax.measure.quantity
This interface represents a quantity that tends to produce an acceleration of a body in the direction of its application.
format(Unit<?>, Appendable) - Method in class javax.measure.unit.UnitFormat.ASCIIFormat
 
format(Unit<?>, Appendable) - Method in class javax.measure.unit.UnitFormat.DefaultFormat
 
format(Unit<?>, Appendable) - Method in class javax.measure.unit.UnitFormat
Formats the specified unit.
format(Object, StringBuffer, FieldPosition) - Method in class javax.measure.unit.UnitFormat
Formats an unit and appends the resulting text to a given string buffer (implements java.text.Format).
format(LargeInteger, int, Appendable) - Static method in class org.jscience.mathematics.number.LargeInteger
Formats the specified large integer in the specified radix and into the specified Appendable argument.
four_π - Static variable in class org.jscience.physics.amount.Constants
Holds 4·Constants.π.
FRANKLIN - Static variable in class javax.measure.unit.NonSI
A unit of electric charge which exerts a force of one dyne on an equal charge at a distance of one centimeter (standard name Fr).
Frequency - Interface in javax.measure.quantity
This interface represents the number of times a specified phenomenon occurs within a specified interval.
Function<X,Y> - Class in org.jscience.mathematics.function
This abstract class represents a mapping between two sets such that there is a unique element in the second set assigned to each element in the first set.
Function() - Constructor for class org.jscience.mathematics.function.Function
Default constructor.
FunctionException - Exception in org.jscience.mathematics.function
Thrown when a function operation cannot be performed.
FunctionException() - Constructor for exception org.jscience.mathematics.function.FunctionException
Constructs a FunctionException with no detail message.
FunctionException(String) - Constructor for exception org.jscience.mathematics.function.FunctionException
Constructs a FunctionException with the specified message.
FUTURE - Static variable in class org.opengis.referencing.cs.AxisDirection
 

G

G - Static variable in class javax.measure.unit.NonSI
A unit of acceleration equal to the gravity at the earth's surface (standard name grav).
g - Static variable in class org.jscience.physics.amount.Constants
Holds the standard acceleration due to gravity (approximately equal to the acceleration due to gravity on the Earth's surface).
G - Static variable in class org.jscience.physics.amount.Constants
Holds the Newtonian constant of gravitation.
G0 - Static variable in class org.jscience.physics.amount.Constants
Holds the conductance quantum (2e²/h)
GALLON_DRY_US - Static variable in class javax.measure.unit.NonSI
A unit of volume equal to one US dry gallon.
GALLON_LIQUID_US - Static variable in class javax.measure.unit.NonSI
A unit of volume equal to one US gallon, Liquid Unit.
GALLON_UK - Static variable in class javax.measure.unit.NonSI
A unit of volume equal to 4.546 09 NonSI.LITRE (standard name gal_uk).
GAUSS - Static variable in class javax.measure.unit.NonSI
A unit of magnetic flux density equal 1000 A/m (standard name G).
GBP - Static variable in class org.jscience.economics.money.Currency
The British Pound currency.
gcd(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the greatest common divisor of this large integer and the one specified.
GEOCENTRIC_X - Static variable in class org.opengis.referencing.cs.AxisDirection
 
GEOCENTRIC_Y - Static variable in class org.opengis.referencing.cs.AxisDirection
 
GEOCENTRIC_Z - Static variable in class org.opengis.referencing.cs.AxisDirection
 
GeocentricCRS<C extends Coordinates<?>> - Class in org.jscience.geography.coordinates.crs
This class represents a 3 dimensional spatial reference system.
GeocentricCRS() - Constructor for class org.jscience.geography.coordinates.crs.GeocentricCRS
 
GeographicCRS<C extends Coordinates<?>> - Class in org.jscience.geography.coordinates.crs
This class represents a 2 dimensional surface reference system based on an ellipsoidal approximation of a geoid.
GeographicCRS() - Constructor for class org.jscience.geography.coordinates.crs.GeographicCRS
 
get() - Method in class org.jscience.mathematics.function.Variable.Global
 
get() - Method in class org.jscience.mathematics.function.Variable.Local
 
get(int, int) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
get(int) - Method in class org.jscience.mathematics.vector.ComplexVector
 
get(int, int) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
get(int) - Method in class org.jscience.mathematics.vector.DenseVector
 
get(int, int) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
get(int) - Method in class org.jscience.mathematics.vector.Float64Vector
 
get(int, int) - Method in class org.jscience.mathematics.vector.Matrix
Returns a single element from this matrix.
get(int, int) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
get(int) - Method in class org.jscience.mathematics.vector.SparseVector
 
get(int) - Method in class org.jscience.mathematics.vector.Vector
Returns a single element from this vector.
getAbbreviation() - Method in interface org.opengis.referencing.cs.CoordinateSystemAxis
The abbreviation used for this coordinate system axes.
getAbsoluteError() - Method in class org.jscience.physics.amount.Amount
Returns the value by which theestimated value may differ from the true value (all stated in base units).
getAccuracy() - Method in class org.jscience.mathematics.number.Real
Returns the number of decimal digits guaranteed exact which appear to the right of the decimal point (absolute error).
getAlias() - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
OpenGIS® - An alternative name by which this object is identified.
getAlias() - Method in interface org.opengis.referencing.IdentifiedObject
 
getAuthority() - Method in interface org.opengis.metadata.Identifier
 
getAxis(int) - Method in interface org.opengis.referencing.cs.CoordinateSystem
 
getBase() - Method in class javax.measure.converter.LogConverter
Returns the logarithmic base of this converter.
getBracketErrorInstance(int) - Static method in class org.jscience.physics.amount.AmountFormat
Returns a format for which the error is represented by an integer value in brackets; for example "1.3456[20] m" is equivalent to "1.3456 ± 0.0020 m".
getCentralMeridian(int, char) - Static method in class org.jscience.geography.coordinates.UTM
Returns the central meridian (in radians) for the specified UTM/UPS zone.
getCode() - Method in class org.jscience.economics.money.Currency
Returns the currency code for this currency.
getCode() - Method in interface org.opengis.metadata.Identifier
 
getCoefficient(Term) - Method in class org.jscience.mathematics.function.Polynomial
Returns the coefficient for the specified term.
getColumn(int) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
getColumn(int) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
getColumn(int) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
getColumn(int) - Method in class org.jscience.mathematics.vector.Matrix
Returns the column identified by the specified index in this matrix.
getColumn(int) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
getConverterTo(Unit<?>) - Method in class javax.measure.unit.Unit
Returns a converter of numeric values from this unit to another unit.
getConverterTo(CoordinateReferenceSystem<T>) - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
Returns the converter between this coordinate reference system and the one specified.
getCoordinateReferenceSystem() - Method in class org.jscience.geography.coordinates.Altitude
 
getCoordinateReferenceSystem() - Method in class org.jscience.geography.coordinates.CompoundCoordinates
 
getCoordinateReferenceSystem() - Method in class org.jscience.geography.coordinates.Coordinates
Returns the reference system for this coordinates.
getCoordinateReferenceSystem() - Method in class org.jscience.geography.coordinates.Height
 
getCoordinateReferenceSystem() - Method in class org.jscience.geography.coordinates.LatLong
 
getCoordinateReferenceSystem() - Method in class org.jscience.geography.coordinates.Time
 
getCoordinateReferenceSystem() - Method in class org.jscience.geography.coordinates.UTM
 
getCoordinateReferenceSystem() - Method in class org.jscience.geography.coordinates.XYZ
 
getCoordinateReferenceSystem() - Method in interface org.opengis.spatialschema.geometry.DirectPosition
 
getCoordinates() - Method in class org.jscience.geography.coordinates.Coordinates
OpenGIS® - Returns the sequence of numbers that hold the coordinate of this position in its reference system.
getCoordinates() - Method in interface org.opengis.spatialschema.geometry.DirectPosition
 
getCoordinateSystem() - Method in class org.jscience.geography.coordinates.crs.CompoundCRS
 
getCoordinateSystem() - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
Returns the OpenGIS coordinate system associated to this coordinate reference system.
getCoordinateSystem() - Method in interface org.opengis.referencing.crs.CoordinateReferenceSystem
 
getDefaultFractionDigits() - Method in class org.jscience.economics.money.Currency
Returns the default number of fraction digits used with this currency unit.
getDiagonal() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
getDiagonal() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
getDiagonal() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
getDiagonal() - Method in class org.jscience.mathematics.vector.Matrix
Returns the diagonal vector.
getDiagonal() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
getDigits() - Static method in class org.jscience.mathematics.number.FloatingPoint
Returns the local number of digits used during calculations (default 20 digits).
getDimension(BaseUnit<?>) - Method in interface javax.measure.unit.Dimension.Model
Returns the dimension of the specified base unit (a dimension particular to the base unit if the base unit is not recognized).
getDimension() - Method in class javax.measure.unit.Unit
Returns the dimension of this unit (depends upon the current dimensional model).
getDimension() - Method in class org.jscience.geography.coordinates.Altitude
 
getDimension() - Method in class org.jscience.geography.coordinates.CompoundCoordinates
 
getDimension() - Method in class org.jscience.geography.coordinates.Coordinates
OpenGIS® - The length of coordinate sequence (the number of entries).
getDimension() - Method in class org.jscience.geography.coordinates.Height
 
getDimension() - Method in class org.jscience.geography.coordinates.LatLong
 
getDimension() - Method in class org.jscience.geography.coordinates.Time
 
getDimension() - Method in class org.jscience.geography.coordinates.UTM
 
getDimension() - Method in class org.jscience.geography.coordinates.XYZ
 
getDimension() - Method in class org.jscience.mathematics.vector.ComplexVector
 
getDimension() - Method in class org.jscience.mathematics.vector.DenseVector
 
getDimension() - Method in class org.jscience.mathematics.vector.Float64Vector
 
getDimension() - Method in class org.jscience.mathematics.vector.SparseVector
 
getDimension() - Method in class org.jscience.mathematics.vector.Vector
Returns the number of elements held by this vector.
getDimension(BaseUnit<?>) - Method in class org.jscience.physics.model.HighEnergyModel
 
getDimension(BaseUnit<?>) - Method in class org.jscience.physics.model.NaturalModel
 
getDimension(BaseUnit<?>) - Method in class org.jscience.physics.model.QuantumModel
 
getDimension(BaseUnit<?>) - Method in class org.jscience.physics.model.RelativisticModel
 
getDimension(BaseUnit<?>) - Method in class org.jscience.physics.model.StandardModel
 
getDimension() - Method in interface org.opengis.referencing.cs.CoordinateSystem
 
getDimension() - Method in interface org.opengis.spatialschema.geometry.DirectPosition
 
getDirection() - Method in interface org.opengis.referencing.cs.CoordinateSystemAxis
Direction of this coordinate system axis.
getDividend() - Method in class javax.measure.converter.RationalConverter
Returns the dividend for this rational converter.
getDividend() - Method in class org.jscience.mathematics.function.RationalFunction
Returns the dividend of this rational function.
getDividend() - Method in class org.jscience.mathematics.number.Rational
Returns the smallest dividend of the fraction representing this rational number.
getDivisor() - Method in class javax.measure.converter.RationalConverter
Returns the positive divisor for this rational converter.
getDivisor() - Method in class org.jscience.mathematics.function.RationalFunction
Returns the divisor of this rational function.
getDivisor() - Method in class org.jscience.mathematics.number.Rational
Returns the smallest divisor of the fraction representing this rational (always positive).
getEccentricity() - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the (first) eccentricity of this reference ellipsoid.
getEccentricitySquared() - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the square of the (first) eccentricity.
getError() - Method in class org.jscience.mathematics.number.Real
Returns the maximum error (positive) on this real significand.
getEstimatedValue() - Method in class org.jscience.physics.amount.Amount
Returns the estimated value for this measure stated in this measure unit.
getExactDigitsInstance() - Static method in class org.jscience.physics.amount.AmountFormat
Returns a format for which only digits guaranteed to be exact are written out.
getExactPrecision() - Static method in class org.jscience.mathematics.number.Real
Returns the local minimum precision (number of exact digits) when exact numbers have to be approximated.
getExactValue() - Method in class org.jscience.physics.amount.Amount
Returns the exact value for this measure stated in this measure unit.
getExchangeRate() - Method in class org.jscience.economics.money.Currency
Returns the exchange rate for this Currency.
getExponent() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the decimal exponent.
getExponent() - Method in class org.jscience.mathematics.number.Real
Returns the exponent of the power of 10 multiplier.
getFactor() - Method in class javax.measure.converter.MultiplyConverter
Returns the scale factor.
getFirst() - Method in class org.jscience.geography.coordinates.CompoundCoordinates
Returns the first coordinates.
getFlattening() - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the flattening or ellipticity of this reference ellipsoid.
getHigher() - Method in class javax.measure.unit.CompoundUnit
Returns the higher unit of this compound unit.
getIdentifiers() - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
OpenGIS® - An identifier which references elsewhere the object's defining information.
getIdentifiers() - Method in interface org.opengis.referencing.IdentifiedObject
 
getImaginary() - Method in class org.jscience.mathematics.number.Complex
Returns the imaginary component of this complex number.
getImaginary(int) - Method in class org.jscience.mathematics.vector.ComplexVector
Returns the imaginary value of a complex number from this vector (fast).
getInstance() - Static method in class javax.measure.MeasureFormat
Returns the measure format for the default locale.
getInstance(NumberFormat, UnitFormat) - Static method in class javax.measure.MeasureFormat
Returns the measure format using the specified number format and unit format (the number and unit are separated by a space).
getInstance() - Static method in class javax.measure.unit.NonSI
Returns the unique instance of this class.
getInstance() - Static method in class javax.measure.unit.SI
Returns the unique instance of this class.
getInstance() - Static method in class javax.measure.unit.UnitFormat
Returns the unit format for the default locale (format used by Unit.valueOf(CharSequence) and Unit.toString()).
getInstance(Locale) - Static method in class javax.measure.unit.UnitFormat
Returns the unit format for the specified locale.
getInstance() - Static method in class org.jscience.physics.amount.AmountFormat
Returns the current local format (default AmountFormat.getPlusMinusErrorInstance(2)).
getInterpolator() - Method in class org.jscience.mathematics.function.DiscreteFunction
Returns the interpolator used by this discrete function.
getLatitudeZone(LatLong) - Static method in class org.jscience.geography.coordinates.UTM
Returns the UTM/UPS latitude zone identifier for the specified coordinates.
getLongitudeZone(LatLong) - Static method in class org.jscience.geography.coordinates.UTM
Returns the UTM/UPS longitude zone number for the specified coordinates.
getLower() - Method in class javax.measure.unit.CompoundUnit
Returns the lower unit of this compound unit.
getLower(F, F) - Method in class org.jscience.mathematics.vector.LUDecomposition
Returns the lower matrix decomposition (L) with diagonal elements equal to the multiplicative identity for F.
getLowestSetBit() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the index of the lowest-order one bit in this large integer or -1 if this.equals(ZERO).
getLU() - Method in class org.jscience.mathematics.vector.LUDecomposition
Returns the lower/upper decomposition in one single matrix.
getMaximumValue() - Method in class org.jscience.physics.amount.Amount
Returns the upper bound interval value for this measure stated in this measure unit.
getMinimumValue() - Method in class org.jscience.physics.amount.Amount
Returns the lower bound interval value for this measure stated in this measure unit.
getModel() - Static method in class javax.measure.unit.Dimension
Returns the model used to determinate the units dimensions (default STANDARD).
getModulus() - Static method in class org.jscience.mathematics.number.ModuloInteger
Returns the local modulus for modular arithmetic or null if the arithmetic operations are non-modular (default).
getName() - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
OpenGIS® - The primary name by which this object is identified.
getName() - Method in interface org.opengis.referencing.IdentifiedObject
 
getNext() - Method in class org.jscience.geography.coordinates.CompoundCoordinates
Returns the next coordinates.
getNumberOfColumns() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
getNumberOfColumns() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
getNumberOfColumns() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
getNumberOfColumns() - Method in class org.jscience.mathematics.vector.Matrix
Returns the number of columns n for this matrix.
getNumberOfColumns() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
getNumberOfRows() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
getNumberOfRows() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
getNumberOfRows() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
getNumberOfRows() - Method in class org.jscience.mathematics.vector.Matrix
Returns the number of rows m for this matrix.
getNumberOfRows() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
getOffset() - Method in class javax.measure.converter.AddConverter
Returns the offset value for this add converter.
getOrder(Variable<R>) - Method in class org.jscience.mathematics.function.Polynomial
Returns the order of this polynomial for the specified variable.
getOrdinate(int) - Method in class org.jscience.geography.coordinates.Altitude
 
getOrdinate(int) - Method in class org.jscience.geography.coordinates.CompoundCoordinates
 
getOrdinate(int) - Method in class org.jscience.geography.coordinates.Coordinates
OpenGIS® - Returns the ordinate at the specified dimension.
getOrdinate(int) - Method in class org.jscience.geography.coordinates.Height
 
getOrdinate(int) - Method in class org.jscience.geography.coordinates.LatLong
 
getOrdinate(int) - Method in class org.jscience.geography.coordinates.Time
 
getOrdinate(int) - Method in class org.jscience.geography.coordinates.UTM
 
getOrdinate(int) - Method in class org.jscience.geography.coordinates.XYZ
 
getOrdinate(int) - Method in interface org.opengis.spatialschema.geometry.DirectPosition
 
getParent() - Method in class javax.measure.unit.AlternateUnit
Returns the parent unit from which this alternate unit is derived (a system unit itself).
getParentUnit() - Method in class javax.measure.unit.TransformedUnit
Returns the parent unit for this unit.
getPermutation(F, F) - Method in class org.jscience.mathematics.vector.LUDecomposition
Returns the permutation matrix (P).
getPivotComparator() - Static method in class org.jscience.mathematics.vector.LUDecomposition
Returns the local comparator used for pivoting or null if pivoting is not performed (default LUDecomposition.NUMERIC_COMPARATOR).
getPivots() - Method in class org.jscience.mathematics.vector.LUDecomposition
Returns the pivots elements of this decomposition.
getPlusMinusErrorInstance(int) - Static method in class org.jscience.physics.amount.AmountFormat
Returns a format for which the error (if present) is stated using the '±' character; for example "(1.34 ± 0.01) m".
getPointValues() - Method in class org.jscience.mathematics.function.DiscreteFunction
Returns the point-value entries of this discrete function.
getPosition() - Method in class org.jscience.geography.coordinates.Coordinates
OpenGIS® - Returns the direct position for this position.
getPower(int) - Method in class org.jscience.mathematics.function.Term
Returns the power of the variable at the specified position.
getPower(Variable<?>) - Method in class org.jscience.mathematics.function.Term
Returns the power of the specified variable.
getPrecision() - Method in class org.jscience.mathematics.number.Real
Returns the total number of decimal digits guaranteed exact (relative error).
getReal() - Method in class org.jscience.mathematics.number.Complex
Returns the real component of this complex number.
getReal(int) - Method in class org.jscience.mathematics.vector.ComplexVector
Returns the real value of a complex number from this vector (fast).
getReferenceCurrency() - Static method in class org.jscience.economics.money.Currency
Returns the currency used as reference when setting the exchange rate.
getRelativeError() - Method in class org.jscience.physics.amount.Amount
Returns the percentage by which the estimated amount may differ from the true amount.
getRemainder() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the final undivided part after division that is less or of lower degree than the divisor.
getRemarks() - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
OpenGIS® - Comments on or information about this object, including data source information.
getRemarks() - Method in interface org.opengis.referencing.IdentifiedObject
 
getRow(int) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
getRow(int) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
getRow(int) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
getRow(int) - Method in class org.jscience.mathematics.vector.Matrix
Returns the row identified by the specified index in this matrix.
getRow(int) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
getScope() - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
OpenGIS® - Description of domain of usage, or limitations of usage, for which this (coordinate) reference system object is valid.
getScope() - Method in interface org.opengis.referencing.ReferenceSystem
 
getSecondEccentricitySquared() - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the square of the second eccentricity of this reference ellipsoid.
getSemimajorAxis() - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the semimajor or equatorial radius of this reference ellipsoid.
getSignificand() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the significand value.
getSignificand() - Method in class org.jscience.mathematics.number.Real
Returns this real significand value.
getsSemiminorAxis() - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the semiminor or polar radius of this reference ellipsoid.
getStandardUnit() - Method in class javax.measure.unit.AlternateUnit
 
getStandardUnit() - Method in class javax.measure.unit.BaseUnit
 
getStandardUnit() - Method in class javax.measure.unit.CompoundUnit
 
getStandardUnit() - Method in class javax.measure.unit.ProductUnit
 
getStandardUnit() - Method in class javax.measure.unit.TransformedUnit
 
getStandardUnit() - Method in class javax.measure.unit.Unit
Returns the base unit, alternate unit or product of base units and alternate units this unit is derived from.
getStandardUnit() - Method in class org.jscience.economics.money.Currency
 
getSymbol() - Method in class javax.measure.unit.AlternateUnit
Returns the symbol for this alternate unit.
getSymbol() - Method in class javax.measure.unit.BaseUnit
Returns the unique symbol for this base unit.
getSymbol() - Method in interface org.jscience.mathematics.function.Variable
Returns the symbol for this variable.
getSymbol() - Method in class org.jscience.mathematics.function.Variable.Global
 
getSymbol() - Method in class org.jscience.mathematics.function.Variable.Local
 
getTerms() - Method in class org.jscience.mathematics.function.Polynomial
Returns the terms of this polynomial.
getTransform(BaseUnit<?>) - Method in interface javax.measure.unit.Dimension.Model
Returns the normalization transform of the specified base unit (IDENTITY if the base unit is not recognized).
getTransform(BaseUnit<?>) - Method in class org.jscience.physics.model.HighEnergyModel
 
getTransform(BaseUnit<?>) - Method in class org.jscience.physics.model.NaturalModel
 
getTransform(BaseUnit<?>) - Method in class org.jscience.physics.model.QuantumModel
 
getTransform(BaseUnit<?>) - Method in class org.jscience.physics.model.RelativisticModel
 
getTransform(BaseUnit<?>) - Method in class org.jscience.physics.model.StandardModel
 
getUCUMInstance() - Static method in class javax.measure.unit.UnitFormat
Returns the UCUM international unit format; this format uses characters range 0000-007F exclusively and is not locale-sensitive.
getUnit() - Method in class javax.measure.DecimalMeasure
 
getUnit() - Method in class javax.measure.Measure
Returns the measurement unit of this measure.
getUnit(int) - Method in class javax.measure.unit.ProductUnit
Returns the unit at the specified position.
getUnit() - Method in class org.jscience.physics.amount.Amount
Returns the unit in which the estimated value and absolute error are stated.
getUnit() - Method in interface org.opengis.referencing.cs.CoordinateSystemAxis
The unit of measure used for this coordinate system axis.
getUnitCount() - Method in class javax.measure.unit.ProductUnit
Returns the number of units in this product.
getUnitPow(int) - Method in class javax.measure.unit.ProductUnit
Returns the power exponent of the unit at the specified position.
getUnitRoot(int) - Method in class javax.measure.unit.ProductUnit
Returns the root exponent of the unit at the specified position.
getUnits() - Method in class javax.measure.unit.NonSI
Returns a read only view over the units defined in this class.
getUnits() - Method in class javax.measure.unit.SI
Returns a read only view over theunits defined in this class.
getUnits() - Method in class javax.measure.unit.SystemOfUnits
Returns a read only view over the units defined in this system.
getUpper(F) - Method in class org.jscience.mathematics.vector.LUDecomposition
Returns the upper matrix decomposition (U).
getValidArea() - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
OpenGIS® - Area for which the (coordinate) reference system is valid.
getValidArea() - Method in interface org.opengis.referencing.ReferenceSystem
 
getValue() - Method in class javax.measure.DecimalMeasure
 
getValue() - Method in class javax.measure.Measure
Returns the measurement value of this measure.
getValue() - Method in class org.jscience.mathematics.function.Constant
Returns the constant value for this function.
getValue(int) - Method in class org.jscience.mathematics.vector.Float64Vector
Returns the value of a floating point number from this vector (fast).
getVariable(String) - Method in class org.jscience.mathematics.function.Function
Retrieves the variable from this function having the specified symbol (convenience method).
getVariable(int) - Method in class org.jscience.mathematics.function.Term
Returns the variable at the specified index (variables are lexically ordered).
getVariables() - Method in class org.jscience.mathematics.function.DiscreteFunction
 
getVariables() - Method in class org.jscience.mathematics.function.Function
Returns a lexically ordered list of the variables (or arguments) for this function (empty list for constant functions).
getVariables() - Method in class org.jscience.mathematics.function.Polynomial
 
getVariables() - Method in class org.jscience.mathematics.function.RationalFunction
 
getVersion() - Method in interface org.opengis.metadata.Identifier
 
getZero() - Method in class org.jscience.mathematics.vector.SparseMatrix
Returns the value of the non-set elements for this sparse matrix.
getZero() - Method in class org.jscience.mathematics.vector.SparseVector
Returns the value of the non-set elements for this sparse vector.
GIGA(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 109
GILBERT - Static variable in class javax.measure.unit.NonSI
A unit of electric charge equal to the centimeter-gram-second electromagnetic unit of magnetomotive force, equal to 10/4 πampere-turn (standard name Gi).
GRADE - Static variable in class javax.measure.unit.NonSI
A unit of angle measure equal to 1/400 NonSI.REVOLUTION (standard name grade).
GRAM - Static variable in class javax.measure.unit.SI
The derived unit for mass quantities (g).
GRAY - Static variable in class javax.measure.unit.SI
The derived unit for absorbed dose, specific energy (imparted), kerma (Gy).
GroupAdditive<G> - Interface in org.jscience.mathematics.structure
This interface represents a structure with a binary additive operation (+), satisfying the group axioms (associativity, neutral element, inverse element and closure).
GroupMultiplicative<G> - Interface in org.jscience.mathematics.structure
This interface represents a structure with a binary multiplicative operation (·), satisfying the group axioms (associativity, neutral element, inverse element and closure).
GRS80 - Static variable in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Geodetic Reference System 1980 ellipsoid.

H

half_π - Static variable in class org.jscience.physics.amount.Constants
Holds Constants.π/2.
hashCode() - Method in class javax.measure.converter.UnitConverter
Returns a hash code value for this converter.
hashCode() - Method in class javax.measure.Measure
Returns the hash code for this scalar.
hashCode() - Method in class javax.measure.unit.AlternateUnit
 
hashCode() - Method in class javax.measure.unit.BaseUnit
 
hashCode() - Method in class javax.measure.unit.CompoundUnit
 
hashCode() - Method in class javax.measure.unit.Dimension
Returns the hash code for this dimension.
hashCode() - Method in class javax.measure.unit.ProductUnit
 
hashCode() - Method in class javax.measure.unit.TransformedUnit
 
hashCode() - Method in class javax.measure.unit.Unit
Returns the hash code for this unit.
hashCode() - Method in class org.jscience.economics.money.Currency
 
hashCode() - Method in class org.jscience.mathematics.function.Function
Returns the hash code for this function (consistent with Function.equals(Object).
hashCode() - Method in class org.jscience.mathematics.function.Polynomial
 
hashCode() - Method in class org.jscience.mathematics.function.RationalFunction
 
hashCode() - Method in class org.jscience.mathematics.function.Term
Returns a hash code for this term.
hashCode() - Method in class org.jscience.mathematics.number.Complex
Returns the hash code for this complex number.
hashCode() - Method in class org.jscience.mathematics.number.Float64
Returns the hash code for this number.
hashCode() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the hash code for this floating point number.
hashCode() - Method in class org.jscience.mathematics.number.Integer64
Returns the hash code for this number.
hashCode() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the hash code for this large integer number.
hashCode() - Method in class org.jscience.mathematics.number.ModuloInteger
Returns the hash code for this large integer number.
hashCode() - Method in class org.jscience.mathematics.number.Number
Returns the hash code for this number (consistent with Number.equals(Object).
hashCode() - Method in class org.jscience.mathematics.number.Rational
Returns the hash code for this rational number.
hashCode() - Method in class org.jscience.mathematics.number.Real
Returns the hash code for this real number.
hashCode() - Method in class org.jscience.mathematics.vector.Matrix
Returns a hash code value for this matrix.
hashCode() - Method in class org.jscience.mathematics.vector.Vector
Returns a hash code value for this vector.
hashCode() - Method in class org.jscience.physics.amount.Amount
Returns the hash code for this measure.
HECTARE - Static variable in class javax.measure.unit.NonSI
A unit of area equal to 100 NonSI.ARE (standard name ha).
HECTO(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 102
Height - Class in org.jscience.geography.coordinates
This class represents the vertical height above the WGS84 ellipsoid.
HEIGHT_CS - Static variable in class org.jscience.geography.coordinates.crs.VerticalCRS
Holds the gravity-related height coordinate system.
heightWGS84 - Variable in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem.AbsolutePosition
Holds the WGS84 Ellipsoidal Height.
HENRY - Static variable in class javax.measure.unit.SI
The derived unit for inductance (H).
HERTZ - Static variable in class javax.measure.unit.SI
The derived unit for frequency (Hz).
HighEnergyModel - Class in org.jscience.physics.model
This class represents the high-energy model.
HighEnergyModel() - Constructor for class org.jscience.physics.model.HighEnergyModel
 
HORSEPOWER - Static variable in class javax.measure.unit.NonSI
A unit of power equal to the power required to raise a mass of 75 kilograms at a velocity of 1 meter per second (metric, standard name hp).
HOUR - Static variable in class javax.measure.unit.NonSI
A unit of duration equal to 60 NonSI.MINUTE (standard name h).

I

I - Static variable in class org.jscience.mathematics.number.Complex
The imaginary unit i.
IdentifiedObject - Interface in org.opengis.referencing
 
Identifier - Interface in org.opengis.metadata
 
IDENTIFIERS_KEY - Static variable in interface org.opengis.referencing.IdentifiedObject
 
IDENTITY - Static variable in class javax.measure.converter.UnitConverter
Holds the identity converter (unique).
Illuminance - Interface in javax.measure.quantity
This interface represents an illuminance.
INCH - Static variable in class javax.measure.unit.NonSI
A unit of length equal to 0.0254 m (standard name in).
INCH_OF_MERCURY - Static variable in class javax.measure.unit.NonSI
A unit of pressure equal to the pressure exerted at the Earth's surface by a column of mercury 1 inch high (standard name inHg).
Integer64 - Class in org.jscience.mathematics.number
This class represents a 64 bits integer number.
integrate(Variable<X>) - Method in class org.jscience.mathematics.function.Function
Returns an integral of this function with respect to the specified variable.
integrate(Variable<R>) - Method in class org.jscience.mathematics.function.Polynomial
 
INTERNATIONAL1924 - Static variable in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
The International 1924 reference ellipsoid, one of the earliest "global" ellipsoids.
InternationalString - Class in org.opengis.util
 
InternationalString() - Constructor for class org.opengis.util.InternationalString
 
interpolate(P, SortedMap<P, V>) - Method in interface org.jscience.mathematics.function.Interpolator
Estimates the value at the specified point.
interpolate(F, SortedMap<F, F>) - Method in class org.jscience.mathematics.function.Interpolator.Linear
 
Interpolator<P,V> - Interface in org.jscience.mathematics.function
This interface represents an estimator of the values at a certain point using surrounding points and values.
Interpolator.Linear<F extends Field<F>> - Class in org.jscience.mathematics.function
This class represents a linear interpolator for field instances (point and values from the same field).
Interpolator.Linear() - Constructor for class org.jscience.mathematics.function.Interpolator.Linear
 
intValue(Unit<Q>) - Method in class javax.measure.Measure
Returns the estimated integral value of this measure stated in the specified unit as a int.
intValue() - Method in class org.jscience.mathematics.number.Number
Returns the value of this number as an int.
inverse() - Method in class javax.measure.converter.AddConverter
 
inverse() - Method in class javax.measure.converter.LogConverter
 
inverse() - Method in class javax.measure.converter.MultiplyConverter
 
inverse() - Method in class javax.measure.converter.RationalConverter
 
inverse() - Method in class javax.measure.converter.UnitConverter
Returns the inverse of this converter.
inverse() - Method in class javax.measure.unit.Unit
Returns the inverse of this unit.
inverse() - Method in class org.jscience.mathematics.function.RationalFunction
Returns the inverse of this rational function.
inverse() - Method in class org.jscience.mathematics.number.Complex
Returns the inverse of this complex.
inverse() - Method in class org.jscience.mathematics.number.Float64
Returns the reciprocal of this number.
inverse() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the inverse of this floating point number.
inverse() - Method in class org.jscience.mathematics.number.ModuloInteger
 
inverse() - Method in class org.jscience.mathematics.number.Rational
Returns the inverse of this rational number.
inverse() - Method in class org.jscience.mathematics.number.Real
Returns the reciprocal (or inverse) of this real number.
inverse() - Method in interface org.jscience.mathematics.structure.GroupMultiplicative
Returns the multiplicative inverse of this object.
inverse() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
inverse() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
inverse() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
inverse() - Method in class org.jscience.mathematics.vector.LUDecomposition
Returns the solution X of the equation: A * X = Identity with this = A.lu() using back and forward substitutions.
inverse() - Method in class org.jscience.mathematics.vector.Matrix
Returns the inverse of this matrix (must be square).
inverse() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
inverse() - Method in class org.jscience.physics.amount.Amount
Returns the multiplicative inverse of this measure.
inverse() - Method in class org.opengis.referencing.cs.AxisDirection
Deprecated. 
inverseScaled(int) - Method in class org.jscience.mathematics.number.LargeInteger
Returns a scaled approximation of 1 / this.
isCompatible(Unit<?>) - Method in class javax.measure.unit.Unit
Indicates if this unit is compatible with the unit specified.
isEven() - Method in class org.jscience.mathematics.number.LargeInteger
Indicates if this large integer is an even number.
isExact() - Method in class org.jscience.mathematics.number.Real
Indicates if this real number is exact (error == 0).
isExact() - Method in class org.jscience.physics.amount.Amount
Indicates if this measure amount is exact.
isGreaterThan(T) - Method in class org.jscience.mathematics.number.Number
Indicates if this number is ordered after that number (convenience method).
isGreaterThan(Amount<Q>) - Method in class org.jscience.physics.amount.Amount
Indicates if this measure is ordered after that measure (independently of the measure unit).
isInfinite() - Method in class org.jscience.mathematics.number.Complex
Indicates if either the real or imaginary component of this complex is infinite.
isInfinite() - Method in class org.jscience.mathematics.number.Float64
Indicates if this number is infinite.
isLargerThan(Complex) - Method in class org.jscience.mathematics.number.Complex
Compares the magnitude of this complex number with the magnitude of the complex number specified.
isLargerThan(Float64) - Method in class org.jscience.mathematics.number.Float64
Compares the absolute value of this number with that number.
isLargerThan(FloatingPoint) - Method in class org.jscience.mathematics.number.FloatingPoint
Compares the absolute value of two FloatingPoint numbers.
isLargerThan(Integer64) - Method in class org.jscience.mathematics.number.Integer64
Compares the magnitude of this number with that number.
isLargerThan(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Indicates if this large integer is larger than the one specified in absolute value.
isLargerThan(ModuloInteger) - Method in class org.jscience.mathematics.number.ModuloInteger
 
isLargerThan(T) - Method in class org.jscience.mathematics.number.Number
Compares the magnitude of this number with that number.
isLargerThan(Rational) - Method in class org.jscience.mathematics.number.Rational
Compares the absolute value of two rational numbers.
isLargerThan(Real) - Method in class org.jscience.mathematics.number.Real
Compares the absolute value of two real numbers.
isLargerThan(Amount<Q>) - Method in class org.jscience.physics.amount.Amount
Compares this measure with that measure ignoring the sign.
isLessThan(T) - Method in class org.jscience.mathematics.number.Number
Indicates if this number is ordered before that number (convenience method).
isLessThan(Amount<Q>) - Method in class org.jscience.physics.amount.Amount
Indicates if this measure is ordered before that measure (independently of the measure unit).
isLinear() - Method in class javax.measure.converter.AddConverter
 
isLinear() - Method in class javax.measure.converter.LogConverter
 
isLinear() - Method in class javax.measure.converter.MultiplyConverter
 
isLinear() - Method in class javax.measure.converter.RationalConverter
 
isLinear() - Method in class javax.measure.converter.UnitConverter
Indicates if this converter is linear.
isNaN() - Method in class org.jscience.mathematics.number.Complex
Indicates if either the real or imaginary component of this complex is not a number.
isNaN() - Method in class org.jscience.mathematics.number.Float64
Indicates if this number is not a number.
isNaN() - Method in class org.jscience.mathematics.number.FloatingPoint
Indicates if this floating point is Not-a-Number.
isNaN() - Method in class org.jscience.mathematics.number.Real
Indicates if this real is Not-a-Number (unbounded value interval).
isNegative() - Method in class org.jscience.mathematics.number.FloatingPoint
Indicates if this rational number is less than zero.
isNegative() - Method in class org.jscience.mathematics.number.LargeInteger
Indicates if this large integer is less than LargeInteger.ZERO.
isNegative() - Method in class org.jscience.mathematics.number.Rational
Indicates if this rational number is less than zero.
isNegative() - Method in class org.jscience.mathematics.number.Real
Indicates if this real is less than zero.
isNorthPolar(LatLong) - Static method in class org.jscience.geography.coordinates.UTM
Returns true if the position indicated by the coordinates is north of the northern limit of the UTM grid (84 degrees).
isOdd() - Method in class org.jscience.mathematics.number.LargeInteger
Indicates if this large integer is an odd number.
isPositive() - Method in class org.jscience.mathematics.number.FloatingPoint
Indicates if this floating point number is greater than zero.
isPositive() - Method in class org.jscience.mathematics.number.LargeInteger
Indicates if this large integer is greater than LargeInteger.ZERO (LargeInteger.ZEROis not included).
isPositive() - Method in class org.jscience.mathematics.number.Rational
Indicates if this rational number is greater than zero.
isPositive() - Method in class org.jscience.mathematics.number.Real
Indicates if this real is greater than zero.
isPowerOfTwo() - Method in class org.jscience.mathematics.number.LargeInteger
Indicates if this number is a power of two (equals to 2 (bitLength() - 1)).
isProbablyPrime() - Method in class org.jscience.mathematics.number.LargeInteger
Indicates if this large integer is probably prime.
isSouthPolar(LatLong) - Static method in class org.jscience.geography.coordinates.UTM
Returns true if the position indicated by the coordinates is south of the southern limit of the UTM grid (-80 degrees).
isSquare() - Method in class org.jscience.mathematics.vector.Matrix
Indicates if this matrix is square.
isStandardUnit() - Method in class javax.measure.unit.Unit
Indicates if this unit is a standard unit (base units and alternate units are standard units).
isValidIdentifier(String) - Method in class javax.measure.unit.UnitFormat.DefaultFormat
 
isValidIdentifier(String) - Method in class javax.measure.unit.UnitFormat
Indicates if the specified name can be used as unit identifier.
isZero() - Method in class org.jscience.mathematics.number.FloatingPoint
Indicates if this floating point number is equal to zero.
isZero() - Method in class org.jscience.mathematics.number.LargeInteger
Indicates if this large integer is equal to LargeInteger.ZERO.
isZero() - Method in class org.jscience.mathematics.number.Rational
Indicates if this rational number is equal to zero.

J

javax.measure - package javax.measure
Provides strongly typed measurements to enforce compile-time check of parameters consistency and avoid interface errors.
javax.measure.converter - package javax.measure.converter
Provides support for unit conversion.
javax.measure.quantity - package javax.measure.quantity
Provides quantitative properties or attributes of thing such as mass, time, distance, heat, and angular separation.
javax.measure.unit - package javax.measure.unit
Provides support for programatic unit handling.
JOULE - Static variable in class javax.measure.unit.SI
The derived unit for energy, work, quantity of heat (J).
JPY - Static variable in class org.jscience.economics.money.Currency
The Japanese Yen currency.
JScience - Class in org.jscience
This class represents the JScience library; it contains the JScience.main(java.lang.String[]) method for versionning, self-tests, and performance analysis.

K

k - Static variable in class org.jscience.physics.amount.Constants
Holds the Boltzmann constant.
KATAL - Static variable in class javax.measure.unit.SI
The derived unit for catalytic activity (kat).
KELVIN - Static variable in class javax.measure.unit.SI
The base unit for thermodynamic temperature quantities (K).
KILO(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 103
KILOGRAM - Static variable in class javax.measure.unit.SI
The base unit for mass quantities (kg).
KILOGRAM_FORCE - Static variable in class javax.measure.unit.NonSI
A unit of force equal to 9.80665 N (standard name kgf).
KILOMETER - Static variable in class javax.measure.unit.SI
Equivalent to SI.KILOMETRE.
KILOMETERS_PER_HOUR - Static variable in class javax.measure.unit.NonSI
KILOMETRE - Static variable in class javax.measure.unit.SI
Equivalent to KILO(METRE).
KILOMETRES_PER_HOUR - Static variable in class javax.measure.unit.NonSI
A unit of velocity expressing the number of SI.KILOMETRE per hour.
KinematicViscosity - Interface in javax.measure.quantity
This interface represents the diffusion of momentum.
KNOT - Static variable in class javax.measure.unit.NonSI
A unit of velocity expressing the number of nautical miles per hour (abbreviation kn).
KRW - Static variable in class org.jscience.economics.money.Currency
The Korean Republic Won currency.

L

label(Unit<?>, String) - Method in class javax.measure.unit.UnitFormat.DefaultFormat
 
label(Unit<?>, String) - Method in class javax.measure.unit.UnitFormat
Attaches a system-wide label to the specified unit.
LAMBERT - Static variable in class javax.measure.unit.NonSI
A unit of illuminance equal to 1E4 Lx (standard name La).
LargeInteger - Class in org.jscience.mathematics.number
This class represents an immutable integer number of arbitrary size.
LATITUDE_LONGITUDE_CS - Static variable in class org.jscience.geography.coordinates.crs.GeographicCRS
Holds the Geodetic Latitude/Longitude coordinate system.
latitudeValue(Unit<Angle>) - Method in class org.jscience.geography.coordinates.LatLong
Returns the latitude value as double
latitudeWGS84 - Variable in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem.AbsolutePosition
Holds the Geodetic Latitude (WGS84 Ellipsoid).
latitudeZone() - Method in class org.jscience.geography.coordinates.UTM
Returns the latitude zone identifier.
LatLong - Class in org.jscience.geography.coordinates
This class represents the geographic latitude/longitude coordinates onto the WGS84 ellipsoid.
latLongToUps(LatLong, ReferenceEllipsoid) - Static method in class org.jscience.geography.coordinates.UTM
Converts latitude/longitude coordinates to UPS coordinates based on the specified reference ellipsoid.
latLongToUtm(LatLong, ReferenceEllipsoid) - Static method in class org.jscience.geography.coordinates.UTM
Converts latitude/longitude coordinates to UTM coordinates based on the specified reference ellipsoid.
LEFT - Static variable in class org.opengis.referencing.cs.AxisDirection
Deprecated. 
Length - Interface in javax.measure.quantity
This interface represents the extent of something along its greatest dimension or the extent of space between two objects or places.
LENGTH - Static variable in class javax.measure.unit.Dimension
Holds length dimension (L).
LIGHT_YEAR - Static variable in class javax.measure.unit.NonSI
A unit of length equal to the distance that light travels in one year through a vacuum (standard name ly).
LinearCS - Interface in org.opengis.referencing.cs
 
LITER - Static variable in class javax.measure.unit.NonSI
Equivalent to NonSI.LITRE (American spelling).
LITRE - Static variable in class javax.measure.unit.NonSI
A unit of volume equal to one cubic decimeter (default label L, also recognized µL, mL, cL, dL).
log() - Method in class org.jscience.mathematics.number.Complex
Returns the principal natural logarithm (base e) of this complex.
log() - Method in class org.jscience.mathematics.number.Float64
Returns the natural logarithm (base e) of this number.
LogConverter - Class in javax.measure.converter
This class represents a logarithmic converter.
LogConverter(double) - Constructor for class javax.measure.converter.LogConverter
Creates a logarithmic converter having the specified base.
longitudeValue(Unit<Angle>) - Method in class org.jscience.geography.coordinates.LatLong
Returns the longitude value as double
longitudeWGS84 - Variable in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem.AbsolutePosition
Holds the Geodetic Longitude (WGS84 Ellipsoid).
longitudeZone() - Method in class org.jscience.geography.coordinates.UTM
Returns the longitude zone identifier.
longValue(Unit<Q>) - Method in interface javax.measure.Measurable
Returns the estimated integral value of this measurable stated in the specified unit as a long.
longValue(Unit<Q>) - Method in class javax.measure.Measure
Returns the estimated integral value of this measure stated in the specified unit as a long.
longValue(Unit<Length>) - Method in class org.jscience.geography.coordinates.Altitude
 
longValue(Unit<Length>) - Method in class org.jscience.geography.coordinates.Height
 
longValue(Unit<Duration>) - Method in class org.jscience.geography.coordinates.Time
 
longValue() - Method in class org.jscience.mathematics.number.Complex
Returns the real component of this Complex number as a long.
longValue() - Method in class org.jscience.mathematics.number.Float64
 
longValue() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the value of this floating point number as a long.
longValue() - Method in class org.jscience.mathematics.number.Integer64
 
longValue() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the low order bits of this large integer as a long.
longValue() - Method in class org.jscience.mathematics.number.ModuloInteger
 
longValue() - Method in class org.jscience.mathematics.number.Number
Returns the value of this number as a long.
longValue() - Method in class org.jscience.mathematics.number.Rational
Returns the value of this rational number as a long.
longValue() - Method in class org.jscience.mathematics.number.Real
Returns the value of this real number as a long.
longValue(Unit<Q>) - Method in class org.jscience.physics.amount.Amount
 
lP - Static variable in class org.jscience.physics.amount.Constants
Holds the Planck length (ℏ/(mP·c))
LUDecomposition<F extends Field<F>> - Class in org.jscience.mathematics.vector
This class represents the decomposition of a matrix A into a product of a lower and upper triangular matrices, L and U respectively, such as A = P·L·U with P a permutation matrix.
LUMEN - Static variable in class javax.measure.unit.SI
The derived unit for luminous flux (lm).
LuminousFlux - Interface in javax.measure.quantity
This interface represents a luminous flux.
LuminousIntensity - Interface in javax.measure.quantity
This interface represents the luminous flux density per solid angle as measured in a given direction relative to the emitting source.
LUX - Static variable in class javax.measure.unit.SI
The derived unit for illuminance (lx).

M

MACH - Static variable in class javax.measure.unit.NonSI
A unit of velocity to express the speed of an aircraft relative to the speed of sound (standard name Mach).
MagneticFlux - Interface in javax.measure.quantity
This interface represents a magnetic flux.
MagneticFluxDensity - Interface in javax.measure.quantity
This interface represents a magnetic flux density.
magnitude() - Method in class org.jscience.mathematics.number.Complex
Returns the magnitude of this complex number, also referred to as the "modulus" or "length".
main(String[]) - Static method in class org.jscience.JScience
Mass - Interface in javax.measure.quantity
This interface represents the measure of the quantity of matter that a body or an object contains.
MASS - Static variable in class javax.measure.unit.Dimension
Holds mass dimension (M).
MassFlowRate - Interface in javax.measure.quantity
This interface represents the movement of mass per time.
Matrix<F extends Field<F>> - Class in org.jscience.mathematics.vector
This class represents a rectangular table of elements of a ring-like algebraic structure.
Matrix() - Constructor for class org.jscience.mathematics.vector.Matrix
Default constructor (for sub-classes).
MAXWELL - Static variable in class javax.measure.unit.NonSI
A unit of magnetic flux equal 1E-8 Wb (standard name Mx).
md - Static variable in class org.jscience.physics.amount.Constants
Holds the deuteron rest mass.
me - Static variable in class org.jscience.physics.amount.Constants
Holds the electron rest mass.
Measurable<Q extends Quantity> - Interface in javax.measure
This interface represents the measurable, countable, or comparable property or aspect of a thing.
Measure<V,Q extends Quantity> - Class in javax.measure
This class represents the result of a measurement stated in a known unit.
Measure() - Constructor for class javax.measure.Measure
Default constructor.
MeasureFormat - Class in javax.measure
This class provides the interface for formatting and parsing measures.
MeasureFormat() - Constructor for class javax.measure.MeasureFormat
 
MEGA(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 106
meridionalArc(double) - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the meridional arc, the true meridional distance on the ellipsoid from the equator to the specified latitude, in meters.
meridionalArc(Measurable<Angle>) - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the meridional arc, the true meridional distance on the ellipsoid from the equator to the specified latitude.
meridionalRadiusOfCurvature(double) - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the radius of curvature in the meridian for this reference ellipsoid at the specified latitude.
meridionalRadiusOfCurvature(Measurable<Angle>) - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the radius of curvature in the meridian for this reference ellipsoid at the specified latitude.
METER - Static variable in class javax.measure.unit.SI
Equivalent to SI.METRE (American spelling).
METERS_PER_SECOND - Static variable in class javax.measure.unit.SI
Equivalent to SI.METRES_PER_SECOND.
METERS_PER_SQUARE_SECOND - Static variable in class javax.measure.unit.SI
METRE - Static variable in class javax.measure.unit.SI
The base unit for length quantities (m).
METRE_PER_SECOND - Static variable in class javax.measure.unit.SI
Deprecated.
METRE_PER_SQUARE_SECOND - Static variable in class javax.measure.unit.SI
Deprecated.
METRES_PER_SECOND - Static variable in class javax.measure.unit.SI
The metric unit for velocity quantities (m/s).
METRES_PER_SQUARE_SECOND - Static variable in class javax.measure.unit.SI
The metric unit for acceleration quantities (m/s²).
METRIC_TON - Static variable in class javax.measure.unit.NonSI
A unit of mass equal to 1000 kg (metric ton, standard name t).
MICRO(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-6
MILE - Static variable in class javax.measure.unit.NonSI
A unit of length equal to 1609.344 m (standard name mi).
MILES_PER_HOUR - Static variable in class javax.measure.unit.NonSI
A unit of velocity expressing the number of international miles per hour (abbreviation mph).
MILLI(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-3
MILLIMETER - Static variable in class javax.measure.unit.SI
Equivalent to SI.MILLIMETRE.
MILLIMETER_OF_MERCURY - Static variable in class javax.measure.unit.NonSI
A unit of pressure equal to the pressure exerted at the Earth's surface by a column of mercury 1 millimeter high (standard name mmHg).
MILLIMETRE - Static variable in class javax.measure.unit.SI
Equivalent to MILLI(METRE).
minus(Function<X, Y>) - Method in class org.jscience.mathematics.function.Function
Returns the difference of this function with the one specified.
minus(Polynomial<R>) - Method in class org.jscience.mathematics.function.Polynomial
Returns the difference of two polynomials.
minus(Function<R, R>) - Method in class org.jscience.mathematics.function.Polynomial
 
minus(RationalFunction<F>) - Method in class org.jscience.mathematics.function.RationalFunction
Returns the difference of two rational functions.
minus(Function<F, F>) - Method in class org.jscience.mathematics.function.RationalFunction
 
minus(Complex) - Method in class org.jscience.mathematics.number.Complex
Returns the difference between this complex and the one specified.
minus(Float64) - Method in class org.jscience.mathematics.number.Float64
Returns the difference between this number and the one specified.
minus(double) - Method in class org.jscience.mathematics.number.Float64
Returns the difference between this number and the specified value.
minus(FloatingPoint) - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the difference between this FloatingPoint number and the one specified.
minus(Integer64) - Method in class org.jscience.mathematics.number.Integer64
Returns the difference between this number and the one specified.
minus(long) - Method in class org.jscience.mathematics.number.Integer64
Returns the difference between this number and the specified value
minus(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the difference between this large integer and the one specified.
minus(long) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the difference between this large integer and the specified value
minus(T) - Method in class org.jscience.mathematics.number.Number
Returns the difference between this number and the one specified.
minus(Rational) - Method in class org.jscience.mathematics.number.Rational
Returns the difference between this rational number and the one specified.
minus(Real) - Method in class org.jscience.mathematics.number.Real
Returns the difference between this real number and the one specified.
minus(Matrix<Complex>) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
minus(Vector<Complex>) - Method in class org.jscience.mathematics.vector.ComplexVector
 
minus(Matrix<F>) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
minus(Vector<F>) - Method in class org.jscience.mathematics.vector.DenseVector
 
minus(Matrix<Float64>) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
minus(Vector<Float64>) - Method in class org.jscience.mathematics.vector.Float64Vector
 
minus(Matrix<F>) - Method in class org.jscience.mathematics.vector.Matrix
Returns the difference between this matrix and the one specified.
minus(Matrix<F>) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
minus(Vector<F>) - Method in class org.jscience.mathematics.vector.Vector
Returns the difference between this vector and the one specified.
minus(Amount) - Method in class org.jscience.physics.amount.Amount
Returns the difference of this measure with the one specified.
MINUTE - Static variable in class javax.measure.unit.NonSI
A unit of duration equal to 60 s (standard name min).
MINUTE_ANGLE - Static variable in class javax.measure.unit.NonSI
A unit of angle equal to 1/60 NonSI.DEGREE_ANGLE (standard name ).
mn - Static variable in class org.jscience.physics.amount.Constants
Holds the neutron rest mass.
mod(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Returns this large integer modulo the specified large integer.
modInverse(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the large integer whose value is (this-1 mod m) .
modPow(LargeInteger, LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Returns this large integer raised at the specified exponent modulo the specified modulus.
MODULO - Static variable in class org.jscience.JScience
 
ModuloInteger - Class in org.jscience.mathematics.number
This class represents a modulo integer.
moduloValue() - Method in class org.jscience.mathematics.number.ModuloInteger
Returns the current modulo value of this number.
MOLE - Static variable in class javax.measure.unit.SI
The base unit for amount of substance quantities (mol).
Money - Interface in org.jscience.economics.money
This interface represents something generally accepted as a medium of exchange, a measure of value, or a means of payment.
MONTH - Static variable in class javax.measure.unit.NonSI
A unit of duration equal to one twelfth of a year (standard name month).
mp - Static variable in class org.jscience.physics.amount.Constants
Holds the proton rest mass.
mP - Static variable in class org.jscience.physics.amount.Constants
Holds the Planck mass (ℏ·c/G)1/2
MultiplyConverter - Class in javax.measure.converter
This class represents a converter multiplying numeric values by a constant scaling factor (approximated as a double).
MultiplyConverter(double) - Constructor for class javax.measure.converter.MultiplyConverter
Creates a multiply converter with the specified scale factor.
- Static variable in class org.jscience.physics.amount.Constants
Holds the muon rest mass.

N

N - Static variable in class org.jscience.physics.amount.Constants
Holds the Avogadro constant.
name() - Method in class org.opengis.util.CodeList
 
NAME_KEY - Static variable in interface org.opengis.referencing.IdentifiedObject
 
nameFor(Unit<?>) - Method in class javax.measure.unit.UnitFormat.ASCIIFormat
 
nameFor(Unit<?>) - Method in class javax.measure.unit.UnitFormat.DefaultFormat
 
NaN - Static variable in class org.jscience.mathematics.number.FloatingPoint
The Not-a-Number instance (unique).
NaN - Static variable in class org.jscience.mathematics.number.Real
Holds a Not-a-Number instance (infinite error).
NANO(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-9
NaturalModel - Class in org.jscience.physics.model
This class represents the natural model.
NaturalModel() - Constructor for class org.jscience.physics.model.NaturalModel
 
NAUTICAL_MILE - Static variable in class javax.measure.unit.NonSI
A unit of length equal to 1852.0 m (standard name nmi).
NEWTON - Static variable in class javax.measure.unit.SI
The derived unit for force (N).
NONE - Static variable in class javax.measure.unit.Dimension
Holds dimensionless.
NonSI - Class in javax.measure.unit
This class contains units that are not part of the International System of Units, that is, they are outside the SI, but are important and widely used.
norm() - Method in interface org.jscience.mathematics.structure.VectorSpaceNormed
Returns the positive length or size of this vector.
norm() - Method in class org.jscience.mathematics.vector.ComplexVector
Returns the Euclidian norm of this vector (square root of the dot product of this vector and itself).
norm() - Method in class org.jscience.mathematics.vector.Float64Vector
Returns the Euclidian norm of this vector (square root of the dot product of this vector and itself).
normValue() - Method in class org.jscience.mathematics.vector.Float64Vector
Returns the Float64Vector.norm() value of this vector.
NORTH - Static variable in class org.opengis.referencing.cs.AxisDirection
 
NORTH_EAST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
NORTH_NORTH_EAST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
NORTH_NORTH_WEST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
NORTH_WEST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
northingValue(Unit<Length>) - Method in class org.jscience.geography.coordinates.UTM
Returns the projected distance of the point from the equator.
Number<T extends Number<T>> - Class in org.jscience.mathematics.number
This class represents a value-type number.
Number() - Constructor for class org.jscience.mathematics.number.Number
 
NUMERIC_COMPARATOR - Static variable in class org.jscience.mathematics.vector.LUDecomposition
Holds the default comparator for pivoting.

O

OCTET - Static variable in class javax.measure.unit.NonSI
Equivalent NonSI.BYTE
OHM - Static variable in class javax.measure.unit.SI
The derived unit for electric resistance (Ω or Ohm).
ONE - Static variable in class javax.measure.unit.Unit
Holds the dimensionless unit ONE.
ONE - Static variable in class org.jscience.mathematics.function.Term
Holds the multiplicative identity.
ONE - Static variable in class org.jscience.mathematics.number.Complex
The complex number one.
ONE - Static variable in class org.jscience.mathematics.number.Float64
The 64 bits floating point representing one.
ONE - Static variable in class org.jscience.mathematics.number.FloatingPoint
The floating point instance representing the multiplicative identity.
ONE - Static variable in class org.jscience.mathematics.number.Integer64
The 64 bits floating point representing one.
ONE - Static variable in class org.jscience.mathematics.number.LargeInteger
The large integer representing the multiplicative identity.
ONE - Static variable in class org.jscience.mathematics.number.ModuloInteger
The modulo integer representing the multiplicative identity.
ONE - Static variable in class org.jscience.mathematics.number.Rational
The Rational representing the multiplicative identity.
ONE - Static variable in class org.jscience.mathematics.number.Real
Holds the exact ONE instance.
ONE - Static variable in class org.jscience.physics.amount.Amount
Holds a dimensionless measure of one (exact).
opposite() - Method in class org.jscience.mathematics.function.Polynomial
Returns the opposite of this polynomial.
opposite() - Method in class org.jscience.mathematics.function.RationalFunction
Returns the opposite of this rational function.
opposite() - Method in class org.jscience.mathematics.number.Complex
Returns the negation of this complex.
opposite() - Method in class org.jscience.mathematics.number.Float64
Returns the opposite of this number.
opposite() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the opposite of this floating point number.
opposite() - Method in class org.jscience.mathematics.number.Integer64
Returns the opposite of this number.
opposite() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the opposite of this large integer.
opposite() - Method in class org.jscience.mathematics.number.ModuloInteger
 
opposite() - Method in class org.jscience.mathematics.number.Rational
Returns the opposite of this rational number.
opposite() - Method in class org.jscience.mathematics.number.Real
Returns the negation of this real number.
opposite() - Method in interface org.jscience.mathematics.structure.GroupAdditive
Returns the additive inverse of this object.
opposite() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
opposite() - Method in class org.jscience.mathematics.vector.ComplexVector
 
opposite() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
opposite() - Method in class org.jscience.mathematics.vector.DenseVector
 
opposite() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
opposite() - Method in class org.jscience.mathematics.vector.Float64Vector
 
opposite() - Method in class org.jscience.mathematics.vector.Matrix
Returns the negation of this matrix.
opposite() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
opposite() - Method in class org.jscience.mathematics.vector.SparseVector
 
opposite() - Method in class org.jscience.mathematics.vector.Vector
Returns the negation of this vector.
opposite() - Method in class org.jscience.physics.amount.Amount
Returns the opposite of this measure.
opposite() - Method in class org.opengis.referencing.cs.AxisDirection
 
ordinal() - Method in class org.opengis.util.CodeList
 
org.jscience - package org.jscience
Provides the library classes for versionning, self-tests and performance analysis.
org.jscience.economics.money - package org.jscience.economics.money
Provides support for monetary quantities and their currencies.
org.jscience.geography.coordinates - package org.jscience.geography.coordinates
Provides linear or angular quantities which designate the position that a point occupies in a given reference frame or system.
org.jscience.geography.coordinates.crs - package org.jscience.geography.coordinates.crs
Provides the Coordinate Reference Systems (CRS) specifying how coordinates are to be assigned to spatial/temporal locations.
org.jscience.mathematics.function - package org.jscience.mathematics.function
Provides support for fairly simple symbolic math analysis (to solve algebraic equations, integrate, differentiate, calculate expressions, and so on).
org.jscience.mathematics.number - package org.jscience.mathematics.number
Provides common types of numbers most of them implementing the field interface.
org.jscience.mathematics.structure - package org.jscience.mathematics.structure
Provides mathematical sets (identified by the class parameter) associated to binary operations, such as multiplication or addition, satisfying certain axioms.
org.jscience.mathematics.vector - package org.jscience.mathematics.vector
Provides support for linear algebra in the form of matrices and vectors.
org.jscience.physics.amount - package org.jscience.physics.amount
Provides support for exact or arbitrary precision measurements.
org.jscience.physics.model - package org.jscience.physics.model
Provides models for physical quantities.
org.opengis.metadata - package org.opengis.metadata
 
org.opengis.metadata.citation - package org.opengis.metadata.citation
 
org.opengis.metadata.extent - package org.opengis.metadata.extent
 
org.opengis.referencing - package org.opengis.referencing
 
org.opengis.referencing.crs - package org.opengis.referencing.crs
 
org.opengis.referencing.cs - package org.opengis.referencing.cs
 
org.opengis.spatialschema.geometry - package org.opengis.spatialschema.geometry
 
org.opengis.spatialschema.geometry.geometry - package org.opengis.spatialschema.geometry.geometry
 
org.opengis.util - package org.opengis.util
 
OTHER - Static variable in class org.opengis.referencing.cs.AxisDirection
 
OUNCE - Static variable in class javax.measure.unit.NonSI
A unit of mass equal to 1 / 16 NonSI.POUND (standard name oz).
OUNCE_LIQUID_UK - Static variable in class javax.measure.unit.NonSI
A unit of volume equal to 1 / 160 NonSI.GALLON_UK (standard name oz_fl_uk).
OUNCE_LIQUID_US - Static variable in class javax.measure.unit.NonSI
A unit of volume equal to 1 / 128 NonSI.GALLON_LIQUID_US (standard name oz_fl).

P

parse(CharSequence, int, TextFormat.Cursor) - Static method in class org.jscience.mathematics.number.LargeInteger
Parses the specified character sequence from the specified position as a large integer in the specified radix.
PARSEC - Static variable in class javax.measure.unit.NonSI
A unit of length equal to the distance at which a star would appear to shift its position by one arcsecond over the course the time (about 3 months) in which the Earth moves a distance of NonSI.ASTRONOMICAL_UNIT in the direction perpendicular to the direction to the star (standard name pc).
parseObject(String, ParsePosition) - Method in class javax.measure.unit.UnitFormat
Parses the text from a string to produce an object (implements java.text.Format).
parseProductUnit(CharSequence, ParsePosition) - Method in class javax.measure.unit.UnitFormat.DefaultFormat
 
parseProductUnit(CharSequence, ParsePosition) - Method in class javax.measure.unit.UnitFormat
Parses a sequence of character to produce a unit or a rational product of unit.
parseSingleUnit(CharSequence, ParsePosition) - Method in class javax.measure.unit.UnitFormat.DefaultFormat
 
parseSingleUnit(CharSequence, ParsePosition) - Method in class javax.measure.unit.UnitFormat
Parses a sequence of character to produce a single unit.
PASCAL - Static variable in class javax.measure.unit.SI
The derived unit for pressure, stress (Pa).
PAST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
PERCENT - Static variable in class javax.measure.unit.NonSI
A dimensionless unit equals to 0.01 (standard name %).
PETA(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 1015
PhysicalModel - Class in org.jscience.physics.model
This abstract class represents a physical model.
PhysicalModel() - Constructor for class org.jscience.physics.model.PhysicalModel
Default constructor (allows for derivation).
PICO(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-12
PIXEL - Static variable in class javax.measure.unit.NonSI
A unit of length equal to 1/72 NonSI.INCH (standard name pixel).
plus(double) - Method in class javax.measure.unit.Unit
Returns the result of adding an offset to this unit.
plus(Function<X, Y>) - Method in class org.jscience.mathematics.function.Function
Returns the sum of this function with the one specified.
plus(R) - Method in class org.jscience.mathematics.function.Polynomial
Returns the sum of this polynomial with a constant polynomial having the specified value (convenience method).
plus(Polynomial<R>) - Method in class org.jscience.mathematics.function.Polynomial
Returns the sum of two polynomials.
plus(Function<R, R>) - Method in class org.jscience.mathematics.function.Polynomial
 
plus(RationalFunction<F>) - Method in class org.jscience.mathematics.function.RationalFunction
Returns the sum of two rational functions.
plus(Function<F, F>) - Method in class org.jscience.mathematics.function.RationalFunction
 
plus(Complex) - Method in class org.jscience.mathematics.number.Complex
Returns the sum of this complex with the one specified.
plus(Float64) - Method in class org.jscience.mathematics.number.Float64
Returns the sum of this number with the one specified.
plus(double) - Method in class org.jscience.mathematics.number.Float64
Returns the sum of this number with the specified value.
plus(FloatingPoint) - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the sum of this floating point number with the one specified.
plus(Integer64) - Method in class org.jscience.mathematics.number.Integer64
Returns the sum of this number with the one specified.
plus(long) - Method in class org.jscience.mathematics.number.Integer64
Returns the sum of this number with the specifice value.
plus(long) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the sum of this large integer with the specified long integer (convenience method)
plus(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the sum of this large integer with the one specified.
plus(ModuloInteger) - Method in class org.jscience.mathematics.number.ModuloInteger
 
plus(Rational) - Method in class org.jscience.mathematics.number.Rational
Returns the sum of this rational number with the one specified.
plus(Real) - Method in class org.jscience.mathematics.number.Real
Returns the sum of this real number with the one specified.
plus(G) - Method in interface org.jscience.mathematics.structure.GroupAdditive
Returns the sum of this object with the one specified.
plus(Matrix<Complex>) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
plus(Vector<Complex>) - Method in class org.jscience.mathematics.vector.ComplexVector
 
plus(Matrix<F>) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
plus(Vector<F>) - Method in class org.jscience.mathematics.vector.DenseVector
 
plus(Matrix<Float64>) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
plus(Vector<Float64>) - Method in class org.jscience.mathematics.vector.Float64Vector
 
plus(Matrix<F>) - Method in class org.jscience.mathematics.vector.Matrix
Returns the sum of this matrix with the one specified.
plus(Matrix<F>) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
plus(Vector<F>) - Method in class org.jscience.mathematics.vector.SparseVector
 
plus(Vector<F>) - Method in class org.jscience.mathematics.vector.Vector
Returns the sum of this vector with the one specified.
plus(Amount) - Method in class org.jscience.physics.amount.Amount
Returns the sum of this measure with the one specified.
POINT - Static variable in class javax.measure.unit.NonSI
A unit of length equal to 0.013837 NonSI.INCH exactly (standard name pt).
POISE - Static variable in class javax.measure.unit.NonSI
A unit of dynamic viscosity equal to 1 g/(cm·s) (cgs unit).
PolarCS - Interface in org.opengis.referencing.cs
 
Polynomial<R extends Ring<R>> - Class in org.jscience.mathematics.function
This class represents a mathematical expression involving a sum of powers in one or more variables multiplied by coefficients (such as x² + x·y + 3y²).
Position - Interface in org.opengis.spatialschema.geometry.geometry
 
positionOf(CompoundCoordinates<C1, C2>, CoordinateReferenceSystem.AbsolutePosition) - Method in class org.jscience.geography.coordinates.crs.CompoundCRS
 
positionOf(C, CoordinateReferenceSystem.AbsolutePosition) - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
Returns the absolute position from the coordinates in this reference system.
POUND - Static variable in class javax.measure.unit.NonSI
A unit of mass equal to 453.59237 grams (avoirdupois pound, standard name lb).
POUND_FORCE - Static variable in class javax.measure.unit.NonSI
A unit of force equal to NonSI.POUND·NonSI.G (standard name lbf).
pow(int) - Method in class javax.measure.unit.Dimension
Returns this dimension raised to an exponent.
pow(int) - Method in class javax.measure.unit.Unit
Returns a unit equals to this unit raised to an exponent.
pow(int) - Method in class org.jscience.mathematics.function.Function
Returns this function raised at the specified exponent.
pow(int) - Method in class org.jscience.mathematics.function.Polynomial
 
pow(int) - Method in class org.jscience.mathematics.function.RationalFunction
 
pow(double) - Method in class org.jscience.mathematics.number.Complex
Returns this complex raised to the specified power.
pow(Complex) - Method in class org.jscience.mathematics.number.Complex
Returns this complex raised to the power of the specified complex exponent.
pow(Float64) - Method in class org.jscience.mathematics.number.Float64
Returns this number raised to the power of the specified exponent.
pow(double) - Method in class org.jscience.mathematics.number.Float64
Returns this number raised to the specified power.
pow(int) - Method in class org.jscience.mathematics.number.Number
Returns this number raised at the specified positive exponent.
pow(int) - Method in class org.jscience.mathematics.vector.Matrix
Returns this matrix raised at the specified exponent.
pow(int) - Method in class org.jscience.physics.amount.Amount
Returns this measure raised at the specified exponent.
Power - Interface in javax.measure.quantity
This interface represents the rate at which work is done.
Pressure - Interface in javax.measure.quantity
This interface represents a force applied uniformly over a surface.
PRIME_CERTAINTY - Static variable in class org.jscience.mathematics.number.LargeInteger
Holds the certainty required when testing for primality (default 100, the probability for a composite to pass the primality test is less than 2-100).
ProductUnit<Q extends Quantity> - Class in javax.measure.unit
This class represents units formed by the product of rational powers of existing units.
ProductUnit(Unit<?>) - Constructor for class javax.measure.unit.ProductUnit
Copy constructor (allows for parameterization of product units).
ProjectedCRS<C extends Coordinates<?>> - Class in org.jscience.geography.coordinates.crs
This class represents a 2-dimensional projected reference system.
ProjectedCRS() - Constructor for class org.jscience.geography.coordinates.crs.ProjectedCRS
 
pseudoInverse() - Method in class org.jscience.mathematics.vector.Matrix
Returns the inverse or pseudo-inverse if this matrix if not square.

Q

Quantity - Interface in javax.measure.quantity
This interface represents any type of quantitative properties or attributes of thing.
QuantumModel - Class in org.jscience.physics.model
This class represents the quantum model.
QuantumModel() - Constructor for class org.jscience.physics.model.QuantumModel
 

R

R - Static variable in class org.jscience.physics.amount.Constants
Holds the molar gas constant (N·k)
RAD - Static variable in class javax.measure.unit.NonSI
A unit of radiation dose absorbed equal to a dose of 0.01 joule of energy per kilogram of mass (J/kg) (standard name rd).
RADIAN - Static variable in class javax.measure.unit.SI
The unit for plane angle quantities (rad).
RadiationDoseAbsorbed - Interface in javax.measure.quantity
This interface represents the amount of energy deposited per unit of mass.
RadiationDoseEffective - Interface in javax.measure.quantity
This interface represents the effective (or "equivalent") dose of radiation received by a human or some other living organism.
RadioactiveActivity - Interface in javax.measure.quantity
This interface represents a radioactive activity.
rangeOf(double, double, Unit<Q>) - Static method in class org.jscience.physics.amount.Amount
Returns the measure corresponding to the specified interval stated in the specified unit.
RANKINE - Static variable in class javax.measure.unit.NonSI
A unit of temperature equal to 5/9 °K (standard name °R).
Rational - Class in org.jscience.mathematics.number
This class represents the ratio of two LargeInteger numbers.
RationalConverter - Class in javax.measure.converter
This class represents a converter multiplying numeric values by an exact scaling factor (represented as the quotient of two long numbers).
RationalConverter(long, long) - Constructor for class javax.measure.converter.RationalConverter
Creates a rational converter with the specified dividend and divisor.
RationalFunction<F extends Field<F>> - Class in org.jscience.mathematics.function
This class represents the quotient of two Polynomial, it is also a field (invertible).
readResolve() - Method in class org.opengis.util.CodeList
 
Real - Class in org.jscience.mathematics.number
This class represents a real number of arbitrary precision with known/guaranteed uncertainty.
ReferenceEllipsoid - Class in org.jscience.geography.coordinates.crs
The ReferenceEllipsoid class defines a geodetic reference ellipsoid used as a standard for geodetic measurements.
ReferenceEllipsoid(double, double) - Constructor for class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Constructs an instance of a reference ellipsoid.
ReferenceSystem - Interface in org.opengis.referencing
 
RelativisticModel - Class in org.jscience.physics.model
This class represents the relativistic model.
RelativisticModel() - Constructor for class org.jscience.physics.model.RelativisticModel
 
REM - Static variable in class javax.measure.unit.NonSI
A unit of radiation dose effective equal to 0.01 Sv (standard name rem).
remainder(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the remainder of the division of this large integer with the one specified (convenience method equivalent to this.divide(that).getRemainder()).
REMARKS_KEY - Static variable in interface org.opengis.referencing.IdentifiedObject
 
REVOLUTION - Static variable in class javax.measure.unit.NonSI
A unit of angle equal to a full circle or 2π SI.RADIAN (standard name rev).
RIGHT - Static variable in class org.opengis.referencing.cs.AxisDirection
Deprecated. 
Rinf - Static variable in class org.jscience.physics.amount.Constants
Holds the Rydberg constant (α²·me·c/2h).
Ring<R> - Interface in org.jscience.mathematics.structure
This interface represents an algebraic structure with two binary operations addition and multiplication (+ and ·), such that (R, +) is an abelian group, (R, ·) is a monoid and the multiplication distributes over the addition.
ROENTGEN - Static variable in class javax.measure.unit.NonSI
A unit used to measure the ionizing ability of radiation (standard name Roentgen).
root(int) - Method in class javax.measure.unit.Dimension
Returns the given root of this dimension.
root(int) - Method in class javax.measure.unit.Unit
Returns a unit equals to the given root of this unit.
root(int) - Method in class org.jscience.physics.amount.Amount
Returns the given root of this measure.
round() - Method in class org.jscience.mathematics.number.Float64
Returns the closest integer value to this 64 bits floating point number.
round() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the closest integer to this floating point number.
round() - Method in class org.jscience.mathematics.number.Rational
Returns the closest integer value to this rational number.
round() - Method in class org.jscience.mathematics.number.Real
Returns the closest integer value to this rational number.
ROW_NEGATIVE - Static variable in class org.opengis.referencing.cs.AxisDirection
 
ROW_POSITIVE - Static variable in class org.opengis.referencing.cs.AxisDirection
 
RUTHERFORD - Static variable in class javax.measure.unit.NonSI
A unit of radioctive activity equal to 1 million radioactive disintegrations per second (standard name Rd).

S

SCOPE_KEY - Static variable in interface org.opengis.referencing.ReferenceSystem
 
SECOND - Static variable in class javax.measure.unit.SI
The base unit for duration quantities (s).
SECOND_ANGLE - Static variable in class javax.measure.unit.NonSI
A unit of angle equal to 1/60 NonSI.MINUTE_ANGLE (standard name ").
select() - Static method in class org.jscience.physics.model.HighEnergyModel
Selects the relativistic model as the current model.
select() - Static method in class org.jscience.physics.model.NaturalModel
Selects the relativistic model as the current model.
select() - Static method in class org.jscience.physics.model.QuantumModel
Selects the relativistic model as the current model.
select() - Static method in class org.jscience.physics.model.RelativisticModel
Selects the relativistic model as the current model.
select() - Static method in class org.jscience.physics.model.StandardModel
Selects the standard model as the current model.
set(X) - Method in class org.jscience.mathematics.function.Variable.Global
 
set(X) - Method in class org.jscience.mathematics.function.Variable.Local
 
setCurrent(PhysicalModel) - Static method in class org.jscience.physics.model.PhysicalModel
Sets the current model (this method is called when the a predefined model is selected).
setDigits(int) - Static method in class org.jscience.mathematics.number.FloatingPoint
Sets the local number of digits to be used during calculations.
setExactPrecision(int) - Static method in class org.jscience.mathematics.number.Real
Sets the local minimum precision (number of exact digits) when exact numbers have to be approximated.
setExchangeRate(double) - Method in class org.jscience.economics.money.Currency
Sets the exchange rate of this Currency relatively to the reference currency.
setInstance(AmountFormat) - Static method in class org.jscience.physics.amount.AmountFormat
Sets the current local format.
setModel(Dimension.Model) - Static method in class javax.measure.unit.Dimension
Sets the model used to determinate the units dimensions.
setModulus(LargeInteger) - Static method in class org.jscience.mathematics.number.ModuloInteger
Sets the local modulus for modular arithmetic.
setOrdinate(int, double) - Method in class org.jscience.geography.coordinates.Coordinates
OpenGIS® - Throws UnsupportedOperationException as JScience coordinates are immutable.
setOrdinate(int, double) - Method in interface org.opengis.spatialschema.geometry.DirectPosition
 
setPivotComparator(Comparator<Field>) - Static method in class org.jscience.mathematics.vector.LUDecomposition
Sets the local comparator used for pivoting or null to disable pivoting.
setReferenceCurrency(Currency) - Static method in class org.jscience.economics.money.Currency
Sets the reference currency (context-local).
shiftLeft(int) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the value of this large integer after performing a binary shift to left.
shiftRight(int) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the value of this large integer after performing a binary shift to right with sign extension (-1 >> 1 == -1).
shortValue() - Method in class org.jscience.mathematics.number.Number
Returns the value of this number as a short.
SI - Class in javax.measure.unit
This class contains SI (Système International d'Unités) base units, and derived units.
SIEMENS - Static variable in class javax.measure.unit.SI
The derived unit for electric conductance (S).
SIEVERT - Static variable in class javax.measure.unit.SI
The derived unit for dose equivalent (Sv).
size() - Method in class org.jscience.mathematics.function.Term
Returns the number of variables for this term.
SolidAngle - Interface in javax.measure.quantity
This interface represents the angle formed by three or more planes intersecting at a common point.
solve(Matrix<F>) - Method in class org.jscience.mathematics.vector.LUDecomposition
Returns the solution X of the equation: A * X = B with this = A.lu() using back and forward substitutions.
solve(Vector<F>) - Method in class org.jscience.mathematics.vector.Matrix
Solves this matrix for the specified vector (returns x such as this · x = y).
solve(Matrix<F>) - Method in class org.jscience.mathematics.vector.Matrix
Solves this matrix for the specified matrix (returns x such as this · x = y).
solve(Matrix<F>) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
SOUTH - Static variable in class org.opengis.referencing.cs.AxisDirection
 
SOUTH_EAST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
SOUTH_SOUTH_EAST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
SOUTH_SOUTH_WEST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
SOUTH_WEST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
SparseMatrix<F extends Field<F>> - Class in org.jscience.mathematics.vector
This class represents a matrix made of sparse vectors (as rows).
SparseVector<F extends Field<F>> - Class in org.jscience.mathematics.vector
This class represents a sparse vector.
SPHERE - Static variable in class javax.measure.unit.NonSI
A unit of solid angle equal to 4 π steradians (standard name sphere).
SphericalCS - Interface in org.opengis.referencing.cs
 
sqrt() - Method in class org.jscience.mathematics.number.Complex
Returns one of the two square root of this complex number.
sqrt() - Method in class org.jscience.mathematics.number.Float64
Returns the positive square root of this number.
sqrt() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the square root of this floating point number.
sqrt() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the integer square root of this integer.
sqrt() - Method in class org.jscience.mathematics.number.Real
Returns the square root of this real number, the more accurate is this real number, the more accurate the square root.
sqrt() - Method in class org.jscience.physics.amount.Amount
Returns the square root of this measure.
SQUARE_METRE - Static variable in class javax.measure.unit.SI
The metric unit for area quantities ().
STANDARD - Static variable in interface javax.measure.unit.Dimension.Model
Holds the standard model (default).
StandardModel - Class in org.jscience.physics.model
This class represents the standard model.
StandardModel() - Constructor for class org.jscience.physics.model.StandardModel
Default constructor (allows for derivation).
STERADIAN - Static variable in class javax.measure.unit.SI
The unit for solid angle quantities (sr).
STOKE - Static variable in class javax.measure.unit.NonSI
A unit of kinematic viscosity equal to 1 cm²/s (cgs unit).
Structure<T> - Interface in org.jscience.mathematics.structure
This interface represents a mathematical structure on a set (type).
SystemOfUnits - Class in javax.measure.unit
This class represents a system of units, it groups units together for historical or cultural reasons.
SystemOfUnits() - Constructor for class javax.measure.unit.SystemOfUnits
 

T

Temperature - Interface in javax.measure.quantity
This class represents the degree of hotness or coldness of a body or an environment.
TEMPERATURE - Static variable in class javax.measure.unit.Dimension
Holds temperature dimension (θ).
TemporalCRS<C extends Coordinates<?>> - Class in org.jscience.geography.coordinates.crs
This class represents a 1 dimensional temporal reference system.
TemporalCRS() - Constructor for class org.jscience.geography.coordinates.crs.TemporalCRS
 
tensor(Matrix<Complex>) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
tensor(Matrix<F>) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
tensor(Matrix<Float64>) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
tensor(Matrix<F>) - Method in class org.jscience.mathematics.vector.Matrix
Returns the linear algebraic matrix tensor product of this matrix and another (Kronecker product).
tensor(Matrix<F>) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
TERA(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 1012
Term - Class in org.jscience.mathematics.function
This class represents the term of a polynomial such as x·y².
TESLA - Static variable in class javax.measure.unit.SI
The derived unit for magnetic flux density (T).
TIME - Static variable in class javax.measure.unit.Dimension
Holds time dimension (T).
Time - Class in org.jscience.geography.coordinates
This class represents the temporal UTC time coordinates.
Time(double, Unit<Duration>) - Constructor for class org.jscience.geography.coordinates.Time
Creates the temporal position corresponding to the specified coordinates.
TIME_CS - Static variable in class org.jscience.geography.coordinates.crs.TemporalCRS
Holds the time coordinate system.
TimeCS - Interface in org.opengis.referencing.cs
 
times(Dimension) - Method in class javax.measure.unit.Dimension
Returns the product of this dimension with the one specified.
times(long) - Method in class javax.measure.unit.Unit
Returns the result of multiplying this unit by an exact factor.
times(double) - Method in class javax.measure.unit.Unit
Returns the result of multiplying this unit by a an approximate factor
times(Unit<?>) - Method in class javax.measure.unit.Unit
Returns the product of this unit with the one specified.
times(Function<X, Y>) - Method in class org.jscience.mathematics.function.Function
Returns the product of this function with the one specified.
times(R) - Method in class org.jscience.mathematics.function.Polynomial
Returns the product of this polynomial with a constant polynomial having the specified value (convenience method).
times(Polynomial<R>) - Method in class org.jscience.mathematics.function.Polynomial
Returns the product of two polynomials.
times(Function<R, R>) - Method in class org.jscience.mathematics.function.Polynomial
 
times(RationalFunction<F>) - Method in class org.jscience.mathematics.function.RationalFunction
Returns the product of two rational functions.
times(Function<F, F>) - Method in class org.jscience.mathematics.function.RationalFunction
 
times(Term) - Method in class org.jscience.mathematics.function.Term
Return the product of this term with the one specified.
times(double) - Method in class org.jscience.mathematics.number.Complex
Returns this complex multiplied by the specified factor.
times(Complex) - Method in class org.jscience.mathematics.number.Complex
Returns the product of this complex with the one specified.
times(Float64) - Method in class org.jscience.mathematics.number.Float64
Returns the product of this number with the one specified.
times(double) - Method in class org.jscience.mathematics.number.Float64
Returns the product of this number with the specified value.
times(long) - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the product of this floating point number with the specified long multiplier.
times(FloatingPoint) - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the product of this floating point number with the one specified.
times(Integer64) - Method in class org.jscience.mathematics.number.Integer64
Returns the product of this number with the one specified.
times(long) - Method in class org.jscience.mathematics.number.Integer64
Returns the product of this number with the specified value.
times(LargeInteger) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the product of this large integer with the one specified.
times(long) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the product of this large integer with the specified long multiplier.
times(ModuloInteger) - Method in class org.jscience.mathematics.number.ModuloInteger
 
times(long) - Method in class org.jscience.mathematics.number.Rational
Returns the product of this rational number with the specified long multiplier.
times(Rational) - Method in class org.jscience.mathematics.number.Rational
Returns the product of this rational number with the one specified.
times(long) - Method in class org.jscience.mathematics.number.Real
Returns the product of this real number with the specified long multiplier.
times(Real) - Method in class org.jscience.mathematics.number.Real
Returns the product of this real number with the one specified.
times(G) - Method in interface org.jscience.mathematics.structure.GroupMultiplicative
Returns the product of this object with the one specified.
times(R) - Method in interface org.jscience.mathematics.structure.Ring
Returns the product of this object with the one specified.
times(F) - Method in interface org.jscience.mathematics.structure.VectorSpace
Returns the scalar multiplication of this vector by the specified field element.
times(Complex) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
times(Vector<Complex>) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
times(Matrix<Complex>) - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
times(Complex) - Method in class org.jscience.mathematics.vector.ComplexVector
 
times(Vector<Complex>) - Method in class org.jscience.mathematics.vector.ComplexVector
 
times(F) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
times(Vector<F>) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
times(Matrix<F>) - Method in class org.jscience.mathematics.vector.DenseMatrix
 
times(F) - Method in class org.jscience.mathematics.vector.DenseVector
 
times(Vector<F>) - Method in class org.jscience.mathematics.vector.DenseVector
 
times(Float64) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
times(Vector<Float64>) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
times(Matrix<Float64>) - Method in class org.jscience.mathematics.vector.Float64Matrix
 
times(Float64) - Method in class org.jscience.mathematics.vector.Float64Vector
 
times(double) - Method in class org.jscience.mathematics.vector.Float64Vector
Equivalent to this.times(Float64.valueOf(k))
times(Vector<Float64>) - Method in class org.jscience.mathematics.vector.Float64Vector
 
times(F) - Method in class org.jscience.mathematics.vector.Matrix
Returns the product of this matrix by the specified factor.
times(Vector<F>) - Method in class org.jscience.mathematics.vector.Matrix
Returns the product of this matrix by the specified vector.
times(Matrix<F>) - Method in class org.jscience.mathematics.vector.Matrix
Returns the product of this matrix with the one specified.
times(F) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
times(Vector<F>) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
times(Matrix<F>) - Method in class org.jscience.mathematics.vector.SparseMatrix
 
times(F) - Method in class org.jscience.mathematics.vector.SparseVector
 
times(Vector<F>) - Method in class org.jscience.mathematics.vector.SparseVector
 
times(F) - Method in class org.jscience.mathematics.vector.Vector
Returns the product of this vector with the specified coefficient.
times(Vector<F>) - Method in class org.jscience.mathematics.vector.Vector
Returns the dot product of this vector with the one specified.
times(long) - Method in class org.jscience.physics.amount.Amount
Returns this measure scaled by the specified exact factor (dimensionless).
times(double) - Method in class org.jscience.physics.amount.Amount
Returns this measure scaled by the specified approximate factor (dimensionless).
times(Amount) - Method in class org.jscience.physics.amount.Amount
Returns the product of this measure with the one specified.
times10pow(int) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the value of this large integer after multiplication by a power of ten.
times2pow(int) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the value of this large integer after multiplication by a power of two.
timeUTC - Variable in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem.AbsolutePosition
Holds the Time since midnight, January 1, 1970 UTC.
to(Unit<Q>) - Method in class javax.measure.DecimalMeasure
Returns the decimal measure equivalent to this measure but stated in the specified unit.
to(Unit<Q>, MathContext) - Method in class javax.measure.DecimalMeasure
Returns the decimal measure equivalent to this measure but stated in the specified unit, the conversion is performed using the specified math context.
to(Unit<Q>) - Method in class javax.measure.Measure
Returns the measure equivalent to this measure but stated in the specified unit.
to(Unit<Q>) - Method in class javax.measure.VectorMeasure
Returns the measurement vector equivalent to this one but stated in the specified unit.
to(Unit<R>) - Method in class org.jscience.physics.amount.Amount
Returns the measure equivalent to this measure but stated in the specified unit.
toByteArray(byte[], int) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the two's-complement binary representation of this large integer.
TON_UK - Static variable in class javax.measure.unit.NonSI
A unit of mass equal to 2240 NonSI.POUND (long ton, standard name ton_uk).
TON_US - Static variable in class javax.measure.unit.NonSI
A unit of mass equal to 2000 NonSI.POUND (short ton, standard name ton_us).
TOP - Static variable in class org.opengis.referencing.cs.AxisDirection
Deprecated. 
toParentUnit() - Method in class javax.measure.unit.TransformedUnit
Returns the converter to the parent unit.
Torque - Interface in javax.measure.quantity
This interface represents the moment of a force.
toStandardUnit() - Method in class javax.measure.unit.AlternateUnit
 
toStandardUnit() - Method in class javax.measure.unit.BaseUnit
 
toStandardUnit() - Method in class javax.measure.unit.CompoundUnit
 
toStandardUnit() - Method in class javax.measure.unit.ProductUnit
 
toStandardUnit() - Method in class javax.measure.unit.TransformedUnit
 
toStandardUnit() - Method in class javax.measure.unit.Unit
Returns the converter from this unit to its system unit.
toStandardUnit() - Method in class org.jscience.economics.money.Currency
 
toString() - Method in class javax.measure.Measure
Returns the String representation of this measure The string produced for a given measure is always the same; it is not affected by locale.
toString() - Method in class javax.measure.unit.Dimension
Returns the representation of this dimension.
toString() - Method in class javax.measure.unit.Unit
Returns the standard String representation of this unit.
toString() - Method in class javax.measure.VectorMeasure
Returns the String representation of this measurement vector (for example [2.3 m/s, 5.6 m/s]).
toString() - Method in class org.jscience.geography.coordinates.Coordinates
Returns the text representation of these coordinates as a java.lang.String.
toString() - Method in class org.jscience.mathematics.function.Function
Returns the text representation of this function as a java.lang.String.
toString() - Method in class org.jscience.mathematics.function.Term
Returns the text representation of this term as a java.lang.String.
toString() - Method in class org.jscience.mathematics.number.Number
Returns the text representation of this number as a java.lang.String.
toString() - Method in class org.jscience.mathematics.vector.Matrix
Returns the text representation of this matrix as a java.lang.String.
toString() - Method in class org.jscience.mathematics.vector.Vector
Returns the text representation of this vector as a java.lang.String.
toString() - Method in class org.jscience.physics.amount.Amount
Returns the text representation of this amount as a java.lang.String.
toString() - Method in class org.opengis.util.CodeList
 
toText() - Method in class org.jscience.geography.coordinates.Coordinates
Returns the string representation of this coordinates.
toText() - Method in class org.jscience.mathematics.function.DiscreteFunction
 
toText() - Method in class org.jscience.mathematics.function.Function
Returns the textual representation of this real-time object (equivalent to toString except that the returned value can be allocated from the local context space).
toText() - Method in class org.jscience.mathematics.function.Polynomial
 
toText() - Method in class org.jscience.mathematics.function.RationalFunction
 
toText() - Method in class org.jscience.mathematics.function.Term
Returns the text representation of this term.
toText() - Method in class org.jscience.mathematics.number.Complex
Returns the text representation of this complex number.
toText() - Method in class org.jscience.mathematics.number.Float64
Returns the decimal text representation of this number.
toText() - Method in class org.jscience.mathematics.number.FloatingPoint
Returns the decimal text representation of this number.
toText() - Method in class org.jscience.mathematics.number.Integer64
Returns the decimal text representation of this number.
toText() - Method in class org.jscience.mathematics.number.LargeInteger
Returns the text representation of this number using the current format.
toText(int) - Method in class org.jscience.mathematics.number.LargeInteger
Returns the text representation of this number in the specified radix.
toText() - Method in class org.jscience.mathematics.number.ModuloInteger
Returns the text representation of the current modulo value of this number.
toText() - Method in class org.jscience.mathematics.number.Number
Returns the textual representation of this real-time object (equivalent to toString except that the returned value can be allocated from the local context space).
toText() - Method in class org.jscience.mathematics.number.Rational
Returns the decimal text representation of this number.
toText() - Method in class org.jscience.mathematics.number.Real
Returns the decimal text representation of this number.
toText() - Method in class org.jscience.mathematics.vector.Matrix
Returns the text representation of this matrix.
toText() - Method in class org.jscience.mathematics.vector.Vector
Returns the text representation of this vector.
toText() - Method in class org.jscience.physics.amount.Amount
Returns the text representation of this measure.
toVector(Unit<Length>) - Method in class org.jscience.geography.coordinates.XYZ
Returns the x/y/z coordinates value as a 3-dimensional vector.
toWKT() - Method in class org.jscience.geography.coordinates.crs.CoordinateReferenceSystem
OpenGIS® - Returns a Well Known Text (WKT) for this object.
toWKT() - Method in interface org.opengis.referencing.IdentifiedObject
 
tP - Static variable in class org.jscience.physics.amount.Constants
Holds the Planck time (lP/c)
trace() - Method in class org.jscience.mathematics.vector.Matrix
Returns the trace of this matrix.
transform(UnitConverter) - Method in class javax.measure.unit.Unit
Returns the unit derived from this unit using the specified converter.
TransformedUnit<Q extends Quantity> - Class in javax.measure.unit
This class represents the units derived from other units using converters.
transpose() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
transpose() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
transpose() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
transpose() - Method in class org.jscience.mathematics.vector.Matrix
Returns the transpose of this matrix.
transpose() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
TWD - Static variable in class org.jscience.economics.money.Currency
The Taiwanese dollar currency.
two_π - Static variable in class org.jscience.physics.amount.Constants
Holds 2·Constants.π.

U

UNIT - Static variable in interface javax.measure.quantity.Acceleration
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.AmountOfSubstance
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Angle
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.AngularAcceleration
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.AngularVelocity
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Area
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.CatalyticActivity
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.DataAmount
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.DataRate
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Dimensionless
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Duration
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.DynamicViscosity
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.ElectricCapacitance
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.ElectricCharge
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.ElectricConductance
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.ElectricCurrent
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.ElectricInductance
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.ElectricPotential
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.ElectricResistance
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Energy
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Force
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Frequency
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Illuminance
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.KinematicViscosity
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Length
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.LuminousFlux
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.LuminousIntensity
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.MagneticFlux
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.MagneticFluxDensity
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Mass
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.MassFlowRate
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Power
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Pressure
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.RadiationDoseAbsorbed
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.RadiationDoseEffective
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.RadioactiveActivity
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.SolidAngle
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Temperature
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Torque
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Velocity
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.Volume
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.VolumetricDensity
Holds the SI unit (Système International d'Unités) for this quantity.
UNIT - Static variable in interface javax.measure.quantity.VolumetricFlowRate
Holds the SI unit (Système International d'Unités) for this quantity.
Unit<Q extends Quantity> - Class in javax.measure.unit
This class represents a determinate quantity (as of length, time, heat, or value) adopted as a standard of measurement.
Unit() - Constructor for class javax.measure.unit.Unit
Default constructor.
UnitConverter - Class in javax.measure.converter
This class represents a converter of numeric values.
UnitConverter() - Constructor for class javax.measure.converter.UnitConverter
Default constructor.
unitFor(String) - Method in class javax.measure.unit.UnitFormat.ASCIIFormat
 
unitFor(String) - Method in class javax.measure.unit.UnitFormat.DefaultFormat
 
UnitFormat - Class in javax.measure.unit
This class provides the interface for formatting and parsing units.
UnitFormat() - Constructor for class javax.measure.unit.UnitFormat
Base constructor.
UnitFormat.ASCIIFormat - Class in javax.measure.unit
This class represents the ASCIIFormat format.
UnitFormat.ASCIIFormat() - Constructor for class javax.measure.unit.UnitFormat.ASCIIFormat
 
UnitFormat.DefaultFormat - Class in javax.measure.unit
This class represents the standard format.
UnitFormat.DefaultFormat() - Constructor for class javax.measure.unit.UnitFormat.DefaultFormat
 
UP - Static variable in class org.opengis.referencing.cs.AxisDirection
 
UPS_FALSE_EASTING - Static variable in class org.jscience.geography.coordinates.UTM
The UPS "false easting" value.
UPS_FALSE_NORTHING - Static variable in class org.jscience.geography.coordinates.UTM
The UPS "false northing" value.
UPS_SCALE_FACTOR - Static variable in class org.jscience.geography.coordinates.UTM
The UPS scale factor.
upsToLatLong(UTM, ReferenceEllipsoid) - Static method in class org.jscience.geography.coordinates.UTM
Converts the UPS coordinates to latitude/longitude coordinates, based on the specified reference ellipsoid.
USD - Static variable in class org.jscience.economics.money.Currency
The United State dollar currency.
UserDefinedCS - Interface in org.opengis.referencing.cs
 
UTM - Class in org.jscience.geography.coordinates
This class represents the projected Universal Transverse Mercator (UTM) coordinates onto the WGS84 ellipsoid.
UTM_FALSE_EASTING - Static variable in class org.jscience.geography.coordinates.UTM
The UTM "false easting" value.
UTM_FALSE_NORTHING - Static variable in class org.jscience.geography.coordinates.UTM
The UTM "false northing" value.
UTM_NORTHERN_LIMIT - Static variable in class org.jscience.geography.coordinates.UTM
The northern limit of the UTM grid.
UTM_SCALE_FACTOR - Static variable in class org.jscience.geography.coordinates.UTM
The UTM scale factor.
UTM_SOUTHERN_LIMIT - Static variable in class org.jscience.geography.coordinates.UTM
The southern limit of the UTM grid.
utmToLatLong(UTM, ReferenceEllipsoid) - Static method in class org.jscience.geography.coordinates.UTM
Converts the UTM coordinates to latitude/longitude coordinates, based on the specified reference ellipsoid.

V

VALID_AREA_KEY - Static variable in interface org.opengis.referencing.ReferenceSystem
 
valueOf(BigDecimal, Unit<Q>) - Static method in class javax.measure.DecimalMeasure
Returns the decimal measure for the specified number stated in the specified unit.
valueOf(CharSequence) - Static method in class javax.measure.DecimalMeasure
Returns the decimal measure for the specified textual representation.
valueOf(double, Unit<Q>) - Static method in class javax.measure.Measure
Returns the scalar measure for the specified double stated in the specified unit.
valueOf(long, Unit<Q>) - Static method in class javax.measure.Measure
Returns the scalar measure for the specified double stated in the specified unit.
valueOf(float, Unit<Q>) - Static method in class javax.measure.Measure
Returns the scalar measure for the specified float stated in the specified unit.
valueOf(int, Unit<Q>) - Static method in class javax.measure.Measure
Returns the scalar measure for the specified int stated in the specified unit.
valueOf(BigDecimal, Unit<Q>) - Static method in class javax.measure.Measure
Deprecated.
DecimalMeasure should be used directly.
valueOf(BigDecimal, Unit<Q>, MathContext) - Static method in class javax.measure.Measure
Deprecated.
DecimalMeasure should be used directly and MathContext specified explicitly when converting.
valueOf(double[], Unit<Q>) - Static method in class javax.measure.Measure
Deprecated.
VectorMeasure should be used directly.
valueOf(CharSequence) - Static method in class javax.measure.unit.Unit
Returns a unit instance that is defined from the specified character sequence using the standard unit format.
valueOf(double, double, Unit<Q>) - Static method in class javax.measure.VectorMeasure
Returns a 2-dimensional measurement vector.
valueOf(double, double, double, Unit<Q>) - Static method in class javax.measure.VectorMeasure
Returns a 3-dimensional measurement vector.
valueOf(double[], Unit<Q>) - Static method in class javax.measure.VectorMeasure
Returns a multi-dimensional measurement vector.
valueOf(double, Unit<Length>) - Static method in class org.jscience.geography.coordinates.Altitude
Returns the vertical position corresponding to the specified coordinates.
valueOf(T1, T2) - Static method in class org.jscience.geography.coordinates.CompoundCoordinates
Returns a compound coordinates made up of the specified coordinates.
valueOf(double, Unit<Length>) - Static method in class org.jscience.geography.coordinates.Height
Returns the vertical position corresponding to the specified coordinates.
valueOf(double, double, Unit<Angle>) - Static method in class org.jscience.geography.coordinates.LatLong
Returns the surface position corresponding to the specified coordinates.
valueOf(double, Unit<Duration>) - Static method in class org.jscience.geography.coordinates.Time
Returns the temporal position corresponding to the specified coordinates.
valueOf(Date) - Static method in class org.jscience.geography.coordinates.Time
Returns the temporal position corresponding to the specified date.
valueOf(int, char, double, double, Unit<Length>) - Static method in class org.jscience.geography.coordinates.UTM
Returns the projected UTM position corresponding to the specified coordinates.
valueOf(double, double, double, Unit<Length>) - Static method in class org.jscience.geography.coordinates.XYZ
Returns the spatial position corresponding to the specified coordinates.
valueOf(Float64Vector, Unit<Length>) - Static method in class org.jscience.geography.coordinates.XYZ
Returns the spatial position corresponding to the specified 3-dimensional vector.
valueOf(R) - Static method in class org.jscience.mathematics.function.Constant
Returns a constant function of specified value.
valueOf(R, Variable<R>) - Static method in class org.jscience.mathematics.function.Polynomial
Returns an univariate polynomial of degree one with the specified coefficient multiplier.
valueOf(R, Term) - Static method in class org.jscience.mathematics.function.Polynomial
Returns a polynomial corresponding to the specified term with the specified coefficient multiplier.
valueOf(Polynomial<F>, Polynomial<F>) - Static method in class org.jscience.mathematics.function.RationalFunction
Returns the rational function from the specified dividend and divisor.
valueOf(Variable<?>, int) - Static method in class org.jscience.mathematics.function.Term
Return the term corresponding to the specified variable raised to the specified power.
valueOf(double, double) - Static method in class org.jscience.mathematics.number.Complex
Returns the complex number having the specified real and imaginary components.
valueOf(CharSequence) - Static method in class org.jscience.mathematics.number.Complex
Returns the complex number for the specified character sequence.
valueOf(double) - Static method in class org.jscience.mathematics.number.Float64
Returns the 64 bits float from the specified double value.
valueOf(CharSequence) - Static method in class org.jscience.mathematics.number.Float64
Returns the number for the specified character sequence.
valueOf(LargeInteger, int) - Static method in class org.jscience.mathematics.number.FloatingPoint
Returns the floating point number for the specified LargeInteger significand and power of two exponent.
valueOf(long, int) - Static method in class org.jscience.mathematics.number.FloatingPoint
Returns the floating point number for the specified long significand and power of two exponent (convenience method).
valueOf(long) - Static method in class org.jscience.mathematics.number.FloatingPoint
Returns the floating point number for the specified long value (convenience method).
valueOf(double) - Static method in class org.jscience.mathematics.number.FloatingPoint
Returns the floating point number for the specified double value (convenience method).
valueOf(CharSequence) - Static method in class org.jscience.mathematics.number.FloatingPoint
Returns the floating point number for the specified character sequence.
valueOf(long) - Static method in class org.jscience.mathematics.number.Integer64
Returns the 64 bits integer from the specified long value.
valueOf(CharSequence) - Static method in class org.jscience.mathematics.number.Integer64
Returns the number for the specified character sequence.
valueOf(long) - Static method in class org.jscience.mathematics.number.LargeInteger
Returns the large integer of specified long value.
valueOf(byte[], int, int) - Static method in class org.jscience.mathematics.number.LargeInteger
Returns the large integer of specified two's-complement binary representation.
valueOf(CharSequence) - Static method in class org.jscience.mathematics.number.LargeInteger
Returns the large integer for the specified character sequence using the current format.
valueOf(CharSequence, int) - Static method in class org.jscience.mathematics.number.LargeInteger
Returns the large integer for the specified character sequence in the specified radix.
valueOf(BigInteger) - Static method in class org.jscience.mathematics.number.LargeInteger
Returns the large integer corresponding to the specified java.math.BigInteger instance.
valueOf(LargeInteger) - Static method in class org.jscience.mathematics.number.ModuloInteger
Returns the modulo integer having the specified value (independently of the current modulo).
valueOf(CharSequence) - Static method in class org.jscience.mathematics.number.ModuloInteger
Returns the modulo integer for the specified character sequence in decimal number.
valueOf(long, long) - Static method in class org.jscience.mathematics.number.Rational
Returns the rational number for the specified integer dividend and divisor.
valueOf(LargeInteger, LargeInteger) - Static method in class org.jscience.mathematics.number.Rational
Returns the rational number for the specified large integer dividend and divisor.
valueOf(CharSequence) - Static method in class org.jscience.mathematics.number.Rational
Returns the rational number for the specified character sequence.
valueOf(LargeInteger, int, int) - Static method in class org.jscience.mathematics.number.Real
Returns a real having the specified significand, error and exponent values.
valueOf(double) - Static method in class org.jscience.mathematics.number.Real
Returns the real number (inexact except for 0.0) corresponding to the specified double value.
valueOf(long) - Static method in class org.jscience.mathematics.number.Real
Returns the exact real number corresponding to the specified long value (convenience method).
valueOf(CharSequence) - Static method in class org.jscience.mathematics.number.Real
Returns the real for the specified character sequence.
valueOf(Complex[][]) - Static method in class org.jscience.mathematics.vector.ComplexMatrix
Returns a complex matrix from the specified 2-dimensional array.
valueOf(ComplexVector...) - Static method in class org.jscience.mathematics.vector.ComplexMatrix
Returns a complex matrix holding the specified row vectors (column vectors if transposed).
valueOf(List<ComplexVector>) - Static method in class org.jscience.mathematics.vector.ComplexMatrix
Returns a complex matrix holding the row vectors from the specified collection (column vectors if transposed).
valueOf(Matrix<Complex>) - Static method in class org.jscience.mathematics.vector.ComplexMatrix
Returns a complex matrix equivalent to the specified matrix.
valueOf(Complex...) - Static method in class org.jscience.mathematics.vector.ComplexVector
Returns a new vector holding the specified complex numbers.
valueOf(List<Complex>) - Static method in class org.jscience.mathematics.vector.ComplexVector
Returns a new vector holding the elements from the specified collection.
valueOf(Vector<Complex>) - Static method in class org.jscience.mathematics.vector.ComplexVector
Returns a ComplexVector instance equivalent to the specified vector.
valueOf(F[][]) - Static method in class org.jscience.mathematics.vector.DenseMatrix
Returns a dense matrix from the specified 2-dimensional array.
valueOf(DenseVector<F>...) - Static method in class org.jscience.mathematics.vector.DenseMatrix
Returns a dense matrix holding the specified row vectors (column vectors if transposed).
valueOf(List<DenseVector<F>>) - Static method in class org.jscience.mathematics.vector.DenseMatrix
Returns a dense matrix holding the row vectors from the specified collection (column vectors if transposed).
valueOf(Matrix<F>) - Static method in class org.jscience.mathematics.vector.DenseMatrix
Returns a dense matrix equivalent to the specified matrix.
valueOf(F...) - Static method in class org.jscience.mathematics.vector.DenseVector
Returns a dense vector holding the specified elements.
valueOf(List<F>) - Static method in class org.jscience.mathematics.vector.DenseVector
Returns a dense vector holding the elements from the specified collection.
valueOf(Vector<F>) - Static method in class org.jscience.mathematics.vector.DenseVector
Returns a dense vector equivalent to the specified vector.
valueOf(double[][]) - Static method in class org.jscience.mathematics.vector.Float64Matrix
Returns a dense matrix from a 2-dimensional array of double values.
valueOf(Float64Vector...) - Static method in class org.jscience.mathematics.vector.Float64Matrix
Returns a complex matrix holding the specified row vectors (column vectors if transposed).
valueOf(List<Float64Vector>) - Static method in class org.jscience.mathematics.vector.Float64Matrix
Returns a complex matrix holding the row vectors from the specified collection (column vectors if transposed).
valueOf(Matrix<Float64>) - Static method in class org.jscience.mathematics.vector.Float64Matrix
Returns a complex matrix equivalent to the specified matrix.
valueOf(double...) - Static method in class org.jscience.mathematics.vector.Float64Vector
Returns a new vector holding the specified double values.
valueOf(List<Float64>) - Static method in class org.jscience.mathematics.vector.Float64Vector
Returns a new vector holding the elements from the specified collection.
valueOf(Vector<Float64>) - Static method in class org.jscience.mathematics.vector.Float64Vector
Returns a Float64Vector instance equivalent to the specified vector.
valueOf(Matrix<F>) - Static method in class org.jscience.mathematics.vector.LUDecomposition
Returns the lower/upper decomposition of the specified matrix.
valueOf(Vector<F>, F) - Static method in class org.jscience.mathematics.vector.SparseMatrix
Returns the sparse square matrix having the specified diagonal vector.
valueOf(SparseVector<F>...) - Static method in class org.jscience.mathematics.vector.SparseMatrix
Returns a sparse matrix holding the specified row vectors (column vectors if transposed).
valueOf(List<SparseVector<F>>) - Static method in class org.jscience.mathematics.vector.SparseMatrix
Returns a sparse matrix holding the row vectors from the specified collection (column vectors if transposed).
valueOf(Matrix<F>, F) - Static method in class org.jscience.mathematics.vector.SparseMatrix
Returns a sparse matrix equivalent to the specified matrix but with the zero elements removed using the default object equality comparator.
valueOf(Matrix<F>, F, FastComparator<? super F>) - Static method in class org.jscience.mathematics.vector.SparseMatrix
Returns a sparse matrix equivalent to the specified matrix but with the zero elements removed using the specified object equality comparator.
valueOf(int, F, int, F) - Static method in class org.jscience.mathematics.vector.SparseVector
Returns a sparse vector having a single element at the specified index.
valueOf(int, F, Map<Index, F>) - Static method in class org.jscience.mathematics.vector.SparseVector
Returns a sparse vector from the specified index to element mapping.
valueOf(Vector<F>, F) - Static method in class org.jscience.mathematics.vector.SparseVector
Returns a sparse vector equivalent to the specified vector but with the zero elements removed removed using a default object equality comparator.
valueOf(Vector<F>, F, FastComparator<? super F>) - Static method in class org.jscience.mathematics.vector.SparseVector
Returns a sparse vector equivalent to the specified vector but with the zero elements removed using the specified object equality comparator.
valueOf(long, Unit<Q>) - Static method in class org.jscience.physics.amount.Amount
Returns the exact measure corresponding to the value stated in the specified unit.
valueOf(double, Unit<Q>) - Static method in class org.jscience.physics.amount.Amount
Returns the measure corresponding to an approximate value (double) stated in the specified unit; the precision of the measure is assumed to be the double precision (64 bits IEEE 754 format).
valueOf(double, double, Unit<Q>) - Static method in class org.jscience.physics.amount.Amount
Returns the measure corresponding to the specified approximate value and measurement error, both stated in the specified unit.
valueOf(CharSequence) - Static method in class org.jscience.physics.amount.Amount
Returns the measure represented by the specified character sequence.
values() - Static method in class org.opengis.referencing.cs.AxisDirection
 
Variable<X> - Interface in org.jscience.mathematics.function
This interface represents a symbol on whose value a Function depends.
Variable.Global<X> - Class in org.jscience.mathematics.function
This class represents a simple Variable implementation with context-local values.
Variable.Global(String) - Constructor for class org.jscience.mathematics.function.Variable.Global
Creates a new global variable with a unique symbol.
Variable.Local<X> - Class in org.jscience.mathematics.function
This class represents a simple Variable implementation for functions not shared between threads (non static).
Variable.Local(String) - Constructor for class org.jscience.mathematics.function.Variable.Local
Creates a new local variable with a unique symbol.
Vector<F extends Field<F>> - Class in org.jscience.mathematics.vector
This class represents an immutable element of a vector space.
Vector() - Constructor for class org.jscience.mathematics.vector.Vector
Default constructor (for sub-classes).
vectorization() - Method in class org.jscience.mathematics.vector.ComplexMatrix
 
vectorization() - Method in class org.jscience.mathematics.vector.DenseMatrix
 
vectorization() - Method in class org.jscience.mathematics.vector.Float64Matrix
 
vectorization() - Method in class org.jscience.mathematics.vector.Matrix
Returns the vectorization of this matrix.
vectorization() - Method in class org.jscience.mathematics.vector.SparseMatrix
 
VectorMeasure<Q extends Quantity> - Class in javax.measure
This class represents a measurement vector of two or more dimensions.
VectorMeasure() - Constructor for class javax.measure.VectorMeasure
Default constructor (for sub-classes).
VectorSpace<V,F extends Field> - Interface in org.jscience.mathematics.structure
This interface represents a vector space over a field with two operations, vector addition and scalar multiplication.
VectorSpaceNormed<V,F extends Field> - Interface in org.jscience.mathematics.structure
This interface represents a vector space on which a positive vector length or size is defined.
Velocity - Interface in javax.measure.quantity
This interface represents a distance traveled divided by the time of travel.
VERSION - Static variable in class org.jscience.JScience
Holds the version information.
VERSION_KEY - Static variable in interface org.opengis.metadata.Identifier
 
VerticalCRS<C extends Coordinates<?>> - Class in org.jscience.geography.coordinates.crs
This class represents a 1 dimensional vertical reference system.
VerticalCRS() - Constructor for class org.jscience.geography.coordinates.crs.VerticalCRS
 
VerticalCS - Interface in org.opengis.referencing.cs
 
verticalRadiusOfCurvature(double) - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the radius of curvature in the prime vertical for this reference ellipsoid at the specified latitude.
verticalRadiusOfCurvature(Measurable<Angle>) - Method in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
Returns the radius of curvature in the prime vertical for this reference ellipsoid at the specified latitude.
VOLT - Static variable in class javax.measure.unit.SI
The derived unit for electric potential difference, electromotive force (V).
Volume - Interface in javax.measure.quantity
This interface represents the amount of space occupied by a three-dimensional object or region of space, expressed in cubic units.
VolumetricDensity - Interface in javax.measure.quantity
This interface represents a mass per unit volume of a substance under specified conditions of pressure and temperature.
VolumetricFlowRate - Interface in javax.measure.quantity
This interface represents the volume of fluid passing a point in a system per unit of time.

W

WATT - Static variable in class javax.measure.unit.SI
The derived unit for power, radiant, flux (W).
WEBER - Static variable in class javax.measure.unit.SI
The derived unit for magnetic flux (Wb).
WEEK - Static variable in class javax.measure.unit.NonSI
A unit of duration equal to 7 NonSI.DAY (standard name week).
WEST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
WEST_NORTH_WEST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
WEST_SOUTH_WEST - Static variable in class org.opengis.referencing.cs.AxisDirection
 
WGS72 - Static variable in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
The World Geodetic System 1972 reference ellipsoid.
WGS84 - Static variable in class org.jscience.geography.coordinates.crs.ReferenceEllipsoid
The World Geodetic System 1984 reference ellipsoid.

X

XML - Static variable in class org.jscience.mathematics.vector.ComplexVector
Holds the default XML representation.
XML - Static variable in class org.jscience.mathematics.vector.DenseVector
Holds the default XML representation for dense vectors.
XML - Static variable in class org.jscience.mathematics.vector.Float64Vector
Holds the default XML representation.
XML - Static variable in class org.jscience.mathematics.vector.Matrix
Holds the default XML representation for matrices.
XML - Static variable in class org.jscience.mathematics.vector.SparseVector
Holds the default XML representation for sparse vectors.
XML - Static variable in class org.jscience.physics.amount.Amount
Holds the default XML representation for measures.
xValue(Unit<Length>) - Method in class org.jscience.geography.coordinates.XYZ
Returns the x coordinate value as double
XYZ - Class in org.jscience.geography.coordinates
This class represents the geocentric Earth-Centered, Earth-Fixed (ECEF) cartesian coordinates used in GPS/GLONASS.
XYZ_CS - Static variable in class org.jscience.geography.coordinates.crs.GeocentricCRS
Holds the XYZ coordinate system.

Y

YARD - Static variable in class javax.measure.unit.NonSI
A unit of length equal to 0.9144 m (standard name yd).
YEAR - Static variable in class javax.measure.unit.NonSI
A unit of duration equal to 365 days, 5 hours, 49 minutes, and 12 seconds (standard name year).
YEAR_CALENDAR - Static variable in class javax.measure.unit.NonSI
A unit of duration equal to 365 NonSI.DAY (standard name year_calendar).
YEAR_SIDEREAL - Static variable in class javax.measure.unit.NonSI
A unit of duration equal to one complete revolution of the earth about the sun, relative to the fixed stars, or 365 days, 6 hours, 9 minutes, 9.54 seconds (standard name year_sidereal).
YOCTO(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-24
YOTTA(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 1024
yValue(Unit<Length>) - Method in class org.jscience.geography.coordinates.XYZ
Returns the y coordinate value as double

Z

Z0 - Static variable in class org.jscience.physics.amount.Constants
Holds the characteristic impedance of vacuum (µ0·c).
ZEPTO(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 10-21
ZERO - Static variable in class org.jscience.mathematics.number.Complex
The complex number zero.
ZERO - Static variable in class org.jscience.mathematics.number.Float64
The 64 bits floating point representing zero.
ZERO - Static variable in class org.jscience.mathematics.number.FloatingPoint
The floating point instance representing the additive identity.
ZERO - Static variable in class org.jscience.mathematics.number.Integer64
The 64 bits floating point representing zero.
ZERO - Static variable in class org.jscience.mathematics.number.LargeInteger
The large integer representing the additive identity.
ZERO - Static variable in class org.jscience.mathematics.number.ModuloInteger
The modulo integer representing the additive identity.
ZERO - Static variable in class org.jscience.mathematics.number.Rational
The Rational representing the additive identity.
ZERO - Static variable in class org.jscience.mathematics.number.Real
Holds the exact ZERO instance.
ZERO - Static variable in class org.jscience.physics.amount.Amount
Holds a dimensionless measure of zero (exact).
ZETTA(Unit<Q>) - Static method in class javax.measure.unit.SI
Returns the specified unit multiplied by the factor 1021
zValue(Unit<Length>) - Method in class org.jscience.geography.coordinates.XYZ
Returns the z coordinate value as double

Α

α - Static variable in class org.jscience.physics.amount.Constants
Holds the fine structure constant (e²/(2·ε0·c·h))

Ε

ε0 - Static variable in class org.jscience.physics.amount.Constants
Holds the permittivity of vacuum or electric constant (1/(µ0·c²))

Μ

µ0 - Static variable in class org.jscience.physics.amount.Constants
Holds the permeability of vacuum or magnetic constant.
µB - Static variable in class org.jscience.physics.amount.Constants
Holds the Bohr magneton (ℏ·e/2me)
µN - Static variable in class org.jscience.physics.amount.Constants
Holds the nuclear magneton (ℏ·e/2mp)

Π

π - Static variable in class org.jscience.physics.amount.Constants
Holds the ratio of the circumference of a circle to its diameter.
π_square - Static variable in class org.jscience.physics.amount.Constants
Holds Constants.π².

Σ

σ - Static variable in class org.jscience.physics.amount.Constants
Holds the Stefan-Boltzmann constant ((π²/60)·k4/(ℏ³·c²))

Φ

Φ0 - Static variable in class org.jscience.physics.amount.Constants
Holds the magnetic flux quantum (h/2e)

- Static variable in class org.jscience.physics.amount.Constants
Holds the Planck constant.

- Static variable in class org.jscience.physics.amount.Constants
Holds the Planck constant over 2π.
A B C D E F G H I J K L M N O P Q R S T U V W X Y Z Α Ε Μ Π Σ Φ   

Copyright © 2012. All Rights Reserved.