advance_math library
Dart package for matrix or list operations
The library was developed, documented, and published by
Charles Gameti
Classes
- AbsorbedDose
- The mean energy imparted to matter per unit mass by ionizing radiation. See the Wikipedia entry for Absorbed Dose for more information.
- AbsorbedDoseRate
- The rate of mean energy imparted to matter per unit mass by ionizing radiation. See the Wikipedia entry for Absorbed Dose for more information.
- AbsorbedDoseRateUnits
- Units acceptable for use in describing AbsorbedDoseRate quantities.
- AbsorbedDoseUnits
- Units acceptable for use in describing AbsorbedDose quantities.
- Acceleration
- The rate of change of speed of an object. See the Wikipedia entry for Acceleration for more information.
- AccelerationUnits
- Units acceptable for use in describing Acceleration quantities.
- Activity
- A measure of the effective concentration of a species in a mixture. See the Wikipedia entry for Thermodynamic activity for more information.
- ActivityUnits
- Units acceptable for use in describing Activity quantities.
- AmountOfSubstance
- The size of an ensemble of elementary entities, such as atoms, molecules, electrons, and other particles. See the Wikipedia entry for Amount of substance for more information.
- AmountOfSubstanceUnits
- Units acceptable for use in describing AmountOfSubstance quantities.
- Angle
- A planar (2-dimensional) angle, which has dimensions of 1 and is a measure of the ratio of the length of a circular arc to its radius.
- AngleConstants
- AngleRange
- An immutable angle range with a start angle, an end angle and an implicit direction.
- AngleUnits
- Units acceptable for use in describing Angle quantities.
- AngularAcceleration
- The rate of change of angular speed. See the Wikipedia entry for Angular acceleration for more information.
- AngularAccelerationUnits
- Units acceptable for use in describing AngularAcceleration quantities.
- AngularMomentum
- A measure of the quantity of rotation of a system of matter, taking into account its mass, rotations, motions and shape. See the Wikipedia entry for Angular momentum for more information.
- AngularMomentumUnits
- Units acceptable for use in describing AngularMomentum quantities.
- AngularSpeed
- The rate of change of an angle. See the Wikipedia entry for Angular_velocity for more information.
- AngularSpeedUnits
- Units acceptable for use in describing AngularSpeed quantities.
- Annulus
- A class representing an annulus (a ring-like shape).
- ApostrophusRomanNumeralsConfig
- Use ApostrophusRomanNumeralsConfig to use special symbols from the Roman era for 500, 1,000; 5,000; 10,000; 50,000; 100,000, and 1,000,000 - these are ⅠↃ, ⅭⅠↃ, ⅠↃↃ, ⅭⅭⅠↃↃ, ⅠↃↃↃ, ⅭⅭⅭⅠↃↃↃ, CCCCIↃↃↃↃ. Maximum value: 3,999,999.
- Area
- The extent of a two-dimensional figure or shape. See the Wikipedia entry for Area for more information.
- AreaUnits
- Units acceptable for use in describing Area quantities.
- BaseLeastSquares
-
The
BaseLeastSquares
class is used to perform a least squares fit to the given model, specified by matrixA
and column vectorb
. It supports weighted least squares with an optional weight matrixW
, - BBP
- Computes the value of π using the BBP (Bailey-Borwein-Plouffe) algorithm. The BBP algorithm is an efficient method for calculating digits of π without computing the entire value. This implementation calculates the specified number of digits of π.
- Bidiagonalization
- Binary
- Represents an integer as a binary number.
- CalendarYear
- The period of 365 days (or 366 days in leap years) starting from the first of January; used for reckoning time in ordinary affairs.
- Capacitance
- The ability of a body to store an electrical charge, See the Wikipedia entry for Capacitance for more information.
- CapacitanceUnits
- Units acceptable for use in describing Capacitance quantities.
- CatalyticActivity
- The increase in rate of a chemical reaction caused by the presence of a catalyst. See the Wikipedia entry for Catalysis for more information.
- CatalyticActivityUnits
- Units acceptable for use in describing CatalyticActivity quantities.
- Charge
- The property of matter that causes it to experience a force when placed in an electromagnetic field See the Wikipedia entry for Electric charge for more information.
- ChargeDensity
- Electric charge per unit volume of space. See the Wikipedia entry for Charge density for more information.
- ChargeDensityUnits
- Units acceptable for use in describing ChargeDensity quantities.
- ChargeUnits
- Units acceptable for use in describing Charge quantities.
- ChineseRemainderTheorem
- Utility class to solve a set of congruence equations using the Chinese Remainder Theorem (CRT).
- CholeskyDecomposition
- Chudnovsky
- Calculates the value of pi using the Chudnovsky algorithm.
- Circle
- Represents a Circle in a 2D space.
- ColumnMatrix
- Column class extends Matrix and represents a single column in a matrix.
- CommonRomanNumeralsConfig
- Use CommonRomanNumeralsConfig for the common MDCLXVI style. Maximum value: 3,999 / MMMCMXCIX.
- CompactApostrophusRomanNumeralsConfig
- The CompactApostrophusRomanNumeralsConfig form of ApostrophusRomanNumeralsConfig uses single characters for each value instead of multiple. 500 will use D. The other characters are ↀ, ↁ, ↂ, ↇ, and ↈ. Maximum value: 399,999.
- Complex
- Complex numbers have both a real and an imaginary part.
- ComplexVector
- A class representing a vector with complex numbers.
- CompressedPrimeSieve
- A class that implements a compressed prime sieve using bit manipulation. Each bit represents a boolean value indicating whether a number is prime or not. This saves memory when creating the sieve. In this implementation, only odd numbers are stored in individual integers, meaning that each integer can represent a range of 128 numbers (even numbers are omitted because they are not prime, with the exception of 2 which is handled as a special case).
- Concentration
- The abundance of a constituent divided by the total volume of a mixture. See the Wikipedia entry for Concentration for more information.
- ConcentrationUnits
- Units acceptable for use in describing Concentration quantities.
- Conductance
-
The ease with which an electric current passes through a conductor (the inverse of
Resistance
). See the Wikipedia entry for Electrical resistance and conductance for more information. - ConductanceUnits
- Units acceptable for use in describing Conductance quantities.
- Constant
-
Concrete implementation of
Algebraic
that represents a constant valuea
. It can be either real or complex. - Cube
- A class representing a cube in 3D space.
- Cubic
-
Concrete implementation of Polynomial that represents a third degree
polynomial equation in the form
ax^3 + bx^2 + cx + d = 0
. - Currency
- Money in any form when in actual use or circulation as a medium of exchange. See the Wikipedia entry for Currency for more information.
- CurrencyUnits
- Units acceptable for use in describing Currency quantities.
- Current
- The flow of electric charge. See the Wikipedia entry for Electric current for more information.
- CurrentDensity
- The electric current per unit area of cross section. See the Wikipedia entry for Current density for more information.
- CurrentDensityUnits
- Units acceptable for use in describing CurrentDensity quantities.
- CurrentUnits
- Units acceptable for use in describing Current quantities.
- DataFrame
- A class representing a DataFrame, which is a 2-dimensional labeled data structure with columns of potentially different types.
- Decimal
- Decomposition
- DiagonalMatrix
-
The
Diagonal
class is a subclass ofMatrix
and represents a diagonal matrix. A diagonal matrix is a square matrix in which all the elements outside the main diagonal are zero. - Digit
- Represents a digit in four bits of a single byte. This wastes four bits but that's a decent trade-off for simplicity and better anyway than the 4+ bytes allocated for a regular int.
- Dimensions
- The Dimensions class represents the dimensions of a physical quantity.
- DivideAndConquer
- Domain
- A class representing a domain along the major axis of an ellipse.
- DoseEquivalent
- Represents the stochastic health effects (probability of cancer induction and genetic damage) of ionizing radiation on the human body. See the Wikipedia entry for Equivalent dose for more information.
- DoseEquivalentUnits
- Units acceptable for use in describing DoseEquivalent quantities.
- Double
- Wraps Dart's core double type, so that it can share a common base type with other Numbers.
- DurandKerner
- The Durand–Kerner method, also known as Weierstrass method, is a root finding algorithm for solving polynomial equations. With this class, you can find all roots of a polynomial of any degree.
- DynamicViscosity
- A measure of a fluid's resistance to gradual deformation by shear stress or tensile stress. See the Wikipedia entry for Viscosity for more information.
- DynamicViscosityUnits
- Units acceptable for use in describing DynamicViscosity quantities.
- Eigen
- Class to store eigenvalues and eigenvectors of a matrix.
- EigenvalueDecomposition
- EigenvalueDecompositions
- ElasticNetRegression
- Implements Elastic Net Regression, a type of regularized linear regression that includes both L1 and L2 penalty terms.
- ElectricFieldStrength
- The magnitude of the force per unit charge that an electric field exerts. See the Wikipedia entry for Electric field for more information.
- ElectricFieldStrengthUnits
- Units acceptable for use in describing ElectricFieldStrength quantities.
- ElectricFluxDensity
- A measure of the intensity of an electric field generated by a free electric charge, corresponding to the number of electric field lines passing through a given area. See the Wikipedia entry for Electric_flux for more information.
- ElectricFluxDensityUnits
- Units acceptable for use in describing ElectricFluxDensity quantities.
- ElectricPotentialDifference
- The difference in electric potential energy between two points per unit electric charge See the Wikipedia entry for Voltage for more information.
- ElectricPotentialDifferenceUnits
- Units acceptable for use in describing ElectricPotentialDifference quantities.
- Ellipse
- A class representing an ellipse in 2D space.
- Energy
- The ability of a system to perform work; cannot be created or destroyed but can take many forms. See the Wikipedia entry for Energy for more information.
- EnergyDensity
- The amount of energy stored in a given system or region of space per unit volume. See the Wikipedia entry for Energy density for more information.
- EnergyDensityUnits
- Units acceptable for use in describing EnergyDensity quantities.
- EnergyFlux
- The rate of transfer of energy through a surface. See the Wikipedia entry for Energy density for more information.
- EnergyFluxUnits
- Units acceptable for use in describing EnergyFlux quantities.
- EnergyUnits
- Units acceptable for use in describing Energy quantities.
- EngineeringFormatSI
- A version of scientific notation in which the exponent of ten must be divisible by three (e.g., 123.345 x 10^3).
- Entropy
- The number of specific ways in which a thermodynamic system may be arranged, commonly understood as a measure of disorder. See the Wikipedia entry for Entropy for more information.
- EntropyUnits
- Units acceptable for use in describing Entropy quantities.
- Exposure
- The radiant energy received by a surface per unit area. See the Wikipedia entry for Radiant exposure for more information.
- ExposureUnits
- Units acceptable for use in describing Exposure quantities.
- Expression
- An abstract representation of a mathematical expression.
- FieldLevel
- Represents a level of a field quantity, a logarithmic quantity. Level of a field quantity is defined as ln(F/F0), where F/F0 is the ratio of two field quantities and F0 is a reference amplitude of the appropriate type.
- FiscalYear
- Constructs a FiscalYear time period.
- Force
- Any interaction that, when unopposed, changes the motion of an object. See the Wikipedia entry for Force for more information.
- ForceUnits
- Units acceptable for use in describing Force quantities.
- Fraction
- Represents a fraction number.
- Frequency
- The number of occurrences of a repeating event per unit time. See the Wikipedia entry for Frequency for more information.
- FrequencyUnits
- Units acceptable for use in describing Frequency quantities.
- GaussLegendre
- Computes the value of π to the specified precision using the Gauss-Legendre algorithm.
- GeneralizedLeastSquares
- Implements Generalized Least Squares method for linear regression.
- Geometry
- An abstract class representing a general geometric shape.
- GeoUtils
- HeatFluxDensity
- Heat rate per unit area. See the Wikipedia entry for Heat flux for more information.
- HeatFluxDensityUnits
- Units acceptable for use in describing HeatFluxDensity quantities.
- Hexadecimal
- Represents an integer as a hexadecimal number.
- Illuminance
- The total luminous flux incident on a surface, per unit area. See the Wikipedia entry for Illuminance for more information.
- IlluminanceUnits
- Units acceptable for use in describing Illuminance quantities.
- Imaginary
- Represents an imaginary number, defined as a number whose square is negative one.
- Inductance
- The property of an electrical conductor by which a change in current flowing through it induces an electromotive force in both the conductor itself and in any nearby conductors by mutual inductance. See the Wikipedia entry for Inductance for more information.
- InductanceUnits
- Units acceptable for use in describing Inductance quantities.
- Information
- Amount of data. See the Wikipedia entry for Information for more information.
- InformationRate
- The flow of information, per unit time. See the Wikipedia entry for Information for more information.
- InformationRateUnits
- Units acceptable for use in describing InformationRate quantities.
- InformationUnits
- Units acceptable for use in describing Information quantities.
- Integer
- Wraps Dart's core int type, so that it can share a common base type with other Numbers.
- Interp1D
- Provides interpolation for a 1-D function.
- Interp2D
- Provides interpolation for a 2-D function.
- IrregularPolygon
- IsoscelesTrapezoid
- A class representing an Isosceles Trapezoid in 2D space.
- KinematicViscosity
- The resistance to flow of a fluid, equal to its absolute viscosity divided by its density. See the Wikipedia entry for Viscosity for more information.
- KinematicViscosityUnits
- Units acceptable for use in describing KinematicViscosity quantities.
- LanguageConfig
- Represents the configuration for converting numbers to words in a specific language. This configuration includes mappings for number segments, conjunctions, delimiters, and other language-specific nuances.
- LassoRegression
- Implements Lasso Regression, a type of regularized linear regression. It includes an L1 penalty term on the size of coefficients which helps to control the magnitude of the coefficients and can produce models with sparse coefficients (many coefficients being zero).
- LeastSquares
-
The
LeastSquares
class is used to perform a least squares fit to the given model, specified by matrixA
and column vectorb
. It supports weighted least squares with an optional weight matrixW
, - Length
- Represents the length physical quantity (one of the seven base SI quantities). See the Wikipedia entry for Length for more information.
- LengthUnits
- Units acceptable for use in describing Length quantities.
- Level
- Represents logarithmic physical quantities and has dimensions of 1 (Scalar). Level of a field quantity and level of a power quantity are two common logarithmic quantities.
- LevelUnits
- Units acceptable for use in describing Level quantities.
- Limit
- Line
- A class representing a line in a 2-dimensional space.
- Linear
- Concrete implementation of Polynomial that represents a first degree polynomial equation in the form ax + b = 0.
- LinearSystemSolvers
- LQDecomposition
- LU
- LUDecomposition
- Luminance
- The intensity of light emitted from a surface per unit area. See the Wikipedia entry for Luminance for more information.
- LuminanceUnits
- Units acceptable for use in describing Luminance quantities.
- LuminousFlux
- The perceived power of light. It differs from radiant flux, the measure of the total power of electromagnetic radiation (including infrared, ultraviolet, and visible light), in that luminous flux is adjusted to reflect the varying sensitivity of the human eye to different wavelengths of light See the Wikipedia entry for Luminance for more information.
- LuminousFluxUnits
- Units acceptable for use in describing LuminousFlux quantities.
- LuminousIntensity
- Represents the luminous intensity physical quantity (one of the seven base SI quantities), the wavelength-weighted power emitted by a light source in a particular direction per unit solid angle. See the Wikipedia entry for Luminous intensity for more information.
- LuminousIntensityUnits
- Units acceptable for use in describing LuminousIntensity quantities.
- Madhava
- Computes the value of π to the specified precision using the Madhava algorithm.
- MagneticFieldStrength
- The intensity of a magnetic field. See the Wikipedia entry for Magnetic field for more information.
- MagneticFieldStrengthUnits
- Units acceptable for use in describing MagneticFieldStrength quantities.
- MagneticFlux
- The magnetic flux density passing through a closed surface. See the Wikipedia entry for Magnetic flux for more information.
- MagneticFluxDensity
- The amount of magnetic flux in an area taken perpendicular to a magnetic flux's direction See the Wikipedia entry for Magnetic flux for more information.
- MagneticFluxDensityUnits
- Units acceptable for use in describing MagneticFluxDensity quantities.
- MagneticFluxUnits
- Units acceptable for use in describing MagneticFlux quantities.
- Mass
- Represents the mass physical quantity (one of the seven base SI quantities), that determines the strength of a body's mutual gravitational attraction to other bodies. See the Wikipedia entry for Mass for more information.
- MassDensity
- Mass per unit volume. See the Wikipedia entry for Density for more information.
- MassDensityUnits
- Units acceptable for use in describing MassDensity quantities.
- MassFlowRate
- The mass of a substance which passes per unit of time. See the Wikipedia entry for Mass flow rate for more information.
- MassFlowRateUnits
- Units acceptable for use in describing MassFlowRate quantities.
- MassFluxDensity
- The mass of a substance which passes per unit of time. See the Wikipedia entry for Mass flow rate for more information.
- MassFluxDensityUnits
- Units acceptable for use in describing MassFluxDensity quantities.
- MassUnits
- Units acceptable for use in describing Mass quantities.
- Matrix
-
The
Matrix
class provides a structure for two-dimensional arrays of data, along with various utility methods for manipulating these arrays. - Matrix2
- Matrix3
- Matrix4
- MatrixDecomposition
- Provides matrix decomposition functions as an extension on Matrix.
- MatrixElementIterator
- A custom iterator for traversing the elements of a Matrix in row-major order.
- MatrixFactory
- MatrixIterator
- A custom iterator for traversing the elements of a Matrix in row-major or column-major order.
- MiscQuantity
- A MiscQuantity is a general (miscellaneous) Quantity having arbitrary dimensions (including possibly the same dimensions as a named Quantity subclass). MiscQuantity objects may be used, for example, in less common domains or as intermediate results in equations.
- MolarEnergy
- Energy per mole of a substance. See the Wikipedia entry for Specific energy for more information.
- MolarEnergyUnits
- Units acceptable for use in describing MolarEnergy quantities.
- MolarEntropy
- Entropy content per mole of substance. See the Wikipedia entry for Standard molar entropy for more information.
- MolarEntropyUnits
- Units acceptable for use in describing MolarEntropy quantities.
- MorseCode
- A class to encode and decode Morse code messages.
- MutableQuantity
-
MutableQuantity supports updates to its value, dimensions and uncertainty.
Changes are broadcast over the
onChange
stream. - NewtonEuler
- Computes the value of π to the specified precision using the Newton-Euler algorithm. The Newton-Euler algorithm is an efficient method for calculating the digits of π. This implementation calculates π to the specified number of digits.
- Number
- The abstract base class for all Number types.
- NumberFormatSI
- NumberFormatSI implements the International System of Units (SI) style conventions for displaying values of quantities. Specifically:
- NumWords
- A utility class to convert numerical values to their word representation in various languages with support for currency and ordinal conversion.
- Octal
- Represents an integer as an octal number.
- OrdinaryLeastSquares
- Implements Ordinary Least Squares method for linear regression.
- Parallelogram
- A class representing a Parallelogram in 2D space.
- Permeability
- The ability of a material to support the formation of a magnetic field within itself. See the Wikipedia entry for Permeability (electromagnetism) for more information.
- PermeabilityUnits
- Units acceptable for use in describing Permeability quantities.
- Permittivity
- The resistance that is encountered when forming an electric field in a medium. See the Wikipedia entry for Permittivity for more information.
- PermittivityUnits
- Units acceptable for use in describing Permittivity quantities.
- PhysicsConstants
- PI
-
The
PI
class provides methods for calculating the value of pi using various algorithms, such as the Chudnovsky, Gauss-Legendre, and BBP algorithms. It also includes methods for retrieving individual digits, checking for digit patterns, and performing computations that require the value of pi. - PiAlgorithm
- Abstract base class for algorithms that compute the value of pi.
- Plane
- A class that represents a plane in a three-dimensional space. Each instance of this class is defined by a Point and a normal Vector.
- PlaneGeometry
- An abstract class representing a 2D geometric shape.
- Point
-
Class
Point
represents a point in two or three-dimensional space. The point coordinates are represented byx
,y
and optionallyz
. - Point3D
-
Class
Point3D
represents a point in two or three-dimensional space. The point coordinates are represented byx
,y
andz
. - Polygon
- A class representing a polygon, which can be used to compute various properties such as area, perimeter, interior and exterior angles, as well as to check whether a point is inside the polygon.
- Polynomial
- A class representing a Polynomial of arbitrary degree.
- Power
- Amount of energy per unit time. See the Wikipedia entry for Power (physics) for more information.
- PowerLevel
- Represents a level of a power quantity, a logarithmic quantity. Level of a power quantity is defined as 0.5*ln(P/P0), where P/P0 is the ratio of two powers and P0 is a reference power.
- PowerUnits
- Units acceptable for use in describing Power quantities.
- Precision
-
Precision
represents an arbitrary precision number. - Pressure
- Force applied perpendicular to the surface of an object per unit area over which that force is distributed. See the Wikipedia entry for Pressure for more information.
- PressureUnits
- Units acceptable for use in describing Pressure quantities.
- QRDecomposition
- Quadratic
- A class that represents a quadratic equation that implementation of Polynomial that represents a second degree polynomial equation in the form ax^2 + bx + c = 0.
- Quantity
- The abstract base class for all quantities. The Quantity class represents the value of a physical quantity and its associated dimensions. It provides methods for constructing and getting the quantity's value in arbitrary units, methods for mathematical manipulation and comparison and optional features such as arbitrary precision and uncertainty.
-
QuantityRange<
Q extends Quantity> - Represents a range of quantity values.
- Quartic
- Concrete implementation of Polynomial that represents a fourth degree polynomial equation in the form ax^4 + bx^3 + cx^2 + dx + e = 0.
- Radiance
- The radiant flux emitted, reflected, transmitted or received by a surface, per unit solid angle per unit projected area. See the Wikipedia entry for Radiance for more information.
- RadianceUnits
- Units acceptable for use in describing Radiance quantities.
- RadiantFlux
- Radiant flux is another way to express power.
- RadiantIntensity
- The radiant flux emitted, reflected, transmitted or received, per unit solid angle. See the Wikipedia entry for Radiant intensity for more information.
- RadiantIntensityUnits
- Units acceptable for use in describing RadiantIntensity quantities.
- Ramanujan
- Computes the value of π to the specified precision using the Ramanujan algorithm. The Ramanujan algorithm is an efficient method for calculating the digits of π. This implementation calculates π to the specified number of digits.
- Random
- A generator of random byte, bool, int, BigInt, or double values.
- Range
- A class representing a range along.
- RateLimiter
- A utility class that implements rate limiting functionality.
- Rational
- A number that can be expressed as a fraction of two integers, a numerator and a non-zero denominator.
- RationalFunction
- Real
- Provides a common handle for all Real Numbers.
- Rectangle
- Represent a rectangle in 2D space.
- RegularPolygon
- Resistance
- A measure of the difficulty passing an electric current through a conductor. See the Wikipedia entry for Electrical resistance and conductance for more information.
- ResistanceUnits
- Units acceptable for use in describing Resistance quantities.
- RidgeRegression
- Implements Ridge Regression, a type of regularized linear regression. It includes an L2 penalty term on the size of coefficients which helps to control the magnitude of the coefficients.
- RightTrapezoid
- A class representing a Right Trapezoid in 2D space.
- RobustLeastSquares
- Implements Robust Least Squares, a type of linear regression that aims to be more resistant to outliers than ordinary least squares.
- RomanNumerals
- A class to convert between Roman and decimal numerals.
- RomanNumeralsConfig
- RomanNumeralsConfig is the base class that defines the behavior for all of the descendent classes and should not be used directly.
- Rotation
-
Rotation
is like an angle that may exceed 360° in the positive or negative direction. - RowMatrix
- Row class extends Matrix and represents a single row in a matrix.
- Scalar
- A one-dimensional physical quantity that can be described by a single real number. See the Wikipedia entry for Scalar (physics) for more information.
- ScalarUnits
- Units acceptable for use in describing Scalar quantities.
- SchurDecomposition
- ScientificFormatSI
- Formats a number as a single integer digit, followed by decimal digits and raised to a power of 10 (e.g., 1.2345 x 10^3).
- Series
-
A
Series
class represents a one-dimensional array with a label. - SingularValueDecomposition
- SolidAngle
- A two-dimensional angle in three-dimensional space that an object subtends at a point. See the Wikipedia entry for Solid angle for more information.
- SolidAngleUnits
- Units acceptable for use in describing SolidAngle quantities.
- SolidGeometry
- An abstract class representing a 3D geometric shape.
- SparseMatrix
- SparseMatrixCOO
- This class represents a SparseMatrix in the COO (Coordinate List) format. It stores the row indices, column indices, and values of all non-zero elements in the matrix.
- SparseMatrixCSC
- This class represents a SparseMatrix in the CSC (Compressed Sparse Column) format. It stores the column pointers, row indices, and values of all non-zero elements in the matrix.
- SparseMatrixCSR
- This class represents a SparseMatrix in the CSR (Compressed Sparse Row) format. It stores the row pointers, column indices, and values of all non-zero elements in the matrix.
- SparseMatrixDOK
- This class represents a SparseMatrix in the DOK (Dictionary of Keys) format. It stores a dictionary with keys representing the (row, column) indices and values representing the non-zero elements in the matrix.
- SparseMatrixLIL
- This class represents a SparseMatrix in the LIL (List of Lists) format. For each row, it stores a list of column indices and a list of values of all non-zero elements in the row.
- SpecificEnergy
- Energy per unit mass. See the Wikipedia entry for Specific energy for more information.
- SpecificEnergyUnits
- Units acceptable for use in describing SpecificEnergy quantities.
- SpecificHeatCapacity
- The heat capacity per unit mass of a material. See the Wikipedia entry for Heat capacity for more information.
- SpecificHeatCapacityUnits
- Units acceptable for use in describing SpecificHeatCapacity quantities.
- SpecificVolume
- The ratio of the substance's volume to its mass. See the Wikipedia entry for Specific volume for more information.
- SpecificVolumeUnits
- Units acceptable for use in describing SpecificVolume quantities.
- SpectralIrradiance
- Irradiance of a surface per unit frequency. See the Wikipedia entry for Radiometry for more information.
- SpectralIrradianceUnits
- Units acceptable for use in describing SpectralIrradiance quantities.
- Speed
- The rate of change of position. See the Wikipedia entry for Speed for more information.
- SpeedUnits
- Units acceptable for use in describing Speed quantities.
- SphericalTriangle
- Represents a spherical triangle, defined by its three angles (A, B, C) and the lengths of the three sides opposite those angles (a, b, c).
- Square
- SurfaceTension
- The elastic tendency of liquids which makes them acquire the least surface area possible. See the Wikipedia entry for Surface tension for more information.
- SurfaceTensionUnits
- Units acceptable for use in describing SurfaceTension quantities.
- SVD
- SylvesterMatrix
- Temperature
- An objective comparative measure of hot or cold. See the Wikipedia entry for Thermodynamic temperature for more information.
- TemperatureInterval
- The difference between two temperatures, where temperature is an objective comparative measure of hot or cold. See the Wikipedia entry for Thermodynamic temperature for more information.
- TemperatureIntervalUnits
- Units acceptable for use in describing TemperatureInterval quantities.
- TemperatureUnits
- Units acceptable for use in describing Temperature quantities.
- ThermalConductivity
- The ability of a material to conduct heat. See the Wikipedia entry for Thermal conductivity for more information.
- ThermalConductivityUnits
- Units acceptable for use in describing ThermalConductivity quantities.
- Time
- Represents the time interval physical quantity (one of the seven base SI quantities).
- TimeInstant
-
TimeInstant
represents a specific moment in time and its units enable conversion between various time scales. - TimeInstantUnits
- Units acceptable for use in describing TimeInstant quantities.
- TimePeriod
- Represents a specific time span.
- TimeUnits
- Units acceptable for use in describing Time quantities.
- Torque
- The tendency of a force to rotate an object about an axis, fulcrum, or pivot. See the Wikipedia entry for Torque for more information.
- TorqueUnits
- Units acceptable for use in describing Torque quantities.
- TotalLeastSquares
- A class for Total Least Squares Regression
- Trapezoid
- A class representing a Trapezoid in 2D space.
- Triangle
- Represents a triangle in 2D space.
- Vector
- Vector2
- Vector3
- Vector4
- VectorElementIterator
- VectorIterator
- VinculumRomanNumeralsConfig
- Use VinculumRomanNumeralsConfig for the extended style similar to the the common MDCLXVI style. Maximum value: 3,999,999 / M̅M̅M̅C̅M̅X̅C̅MX̅CMXCIX.
- Volume
- The amount of three-dimensional space enclosed by some closed boundary. See the Wikipedia entry for Volume for more information.
- VolumeFlowRate
- The volume of fluid which passes per unit time. See the Wikipedia entry for Volumetric flow rate for more information.
- VolumeFlowRateUnits
- Units acceptable for use in describing VolumeFlowRate quantities.
- VolumeUnits
- Units acceptable for use in describing Volume quantities.
- WaveNumber
- The spatial frequency of a wave. See the Wikipedia entry for Wavenumber for more information.
- WaveNumberUnits
- Units acceptable for use in describing WaveNumber quantities.
- WeightedLeastSquares
- Implements Weighted Least Squares method for linear regression.
- ZScore
- Computes Z-score based on a given confidence level.
Enums
- AngleCategory
- AngleDirection
- AreaMethod
- DecompositionMethod
-
Enumeration for available decomposition methods in the
solve
function. - DeterminantMethod
- Enum representing the available methods for calculating the determinant of a matrix.
- DistanceType
- The DistanceType enum contains different types of distance metrics used for both Vector and Matrix distance calculations.
- EquationMethod
- An enumeration of different methods that can be used to solve the least squares problem.
- LinearSystemMethod
- Enum representing the available methods for solving linear systems.
- MatrixAlign
- An enum representing the alignment options for matrix elements in a string representation.
- MatrixType
- Enum representing different types of matrices and their properties.
- MethodType
- An enumeration of interpolation methods.
- Norm
- Enumeration of supported norms for vectors and matrices.
- PiCalcAlgorithm
- Specifies the algorithm to use when calculating the value of pi.
- PlaneType
- Define an enumeration for the XY-plane, XZ-plane, and YZ-plane
- Rescale
- Enum for specifying the direction of rescaling operation in a matrix.
- RomanNumeralsType
- RomanNumeralsType enumerates the 3 major types of Roman numerals supported.
- SparseFormat
- UncertaintyFormat
- Whether and how to display a quantity's uncertainty (e.g., compact is 32.324(12), not compact is (32.324 +/- 0.012)).
Mixins
- Units
- A unit is a particular physical quantity, defined and adopted by convention, with which other particular quantities of the same kind (dimensions) are compared to express their value.
Extensions
- AdvancedMatrixOperations on Matrix
- BigIntExt on BigInt
- Extensions on BigInt.
- DataFrameFunctions on DataFrame
- DataFrameOperations on DataFrame
- ExtString on String
-
GroupingExtension
on Iterable<
T> - IntExt on int
-
IterableExt
on Iterable<
E> -
ListToVector
on List<
num> -
ListVector
on List<
num> -
MapListGroupingExtension
on List<
Map< String, dynamic> > - MathExtension on num
- MatrixFunctions on Matrix
-
MatrixListExtension
on List<
List> - MatrixManipulationExtension on Matrix
- MatrixOperationExtension on Matrix
- MatrixStatsExtension on Matrix
- MatrixStructure on Matrix
- MatrixVectorConversion on Matrix
- MatrixVectorOperations on Matrix
- NumberToWordsExtension on Number
- NumExtension on num
- NumOperationExtension on num
- NumWordsExtension on num
- RationalExt on Rational
- RomanNumeralsInt on int
- RomanNumeralsString on String
-
ScanList
on List<
T> - SeriesFunctions on Series
- SeriesOperations on Series
- VectorMatrixOperations on Vector
- VectorOperations on Vector
Constants
- alphaParticleMass → const Mass
- The rest mass of a helium nucleus.
- angstromStar → const Length
- Often used to represent the wavelengths of X rays and the distances between atoms in crystals.
- atomicMass → const Mass
- One twelfth of the mass of a carbon-12 atom in its nuclear and electronic ground state.
- bohrRadius → const Length
- The mean radius of the orbit of an electron around the nucleus of a hydrogen atom at its ground state.
- boltzmannConstant → const Entropy
- The Boltzmann constant is a physical constant that relates the average relative kinetic energy of particles in a gas with the temperature of the gas.
- characteristicImpedanceOfVacuum → const Resistance
- Relates the magnitudes of the electric and magnetic fields of electromagnetic radiation travelling through free space.
- classicalElectronRadius → const Length
- The classical electron radius is a combination of fundamental physical quantities that define a length scale for problems involving an electron interacting with electromagnetic radiation.
- comptonWavelength → const Length
- The wavelength of a photon whose energy is the same as the mass energy equivalent of that particle.
- conductanceQuantum → const Conductance
- The quantized unit of electrical conductance. It appears when measuring the conductance of a quantum point contact, and, more generally, is a key component of Landauer formula which relates the electrical conductance of a quantum conductor to its quantum properties.
- cos0 → const double
- The cosine of a ninety degree angle (1).
- cos60 → const double
- The cosine of a sixty degree angle (0.5).
- cos90 → const double
- The cosine of a ninety degree angle (1).
- deuteronMass → const Mass
- The mass of a stationary deuteron.
- e → const double
- Returns the mathematical constant e. Base of the natural logarithms
- electronGFactor → const Scalar
- Electron g factor (ge).
- electronMass → const Mass
- The mass of a stationary electron.
- elementaryCharge → const Charge
- The electric charge carried by a single proton.
- eps → const double
-
expUnicodeMap
→ const Map<
String, String> - Maps a digit, decimal point or minus sign string to a unicode exponent character.
- fineStructureConstant → const Scalar
- Fine structure constant (alpha).
- fiveNinths → const double
- A ratio used in the conversion between metric temperature scales and Fahrenheit.
- hartreeEnergy → const Energy
- The Hartree atomic unit of energy is the energy for the separation of a molecule to nuclei and electrons.
- hBar → const AngularMomentum
- The Planck constant divided by 2 PI (a.k.a., 'h-bar' or 'reduced Planck constant').
- helionMass → const Mass
- The mass of a stationary helion.
- lengthZero → const Length
- A constant representing zero length.
- ln10 → const double
- Natural logarithm of 10.
- ln2 → const double
- Natural logarithm of 2.
- log10e → const double
- Base-10 logarithm of e.
- log2e → const double
- Base-2 logarithm of e.
- magneticFluxQuantum → const MagneticFlux
- The magnetic flux quantum constant is a combination of two other physical constants: the Planck constant h and the electron charge e. Its value is, therefore, the same for any superconductor.
- muonGFactor → const Scalar
- Muon g factor (gn).
- muonMass → const Mass
- The mass of a stationary muon particle.
- naught → const Scalar
- A synonym for zero.
- neutronGFactor → const Scalar
- Neutron g factor (gn).
- neutronMass → const Mass
- The mass of a stationary neutron.
- pi → const double
- Returns the mathematical constant Pi.
- planckConstant → const AngularMomentum
- The Planck constant.
- planckLength → const Length
- The threshold length at which classical ideas about gravity and space-time cease to be valid and quantum effects dominate.
- planckMass → const Mass
- The unit of mass in the system of natural units known as Planck units. It is approximately 0.02 milligrams.
- planckTemperature → const Temperature
- Contemporary models of physical cosmology postulate that the highest possible temperature is the Planck temperature.
- planckTime → const Time
- The time required for light to travel in a vacuum a distance of one Planck length.
- protonGFactor → const Scalar
- Proton g factor (gp).
- protonMass → const Mass
- The mass of a stationary proton.
- sackurTetrode100kPa → const Scalar
- Sackur-Tetrode constant at 1 K and 100 kPa ('S0/R').
- sackurTetrodeStdAtm → const Scalar
- Sackur-Tetrode constant at 1 K and 101.325 kPa ('S0/R').
- scalarZero → const Scalar
- Zero, as a Scalar.
- sigma0 → const Area
- A synonym for the thomsonCrossSection.
- sin0 → const double
- The sine of a zero degree angle (0).
- sin30 → const double
- The sine of a thirty degree angle (0.5).
- sin90 → const double
- The sine of a ninety degree angle (1).
- solarLuminosity → const Power
- The solar luminosity constant is the radiant flux (power emitted in the form of photons) emitted by the Sun (a typical value; the Sun's output actually varies slightly over time).
- speedOfLightVacuum → const Speed
- Speed of light in a vacuum.
- speedOfSoundAir0C → const Speed
- Speed of sound in air at 0 deg C.
- sqrt1_2 → const double
- Square root of 1/2.
- sqrt2 → const double
- Square root of 2.
- sqrt3 → const double
- Square root of 3.
- tan0 → const double
- The tangent of a zero degree angle (0).
- tan45 → const double
- The tangent of a forty five degree angle (1).
- tau → const double
- The "circle constant", equal to two pi.
- tauComptonWavelength → const Length
- The tau Compton wavelength.
- tauMass → const Mass
- The mass of a stationary tau particle.
- thomsonCrossSection → const Area
- Helpful for describing the scattering of photons when the energy of each individual photon is much smaller than the rest energy of the electron.
- twoPi → const double
- The value 2 * pi, also known as tau.
- vacuumElectricPermittivity → const Permittivity
- A constant of proportionality that exists between electric displacement and electric field intensity.
- vacuumMagneticPermeability → const Permeability
- The magnetic permeability in a classical vacuum.
- vonKlitzingConstant → const Resistance
- Relates Planck's constant and the charge of the electron.
- weakMixingAngle → const Scalar
- Weak mixing angle.
- Z0 → const Resistance
- A synonym for characteristicImpedanceOfVacuum.
- zilch → const Scalar
- A synonym for zero.
Properties
- abamperes → CurrentUnits
-
Abamperes as a unit.
final
- abcoulombs → ChargeUnits
-
A synonym for dekacoulombs.
final
- abfarads → CapacitanceUnits
-
A unit representing one gigafarad.
final
- abhenries ↔ InductanceUnits
-
Abhenries is a synonym for nanohenries.
getter/setter pair
- abmho → ConductanceUnits
-
Equivalent to a billion siemens (or mhos).
final
- abvolts ↔ ElectricPotentialDifferenceUnits
-
The unit of electromotive force (EMF) or potential difference in the CGS (centimeter/gram/second)
electromagnetic system of units. When an EMF of 1 abV exists between two points, then one erg of energy
is needed to move one abcoulomb (1 abC) of charge carriers between those two points.
getter/setter pair
- acreFoot ↔ VolumeUnits
-
Acre foot as a unit.
getter/setter pair
- acres → AreaUnits
-
An acre is about three-quarters of the size of an American football field.
final
- aeons → TimeUnits
-
A unit of one billion years.
final
-
allQuantityTypes
→ Iterable<
Type> -
Returns an iterable of Type objects representing all of the quantity types
supported by this library (for example, Angle, Length, etc.).
no setter
- ampereHours → ChargeUnits
-
Ampere hours as a unit.
final
- amperes → CurrentUnits
-
The standard SI unit.
final
- amps → CurrentUnits
-
A synonym for amperes.
final
- angle0 → Angle
-
A zero degree angle.
final
- angle180 → Angle
-
A one hundred eighty degree angle.
final
- angle270 → Angle
-
A two hundred seventy degree angle.
final
- angle30 → Angle
-
A thirty degree angle.
final
- angle360 → Angle
-
A three hundred sixty degree angle.
final
- angle45 → Angle
-
A forty five degree angle.
final
- angle60 → Angle
-
A sixty degree angle.
final
- angle90 → Angle
-
A ninety degree angle.
final
- anglePi → Angle
-
A one hundred eighty degree angle.
final
- angleTau → Angle
-
A three hundred sixty degree angle.
final
- ares → AreaUnits
-
Accepted for use with the SI, subject to further review.
Equals one square dekameter, or 100 square meters.
final
- atmospheres ↔ PressureUnits
-
Standard atmospheres as a unit.
getter/setter pair
- atmospheresTechnical ↔ PressureUnits
-
Technical atmospheres as a unit.
getter/setter pair
- attoseconds → TimeUnits
-
10^-18 of a second.
final
- B → TimeInstantUnits
-
Besselian - Replaced by Julian system, but still of occasional use
final
- bakersDozen → ScalarUnits
-
A baker's dozen is 13. One extra donut. Thank you.
final
- barns → AreaUnits
-
Accepted for use with the SI, subject to further review.
Equals 100 square femtometers, or 1.0e-28 square meters.
final
- barrels ↔ VolumeUnits
-
Barrels as a unit.
getter/setter pair
- barrelsPetroleum ↔ VolumeUnits
-
Barrels petroleum as a unit.
getter/setter pair
- bars ↔ PressureUnits
-
Shorthand bars unit.
getter/setter pair
- baryes ↔ PressureUnits
-
Baryes as a unit.
getter/setter pair
- billionEur → ScalarUnits
-
The European variant of one billion (10^12) as a unit.
final
- billionthsUS → ScalarUnits
-
One billionth (US: 10^-9) as a unit.
final
- billionUS → ScalarUnits
-
One billion (US: 10^9) as a unit.
final
- bits → InformationUnits
-
The standard SI unit.
final
- boardFeet ↔ VolumeUnits
-
Board feet as a unit.
getter/setter pair
- boltzmannUnit → EntropyUnits
-
Boltzmann constant as a unit.
final
- btu39 → EnergyUnits
-
39 degree Fahrenheit BTUs as a unit.
final
- btu60 → EnergyUnits
-
60 degree Fahrenheit BTUs as a unit.
final
- btuInternationalTable → EnergyUnits
-
International Table BTUs as a unit.
final
- btuMean → EnergyUnits
-
Mean BTUs as a unit.
final
- btuThermo → EnergyUnits
-
Thermochemical BTUs as a unit.
final
- btuThermsPerHour ↔ PowerUnits
-
Square degrees as a unit.
getter/setter pair
- btuThermsPerSecond ↔ PowerUnits
-
Thermochemical BTUs per second as a unit.
getter/setter pair
- bushels ↔ VolumeUnits
-
Bushels as a unit.
getter/setter pair
- bytes → InformationUnits
-
Units of 8 bits.
final
- calories15 → EnergyUnits
-
15 degree Celsius calories as a unit.
final
- calories20 → EnergyUnits
-
20 degree Celsius calories as a unit.
final
- caloriesInternationalTable → EnergyUnits
-
International Table calories as a unit.
final
- caloriesKgInternationalTable → EnergyUnits
-
International Table kilogram calories as a unit.
final
- caloriesKgMean → EnergyUnits
-
Mean kilogram calories as a unit.
final
- caloriesKgThermo → EnergyUnits
-
Thermochemical kilogram calories as a unit.
final
- caloriesMean → EnergyUnits
-
Mean calories as a unit.
final
- caloriesThermo → EnergyUnits
-
Thermochemical calories as a unit.
final
- caloriesThermoPerSecond ↔ PowerUnits
-
Thermochemical calories as a unit.
getter/setter pair
- candelas → LuminousIntensityUnits
-
The standard SI unit.
final
- caratsMetric → MassUnits
-
Metric carats as a unit.
final
- cefaCurrency → Currency
-
final
- centiseconds → TimeUnits
-
A hundredth of a second.
final
- centistokes ↔ KinematicViscosityUnits
-
Centistokes as a unit.
getter/setter pair
- circularMils → AreaUnits
-
Equal to the area of a circle with a diameter of one mil (one thousandth of an inch).
It is often used for representing the area of a wire's circular cross section.
final
- clausius → EntropyUnits
-
The erg per clausius unit of entropy.
final
- cmMercury0 ↔ PressureUnits
-
Centimeters of mercury at 0 degrees Celsius.
getter/setter pair
- cmWater4 ↔ PressureUnits
-
Centimeters of water at 4 degrees Celsius.
getter/setter pair
- cords ↔ VolumeUnits
-
Cords as a unit.
getter/setter pair
- cos30 → double
-
The cosine of a thirty degree angle.
final
- cos45 → double
-
The cosine of a forty five degree angle.
final
- coulombs → ChargeUnits
-
The standard SI unit.
final
- cubicCentimeters ↔ VolumeUnits
-
Cubic centimeters as a unit.
getter/setter pair
- cubicFeet ↔ VolumeUnits
-
Barrels as a unit.
getter/setter pair
- cubicInches ↔ VolumeUnits
-
Cubic inches as a unit.
getter/setter pair
- cubicMeters ↔ VolumeUnits
-
The standard SI unit.
getter/setter pair
- cubicMetersPerSecond ↔ VolumeFlowRateUnits
-
The standard SI unit, tersely.
getter/setter pair
- cubicParsecs ↔ VolumeUnits
-
Cubic parsecs as a unit.
getter/setter pair
- cubicYards ↔ VolumeUnits
-
Cubic yards as a unit.
getter/setter pair
- cumecs ↔ VolumeFlowRateUnits
-
Shorthand synonym for standard SI unit.
getter/setter pair
- cups ↔ VolumeUnits
-
Cups as a unit.
getter/setter pair
- days → TimeUnits
-
Accepted for use with the SI.
final
- daysMeanSolar → TimeUnits
-
Accepted for use with the SI.
final
- daysSidereal → TimeUnits
-
A sidereal day is the time between two consecutive transits of the First Point of Aries. It represents the time
taken by the Earth to rotate on its axis relative to the stars, and is almost four minutes shorter than the solar
day because of the Earth's orbital motion.
final
- decillionEur → ScalarUnits
-
The European variant of one decillion (10^60) as a unit.
final
- decillionUS → ScalarUnits
-
One decillion (US: 10^33) as a unit.
final
- decimalPrecision ↔ int
-
The default precision of a
Precision
. The default value is 50. This can be changed by setting the global variabledecimalPrecision
.getter/setter pair - deciseconds → TimeUnits
-
A tenth of a second.
final
- deg → AngleUnits
-
Synonymous with degrees.
final
- degF → TemperatureIntervalUnits
-
A synonym for degreesFahrenheit.
final
- degK → TemperatureIntervalUnits
-
A synonym for degrees Kelvin.
final
- degR → TemperatureIntervalUnits
-
A synonym for degreesRankine.
final
- degrees → AngleUnits
-
A terse version of
Angle.degrees
.final - degreesCelsius → TemperatureUnits
-
Degrees in the Celsius scale.
final
- degreesFahrenheit → TemperatureIntervalUnits
-
Degrees in the Fahrenheit scale.
final
- degreesRankine → TemperatureIntervalUnits
-
Degrees in the Rankine scale.
final
- dekaseconds → TimeUnits
-
Ten seconds.
final
- dozen → ScalarUnits
-
A dozen is 12.
final
- drams ↔ VolumeUnits
-
Drams as a unit.
getter/setter pair
- dramsApothecary → MassUnits
-
Apothecary drams as a unit.
final
- dramsAvoirdupois → MassUnits
-
Avoirdupois drams as a unit.
final
- duotrigintillion → ScalarUnits
-
One duotrigintillion (10^99) as a unit.
final
- dynamicQuantityTyping ↔ bool
-
Dynamic quantity typing may be turned off for increased
efficiency. If false, the result of operations where
dimensions may change will be MiscQuantity type objects.
getter/setter pair
- dynes ↔ ForceUnits
-
Dynes as a unit.
getter/setter pair
- electronVolts → EnergyUnits
-
Accepted for use with the SI.
final
- emuCapacitance → CapacitanceUnits
-
Electromagnetic unit (emu), the capacity of a circuit component to store charge.
final
- emuOfInductance ↔ InductanceUnits
-
EMU of inductance is a synonym for nanohenries.
getter/setter pair
- emuPotential ↔ ElectricPotentialDifferenceUnits
-
Synonymous with abvolts.
getter/setter pair
- englishConfig → LanguageConfig
-
An English configuration for conversion
final
- eons → TimeUnits
-
A synonym for aeons.
final
- ergPerKelvin → EntropyUnits
-
The erg per kelvin unit of entropy.
final
- ergs → EnergyUnits
-
Ergs as a unit.
final
- ergsPerSecond ↔ PowerUnits
-
Ergs per second as a unit.
getter/setter pair
- esuCapacitance → CapacitanceUnits
-
A synonym for statfarads.
final
- esuOfInductance ↔ InductanceUnits
-
ESU of inductance as a unit.
getter/setter pair
- esuPotential ↔ ElectricPotentialDifferenceUnits
-
Synonymous with statvolts.
getter/setter pair
- ET → TimeInstantUnits
-
Ephemeris Time (ET) is the same as TDT: ET = TDT = TT = TAI + 32.184 s.
Ephemeris Time was renamed Terrestrial Dynamical Time in 1984 (when
Barycentric Dynamical Time was also introduced)
final
- euroCurrency → Currency
-
final
- exabytes → InformationUnits
-
10^18 bytes.
Use Information.exbibytes (EiB) instead for the binary interpretation of EB (2^60 bytes).
final
- exaseconds → TimeUnits
-
10^18 seconds.
final
- Fahrenheit → TemperatureUnits
-
Fahrenheit scale units.
final
- faradaysC12 → ChargeUnits
-
Carbon 12 faradays as a unit.
final
- faradaysChemical → ChargeUnits
-
Chemical faradays as a unit.
final
- faradaysPhysical → ChargeUnits
-
Physical faradays as a unit.
final
- farads → CapacitanceUnits
-
The standard SI unit.
final
- faradsPerMeter ↔ PermittivityUnits
-
The standard SI unit.
getter/setter pair
- feetPerHour ↔ SpeedUnits
-
Feet per hour as a unit.
getter/setter pair
- feetPerMinute ↔ SpeedUnits
-
Feet per minute as a unit.
getter/setter pair
- feetPerSecond ↔ SpeedUnits
-
Feet per second as a unit.
getter/setter pair
- femtoseconds → TimeUnits
-
10^-15 of a second.
final
- fileIO ↔ FileIO
-
getter/setter pair
- fluidOunces ↔ VolumeUnits
-
Fluid ounces as a unit.
getter/setter pair
- fluidOuncesUK ↔ VolumeUnits
-
U.K. fluid ounces as a unit.
getter/setter pair
- fluxUnits → SpectralIrradianceUnits
-
Synonymous with janskys.
final
- footCandles ↔ IlluminanceUnits
-
Foot candles as a unit.
getter/setter pair
- footPerSecondSquared → AccelerationUnits
-
A commonly used English unit of acceleration.
final
- footPoundals → EnergyUnits
-
Foot-poundals as a unit.
final
- footPoundsForce → EnergyUnits
-
Foot pounds force as a unit.
final
- forceDeCheval ↔ PowerUnits
-
Force de cheval as a unit.
getter/setter pair
- frenchConfig → LanguageConfig
-
A French configuration for conversion
final
- ftWater39 ↔ PressureUnits
-
Feet of water at 39.2 degrees Fahrenheit.
getter/setter pair
- g → MassUnits
-
Gram unit synonym.
final
- galileos → AccelerationUnits
-
Defined as 0.01 meter per second squared.
final
- gallonsUKLiquid ↔ VolumeUnits
-
U.K. liquid gallons as a unit.
getter/setter pair
- gallonsUSDry ↔ VolumeUnits
-
U.S. dry gallons as a unit.
getter/setter pair
- gallonsUSLiquid ↔ VolumeUnits
-
U.S. liquid gallons as a unit.
getter/setter pair
- gals → AccelerationUnits
-
Synonymous with galileos.
final
- gammas → MassUnits
-
Microgram units.
final
- gauss ↔ MagneticFluxDensityUnits
-
One gauss is one ten-thousandth of a tesla.
getter/setter pair
- gees → AccelerationUnits
-
A unit based on the acceleration experienced by a free-falling body at the Earth's surface.
final
- gigabytes → InformationUnits
-
10^9 bytes.
Use Information.gibibytes (GiB) instead for the binary interpretation of GB (2^30 bytes).
final
- gigaseconds → TimeUnits
-
A billion seconds.
final
- gilberts → CurrentUnits
-
Gilberts as a unit.
final
- gillsUK ↔ VolumeUnits
-
U.K. gills as a unit.
getter/setter pair
- gillsUS ↔ VolumeUnits
-
U.S. gills as a unit.
getter/setter pair
- googol ↔ Scalar
-
googol (10^100), arbitrary precision.
getter/setter pair
- googols → ScalarUnits
-
One googol (10^100) as a unit.
final
- GPST → TimeInstantUnits
-
GPS Satellite Time (GPST): GPST = TAI - 19 s
final
- grains → MassUnits
-
Grains as a unit.
final
- grams → MassUnits
-
A unit of one gram.
final
- gramsPerCubicCentimeter ↔ MassDensityUnits
-
Grams per cubic centimeter as a unit.
getter/setter pair
- greatGross → ScalarUnits
-
A great gross is 1728.
final
- gross → ScalarUnits
-
A gross is 144.
final
- halfDozen → ScalarUnits
-
A half-dozen is 6.
final
- hBarUnits → AngularMomentumUnits
-
The Planck constant divided by 2 PI (a.k.a., 'h-bar') as units.
final
- hectares → AreaUnits
-
Accepted for use with the SI, subject to further review.
Equals 1 square hectometer, or 10 000 square meters.
final
- hectoseconds → TimeUnits
-
A hundred seconds.
final
- henries ↔ InductanceUnits
-
The standard SI unit.
getter/setter pair
- henriesPerMeter ↔ PermeabilityUnits
-
The standard SI unit.
getter/setter pair
- hogsheads ↔ VolumeUnits
-
Hogsheads as a unit.
getter/setter pair
- horsepower550 ↔ PowerUnits
-
Horsepower (550 ft lbs/s) as a unit.
getter/setter pair
- horsepowerBoiler ↔ PowerUnits
-
Horsepower (boiler) as a unit.
getter/setter pair
- horsepowerElectric ↔ PowerUnits
-
Horsepower (electric) as a unit.
getter/setter pair
- horsepowerMetric ↔ PowerUnits
-
Horsepower (metric) as a unit.
getter/setter pair
- horsepowerWater ↔ PowerUnits
-
Horsepower (water) as a unit.
getter/setter pair
- hours → TimeUnits
-
Accepted for use with the SI.
final
- hoursMeanSolar → TimeUnits
-
Accepted for use with the SI.
final
- hoursSidereal → TimeUnits
-
A unit of one hour in the sidereal day.
final
- hundred → ScalarUnits
-
100 as a unit.
final
- hundredths → ScalarUnits
-
One hundredth as a unit.
final
- hundredweightLong → MassUnits
-
Long hundredweight as a unit.
final
- hundredweightShort → MassUnits
-
Short hundredweight as a unit.
final
- inchesPerSecond ↔ SpeedUnits
-
Inches per second as a unit.
getter/setter pair
- inchPerSecondSquared → AccelerationUnits
-
A commonly used English unit of acceleration.
final
- inMercury32 ↔ PressureUnits
-
Inches of mercury at 32 degrees Fahrenheit.
getter/setter pair
- inWater39 ↔ PressureUnits
-
Inches of water at 39.2 degrees Fahrenheit.
getter/setter pair
- J2000 → TimeInstant
-
J2000.0 as defined by the IAU: Julian date: 2000 Jan 1d 12h UT in the TDT time scale
final
- janskys → SpectralIrradianceUnits
-
A non-SI unit of spectral irradiance used especially in radio astronomy.
final
- JD_TAI → TimeInstantUnits
-
Julian Date in the TAI scale
final
- JD_TCB → TimeInstantUnits
-
Julian Date in the TCB scale
final
- JD_TCG → TimeInstantUnits
-
Julian Date in the TCG scale
final
- JD_TDB → TimeInstantUnits
-
Julian Date in the TDB (TB) scale
final
- JD_TDT → TimeInstantUnits
-
Julian Date in the TDT (TT) scale
final
- JD_UT1 → TimeInstantUnits
-
Julian Date in the UT1 scale
final
- JD_UTC → TimeInstantUnits
-
Julian Date in the UTC scale
final
- joules → EnergyUnits
-
The standard SI unit.
final
- jouleSecond → AngularMomentumUnits
-
The standard SI unit.
final
- joulesPerKelvin → EntropyUnits
-
The standard SI unit.
final
- joulesPerKilogram ↔ SpecificEnergyUnits
-
The standard SI unit.
getter/setter pair
- kelvins → TemperatureUnits
-
The standard SI unit.
final
- kg → MassUnits
-
Kilogram unit synonym.
final
- kgfSecondSquaredMeter → MassUnits
-
Kilogram force second square meter as a unit.
final
- kilobytes → InformationUnits
-
1000 bytes (8000 bits).
Use Information.kibibytes (kiB) instead for the binary interpretation of kB (1024 bytes).
final
- kilocaloriesThermo → EnergyUnits
-
A synonym for thermochemical kilogram calories.
final
- kilograms → MassUnits
-
The standard SI unit.
final
- kilogramsForce ↔ ForceUnits
-
Kilograms force as a unit.
getter/setter pair
- kilogramsPerCubicMeter ↔ MassDensityUnits
-
The standard SI unit.
getter/setter pair
- kilojoules → EnergyUnits
-
Kilojoules as a unit.
final
- kilometersPerHour ↔ SpeedUnits
-
Kilometers per hour as a unit.
getter/setter pair
- kilomoles → AmountOfSubstanceUnits
-
A unit of one thousand moles.
final
- kiloponds ↔ ForceUnits
-
A synonym for kilograms force.
getter/setter pair
- kiloseconds → TimeUnits
-
A thousand seconds.
final
- kilowattHours → EnergyUnits
-
Kilowatt-hours as a unit.
final
- kilowatts ↔ PowerUnits
-
Shorthand kilowatts as a unit.
getter/setter pair
- kips ↔ ForceUnits
-
Kips as a unit.
getter/setter pair
- knots ↔ SpeedUnits
-
Knots, tersely.
getter/setter pair
- langleys → EnergyFluxUnits
-
Langleys as a unit.
final
- liters ↔ VolumeUnits
-
A terse alternative to
Volume.liters
.getter/setter pair - litersPerSecond ↔ VolumeFlowRateUnits
-
0.001 cubic meter per second.
getter/setter pair
- logger ↔ Logger
-
Logger for use across entire library
getter/setter pair
- lusecs ↔ VolumeFlowRateUnits
-
Shorthand synonym for liters per second.
getter/setter pair
- lux ↔ IlluminanceUnits
-
The standard SI unit.
getter/setter pair
- magFieldAtomicUnit ↔ MagneticFluxDensityUnits
-
Magnetic field atomic unit.
getter/setter pair
- magneticGammas ↔ MagneticFluxDensityUnits
-
A synonym for nanoteslas.
getter/setter pair
- maxwells ↔ MagneticFluxUnits
-
A maxwell is one one-hundred-millionth of a weber.
getter/setter pair
- megabytes → InformationUnits
-
10^6 bytes.
Use Information.mebibytes (MiB) instead for the binary interpretation of MB (2^20 bytes).
final
- megaseconds → TimeUnits
-
A million seconds.
final
- meterPerSecondSquared → AccelerationUnits
-
A synonym for the standard SI-MKS unit of acceleration.
final
- metersPerSecond ↔ SpeedUnits
-
The standard SI unit.
getter/setter pair
- metersSquaredPerSecond ↔ KinematicViscosityUnits
-
The standard SI unit.
getter/setter pair
- metricTons → MassUnits
-
Accepted for use with the SI.
final
- mg → MassUnits
-
Milligram unit synonym.
final
- mho → ConductanceUnits
-
Synonymous with Siemens.
final
- microseconds → TimeUnits
-
A millionth of a second.
final
- milesPerHour ↔ SpeedUnits
-
Miles per hour as a unit.
getter/setter pair
- milesPerMinute ↔ SpeedUnits
-
Miles per minute as a unit.
getter/setter pair
- milesPerSecond ↔ SpeedUnits
-
Miles per second as a unit.
getter/setter pair
- millibars ↔ PressureUnits
-
A millibar as a unit.
getter/setter pair
- milligrams → MassUnits
-
A unit of one thousandth of a gram.
final
- million → ScalarUnits
-
One million as a unit.
final
- millionths → ScalarUnits
-
One millionth as a unit.
final
- milliradian → AngleUnits
-
A unit of one thousandth of a radian.
final
- milliseconds → TimeUnits
-
A thousandth of a second.
final
- minersInches ↔ VolumeFlowRateUnits
-
The miner's inch as a unit.
getter/setter pair
- minutes → TimeUnits
-
Accepted for use with the SI.
final
- minutesArc → AngleUnits
-
A terse version of
Angle.minutesArc
.final - minutesMeanSolar → TimeUnits
-
Accepted for use with the SI.
final
- minutesSidereal → TimeUnits
-
A unit of one minute in the sidereal day.
final
- MJD_TAI → TimeInstantUnits
-
Modified Julian Date in the TAI scale
final
- MJD_TCB → TimeInstantUnits
-
Modified Julian Date in the TCB scale
final
- MJD_TCG → TimeInstantUnits
-
Modified Julian Date in the TCG scale
final
- MJD_TDB → TimeInstantUnits
-
Modified Julian Date in the TDB scale
final
- MJD_TDT → TimeInstantUnits
-
Modified Julian Date in the TDT scale
final
- MJD_UT1 → TimeInstantUnits
-
Modified Julian Date in the UT1 scale
final
- MJD_UTC → TimeInstantUnits
-
Modified Julian Date in the UTC scale
final
- moles → AmountOfSubstanceUnits
-
A synonym for the SI-MKS base unit of amount of substance.
final
- musecs ↔ VolumeFlowRateUnits
-
Shorthand synonym for standard SI unit.
getter/setter pair
- myriad → ScalarUnits
-
A myriad is ten thousand.
final
- nanoseconds → TimeUnits
-
A billionth of a second.
final
- newtons → ForceUnits
-
The standard SI unit.
final
- newtonsPerAmpereSquared ↔ PermeabilityUnits
-
Newtons per ampere as a unit.
getter/setter pair
- newtonsPerSquareMeter ↔ PressureUnits
-
A synonym for pascals.
getter/setter pair
- nonillionEur → ScalarUnits
-
The European variant of one nonillion (10^54) as a unit.
final
- nonillionUS → ScalarUnits
-
One nonillion (US: 10^30) as a unit.
final
- NTP → TimeInstantUnits
-
Network Time Protocol (NTP) - NTP is offset from the UTC time scale, with its epoch at 1 Jan 1900 0h
final
- octillionEur → ScalarUnits
-
The European variant of one octillion (10^48) as a unit.
final
- octillionUS → ScalarUnits
-
One octillion (US: 10^27) as a unit.
final
- ohms ↔ ResistanceUnits
-
The standard SI unit.
getter/setter pair
- one → ScalarUnits
-
The standard SI unit.
final
- ouncesApothecary → MassUnits
-
Apothecary ounces as a unit.
final
- ouncesAvoirdupois → MassUnits
-
Avoirdupois ounces as a unit.
final
- ouncesForceAvoirdupois ↔ ForceUnits
-
Avoirdupois ounces force as a unit.
getter/setter pair
- pair → ScalarUnits
-
A pair is 2.
final
- pascals ↔ PressureUnits
-
The standard SI unit.
getter/setter pair
- pecks ↔ VolumeUnits
-
Pecks as a unit.
getter/setter pair
- pennyweightTroy → MassUnits
-
Troy pennyweight as a unit.
final
- percent → ScalarUnits
-
Synonymous with Scalar.percent.
final
- petabytes → InformationUnits
-
10^15 bytes.
Use Information.pebibytes (PiB) instead for the binary interpretation of PB (2^50 bytes).
final
- petaseconds → TimeUnits
-
10^15 seconds.
final
- phots ↔ IlluminanceUnits
-
Phots as a unit.
getter/setter pair
- picoseconds → TimeUnits
-
10^-12 of a second.
final
- pintsDry ↔ VolumeUnits
-
U.S. dry pints as a unit.
getter/setter pair
- pintsLiquid ↔ VolumeUnits
-
U.S. liquid pints as a unit.
getter/setter pair
- planckUnits → AngularMomentumUnits
-
The Planck constant as units.
final
- poundals ↔ ForceUnits
-
Poundals as a unit.
getter/setter pair
- poundsApothecary → MassUnits
-
Apothecary pounds as a unit.
final
- poundsAvoirdupois → MassUnits
-
Avoirdupois pounds as a unit.
final
- poundsForceAvoirdupois ↔ ForceUnits
-
Avoirdupois pounds force as a unit.
getter/setter pair
- poundsPerCubicFoot ↔ MassDensityUnits
-
Pounds per cubic foot as a unit.
getter/setter pair
- poundsPerCubicInch ↔ MassDensityUnits
-
Pounds per cubic inch as a unit.
getter/setter pair
- psi ↔ PressureUnits
-
Pounds per square inch as a unit.
getter/setter pair
- quadrillionEur → ScalarUnits
-
The European variant of one quadrillion (10^24) as a unit.
final
- quadrillionUS → ScalarUnits
-
One quadrillion (US: 10^15) as a unit.
final
- quartsDry ↔ VolumeUnits
-
U.S. dry quarts as a unit.
getter/setter pair
- quartsLiquid ↔ VolumeUnits
-
U.S. liquid quarts as a unit.
getter/setter pair
- quintals → MassUnits
-
A quintal is 100 kilograms.
final
- quintillionEur → ScalarUnits
-
The European variant of one quintillion (10^30) as a unit.
final
- quintillionUS → ScalarUnits
-
One quintillion (US: 10^18) as a unit.
final
- rad → AngleUnits
-
Synonymous with radians.
final
- radians → AngleUnits
-
A terse version of
Angle.radians
.final - Rankine → TemperatureUnits
-
Rankine scale units.
final
- referenceSound ↔ PowerUnits
-
A power commonly used as the reference power for calculation of sound power levels.
getter/setter pair
- referenceSoundAir ↔ PressureUnits
-
A pressure often used as the reference pressure for calculation of
sound pressure levels.
getter/setter pair
- referenceSoundWater ↔ PressureUnits
-
A pressure commonly used as the reference pressure for calculation of
sound pressure levels.
getter/setter pair
- registryTons ↔ VolumeUnits
-
Registry tons as a unit.
getter/setter pair
- romanNumeralConfig ↔ RomanNumeralsConfig
-
Sets the RomanNumeralsConfig to be used globally for all RomanNumerals instances.
This allows customizing the behavior of the RomanNumerals class, such as the
representation of zero or the use of overline.
getter/setter pair
- score → ScalarUnits
-
A score is 20. Four score is 80. More poetic than just saying eighty.
final
- scruples → MassUnits
-
Scruples as a unit.
final
- seconds → TimeUnits
-
The standard SI unit.
final
- secondsArc → AngleUnits
-
A terse version of
Angle.secondsArc
.final - secondsSidereal → TimeUnits
-
A unit of one second in the sidereal day.
final
- sections → AreaUnits
-
Synonymous with squareMiles.
final
- septillionEur → ScalarUnits
-
The European variant of one billion (10^42) as a unit.
final
- septillionUS → ScalarUnits
-
One septillion (US: 10^24) as a unit.
final
- sextillionEur → ScalarUnits
-
The European variant of one sextillion (10^36) as a unit.
final
- sextillionUS → ScalarUnits
-
One sextillion (US: 10^21) as a unit.
final
- sin45 → double
-
The sine of a forty five degree angle.
final
- sin60 → double
-
The sine of a sixty degree angle.
final
- slugs → MassUnits
-
Slugs as a unit.
final
- slugsPerCubicFoot ↔ MassDensityUnits
-
Slugs per cubic foot as a unit.
getter/setter pair
- speedOfLightSquared ↔ SpecificEnergyUnits
-
The square of the speed of light in a vacuum.
getter/setter pair
- speedOfLightUnits ↔ SpeedUnits
-
The speed of light as a unit.
getter/setter pair
- squareCentimeters → AreaUnits
-
An area unit equivalent to a square with sides having a length of one centimeter.
final
- squareFeet → AreaUnits
-
An area unit equivalent to a square with sides having a length of one foot.
final
- squareFeetPerSecond ↔ KinematicViscosityUnits
-
Square feet per second as a unit.
getter/setter pair
- squareInches → AreaUnits
-
An area unit equivalent to a square with sides having a length of one inch.
final
- squareKilometers → AreaUnits
-
An area unit equivalent to a square with sides having a length of one kilometer.
final
- squareMeters → AreaUnits
-
The standard SI unit.
final
- squareMetersPerSquareSecond ↔ SpecificEnergyUnits
-
Square meters per second as a unit.
getter/setter pair
- squareMiles → AreaUnits
-
An area unit equivalent to a square with sides having a length of one mile.
final
- squarePerches → AreaUnits
-
Synonymous with squareRods.
final
- squarePoles → AreaUnits
-
Synonymous with squareRods.
final
- squareRods → AreaUnits
-
An area unit equivalent to a square with sides having a length of one rod.
final
- squareYards → AreaUnits
-
An area unit equivalent to a square with sides having a length of one yard.
final
- standardAccelerationOfGravity → AccelerationUnits
-
The more formal name for gees.
final
- statamperes → CurrentUnits
-
Statamperes as a unit.
final
- statcoulombs → ChargeUnits
-
Statcoulombs as a unit.
final
- statfarads → CapacitanceUnits
-
The statfarad is the standard unit of capacitance in the cgs (centimeter/gram/second) system.
final
- statmhos → ConductanceUnits
-
A non-SI unit of electrical conductance.
final
- statvolts ↔ ElectricPotentialDifferenceUnits
-
A useful unit for electromagnetism because, in a vacuum, an electric field of one statvolt/cm has
the same energy density as a magnetic field of one gauss. Likewise, a plane wave propagating in a
vacuum has perpendicular electric and magnetic fields such that for every gauss of magnetic field
intensity there is one statvolt/cm of electric field intensity.
getter/setter pair
- steres ↔ VolumeUnits
-
A synonym for cubic meters.
getter/setter pair
- stokes ↔ KinematicViscosityUnits
-
Stokes as a unit.
getter/setter pair
- system → TimeInstantUnits
-
Measures time since 1 Jan 1970 0h 0m 0s, which is the System
time defined by many computer operating systems
final
- tablespoons ↔ VolumeUnits
-
Tablespoons as a unit.
getter/setter pair
- TAI → TimeInstantUnits
-
International Atomic Time scale units
final
- tan30 → double
-
The tangent of a thirty degree angle.
final
- tan60 → double
-
The tangent of a sixty degree angle.
final
- TB → TimeInstantUnits
-
Barycentric Time (TB); same as TDB: TT = TDB
final
- TCB → TimeInstantUnits
-
Barycentric Coordinate Time (TCB): TCB = TDB + (1.550505e-8)(JD - 2443144.5)(86400)
final
- TCG → TimeInstantUnits
-
Geocentric Coordinate Time (TCG): TCG = TDT + (6.969291e-10)(JD - 2443144.5)(86400)
final
- TDB → TimeInstantUnits
-
Barycentric Dynamical Time (TDB): TDB varies from TDT by periodic variations
final
- TDT → TimeInstantUnits
-
Terrestrial Dynamical Time (TDT): TDT = TAI + 32.184 s
final
- teaspoons ↔ VolumeUnits
-
Teaspoons as a unit.
getter/setter pair
- tenths → ScalarUnits
-
One tenth as a unit.
final
- terabytes → InformationUnits
-
10^12 bytes.
Use Information.tebibytes (TiB) instead for the binary interpretation of TB (2^40 bytes).
final
- teraseconds → TimeUnits
-
10^12 seconds.
final
- teslas ↔ MagneticFluxDensityUnits
-
The standard SI unit.
getter/setter pair
- thermalCoulomb → EntropyUnits
-
Entropy as a 'charge'; identical to joulesPerKelvin.
final
- therms → EnergyUnits
-
Therms as a unit.
final
- thousand → ScalarUnits
-
1000 as a unit.
final
- thousandths → ScalarUnits
-
One thousandth as a unit.
final
- tonnes → MassUnits
-
Accepted for use with the SI.
final
- tons → EnergyUnits
-
Tons of TNT equivalent as a unit.
final
- tonsAssay → MassUnits
-
Assay tons as a unit.
final
- tonsLong → MassUnits
-
Long tons as a unit.
final
- tonsShort → MassUnits
-
Short tons as a unit.
final
- torrs ↔ PressureUnits
-
Torrs as a unit.
getter/setter pair
- townships → AreaUnits
-
An area unit used in US surveyors' measures equalling 36 square miles.
final
- trillionEur → ScalarUnits
-
The European variant of one trillion (10^18) as a unit.
final
- trillionthsUS → ScalarUnits
-
One trillionth (US: 10^-12) as a unit.
final
- trillionUS → ScalarUnits
-
One trillion (US: 10^12) as a unit.
final
- TT → TimeInstantUnits
-
Terrestrial Time (TT) is the same as TDT: TDT = TT = TAI + 32.184 s
final
- unifiedAtomicMassUnits → MassUnits
-
Accepted for use with the SI.
final
- unitPoles ↔ MagneticFluxUnits
-
Unit poles as a unit.
getter/setter pair
- unitPolesDensity ↔ MagneticFluxDensityUnits
-
Unit poles density as a unit.
getter/setter pair
- usdCurrency → Currency
-
final
- UT1 → TimeInstantUnits
-
Universal Time (UT1): UT1 = TDT - Delta T
final
- UT2 → TimeInstantUnits
-
Universal Time (UT2):
UT2 = UT1 + 0.022 sin(2PIt) - 0.012 cos(2PIt) - 0.006 sin(4PIt) + 0.007 cos(4PIt),
where t = the date in Besellian years
final
- UTC → TimeInstantUnits
-
Coordinated Universal Time (differs from TAI by a number of leap seconds)
final
- volts ↔ ElectricPotentialDifferenceUnits
-
The standard SI unit.
getter/setter pair
- wattHour → EnergyUnits
-
Watt-hour as a unit.
final
- watts ↔ PowerUnits
-
The standard SI unit.
getter/setter pair
- wattSecond → EnergyUnits
-
Watt-second as a unit.
final
- wattsPerSquareMeter → EnergyFluxUnits
-
The standard SI unit.
final
- webers ↔ MagneticFluxUnits
-
The standard SI unit.
getter/setter pair
- yearsCalendar → TimeUnits
-
Calendar years as a unit.
final
- yearsJulian → TimeUnits
-
Defined as exactly 365.25 days of 86400 SI seconds each.
The length of the Julian year is the average length of the year in the Julian calendar that was used in Western
societies until some centuries ago, and from which the unit is named.
final
- yearsSidereal → TimeUnits
-
Sidereal years as a unit.
final
- yearsTropical → TimeUnits
-
Tropical years as a unit.
final
- yoctoseconds → TimeUnits
-
10^-24 of a second.
final
- yottaseconds → TimeUnits
-
10^24 seconds.
final
- zeptoseconds → TimeUnits
-
10^-21 of a second.
final
- zettaseconds → TimeUnits
-
10^21 seconds.
final
Functions
-
abs(
num x) → num - Returns the absolute value of a number.
-
acos(
dynamic x) → dynamic - Returns the arccosine of a number in radians.
-
acosh(
num x) → double - Returns the inverse hyperbolic cosine (acosh) of the number.
-
acot(
dynamic x) → dynamic -
Returns the arccotangent (inverse of the cotangent) of
x
. -
acoth(
num x) → double -
Returns the inverse hyperbolic cotangent (acoth) of
x
. -
acsc(
dynamic x) → dynamic -
Returns the arccosecant (inverse of the cosecant) of
x
. -
acsch(
num x) → double -
Returns the inverse hyperbolic cosecant (acsch) of
x
. -
angleFromHourMinSec(
int hour, int minute, double second, [double uncert = 0]) → Angle - Constructs an angle from hours, minutes and seconds of time (as opposed to arc).
-
annulus(
) → void -
areWithin(
Quantity q1, Quantity q2, Quantity tolerance) → bool -
Returns whether or not the magnitude of the difference between two
quantities is less than or equal to the specified
tolerance
. -
asec(
dynamic x) → dynamic -
Returns the arcsecant (inverse of the secant) of
x
. -
asech(
num x) → double -
Returns the inverse hyperbolic secant (asech) of
x
. -
asin(
dynamic x) → dynamic - Returns the arcsine of a number in radians.
-
asinh(
num x) → double - Returns the inverse hyperbolic sine (asinh) of the number.
-
atan(
dynamic x) → dynamic - Returns the arctangent of a number.
-
atan2(
dynamic a, dynamic b) → dynamic - Returns the angle in radians between the positive x-axis and the vector.
-
atanh(
num x) → double - Returns the inverse hyperbolic tangent (atanh) of the number.
-
bigIntNChooseRModPrime(
int N, int R, int P) → BigInt - Computes the value of C(N, R) % P using BigInt for large numbers.
-
binomialCoefficient(
int n, int k) → int - Returns the binomial coefficient, often referred to as "n choose k". The binomial coefficient is the number of ways to choose k items from n items without repetition and without order.
-
cbrt(
num x) → dynamic - Returns the cube root of a number.
-
ceil(
num x) → int - Rounds a number up to the nearest integer.
-
circle(
) → void -
clamp(
num x, num min, num max) → num - Clamps x between min and max.
-
collinear(
Point a, Point b, Point c) → bool - Checks if three points are collinear.
-
collinear2(
Point a, Point b, Point c) → int -
combinations(
dynamic n, int r, {Function? func, bool simplify = true, bool generateCombinations = true}) → dynamic -
Generates all combinations of elements from
n
takenr
at a time. -
confidenceInterval(
List< num> data, double confidenceLevel) → List<num> - Returns the confidence Interval of a dataset when a confidence level is provided
-
correlation(
List< num> x, List<num> y) → double - Returns the correlation of two lists
-
cos(
dynamic x) → dynamic - Returns the cosine of a number in radians.
-
cosh(
dynamic x) → dynamic - Returns the hyperbolic cosine of a number.
-
cot(
dynamic x) → dynamic - Returns the cotangent of a number in radians.
-
coth(
dynamic x) → dynamic - Returns the hyperbolic cotangent of a number.
-
covers(
num x) → double - Coversine function
-
createTypedQuantityInstance(
Type t, dynamic value, Units? units, {double uncert = 0.0, Dimensions? dimensions}) → Quantity -
Creates a instance of a typed quantity of type
t
having the specifiedvalue
inunits
. -
csc(
dynamic x) → dynamic - Returns the cosecant of a number in radians.
-
csch(
dynamic x) → dynamic - Returns the hyperbolic cosecant of a number.
-
degree2DMS(
num degDEC) → List< num> -
Converts
decimal degrees
to degrees, minutes, and seconds. -
degree2DMSString(
num degDEC, {bool isLat = false, bool isLatLon = false, int decPlace = 5, bool showSignAndDirection = true}) → String -
Converts a decimal degree value to a string in degrees, minutes, and seconds.
The
isLat
parameter indicates whether the coordinate is latitude (default: false). TheisLatLon
parameter specifies whether the coordinate is part of a latitude-longitude pair (default: false). ThedecPlace
parameter defines the decimal place for the second value (default: 5). TheshowSignAndDirection
parameter removes the sign or direction from the returned string (default: true). -
degrees2Minutes(
num degrees) → double - Converts degrees to minutes.
-
degrees2Percentage(
num deg) → double -
Converts
degrees
topercentage
. -
degrees2Seconds(
num degrees) → double - Converts degrees to seconds.
-
degreesToGrads(
num degrees) → double -
Converts
degrees
tograds
. -
degToRad(
num deg) → double - Converts degrees to radians.
-
diff(
Function f, [double h = 0.001]) → Function -
Computes the numerical derivative of the function
f
. -
dmm2Degree(
double deg, num min) → double -
Converts
degrees
andminutes
to decimal degrees. -
dms2Degree(
int deg, int min, num sec) → double -
Converts
degrees
,minutes
andseconds
todecimal degrees
. -
dmsList2Degrees(
List< num> dms) → double -
Converts list
[degrees, minutes, seconds]
to decimal degrees. -
doubleFactorial(
double x) → double -
Computes the double factorial of a given number
x
. -
egcd(
List< num> numbers) → List<List< num> > - Extended Euclidean algorithm to find gcd and coefficients of Bezel identity for a list of numbers.
-
ellipse(
) → void -
erf(
double x) → double -
Computes the error function of
x
. -
excsc(
num x) → double - Excosecant function
-
exp(
dynamic x) → dynamic - Returns the natural exponentiation of a number.
-
exsec(
num x) → double - Exsecant function
-
factorial(
int n) → int - Returns the factorial of a number.
-
factorial2(
dynamic x) → dynamic -
Computes the factorial of a given number
x
. -
factors(
int n) → List< int> -
Returns the factors of the given integer
n
. -
fib(
int n) → int -
Returns the nth Fibonacci number considering the sign of
n
. -
fibRange(
int start, int end) → List< num> - Returns a list of Fibonacci numbers from the start to the end.
-
floor(
num x) → int - Rounds a number down to the nearest integer.
-
gamma(
double z) → double -
Computes the gamma function of
z
. -
gcd(
List< num> numbers) → num - Returns the greatest common divisor of a list of numbers.
-
gcf(
List< num> numbers) → num - Calculates the greatest common factor (GCF) of all numbers in the input list.
-
getDeltaT(
TimeInstant time) → double - Returns the value 'Delta T,' in seconds, which relates the Terrestrial Dynamical Time scale to measured Universal Time (and indirectly UTC to TAI before 1972, when leap seconds were introduced).
-
getDigits(
int n) → List< int> - Returns a list of digits of a number.
-
getDirectionString(
num bearing, {num precision = 3}) → String -
Returns a
string
representing the compass direction of thebearing
. Precision is optional and can be set to 1 (4 compass points), 2 (8 compass points), or 3 (16 compass points). -
getLeapSeconds(
double tai, {bool pre1972LeapSeconds = false}) → num -
Returns the number of leap seconds in effect for the specified time
instant,
tai
, specified in the TAI time scale. The number of leap seconds relates the UTC time scale to the TAI time scale. -
gradsToDegrees(
num grads) → double -
Converts
grads
to degrees. -
gradsToRadians(
num grads) → double -
Converts
grads
toradians
. -
hashObjects(
Iterable< Object> objects) → int - Generates a unique hash for a set of objects.
-
havers(
num x) → double - Haversine function
-
hypot(
num x, num y) → num - Returns the hypotenuse or Euclidean norm, sqrt(xx + yy).
-
integerPart(
double x) → int -
Returns the integer part of the number
x
. -
isAlpha(
String input) → bool -
Checks if the provided string characters
input
are alphabetic letter(s) (A-Z, a-z). -
isAlphaNumeric(
String input) → bool -
Checks if the provided character
input
is alphanumeric (A-Z, a-z, 0-9). -
isArmstrongNumber(
int n) → bool - Checks if a number is an Armstrong number.
-
isDigit(
String input) → bool -
Checks if the provided string characters
input
are a digit(s) (0-9). -
isDivisible(
num n, num divisor) → bool -
Checks if a number
n
is divisible by a another numberdivisor
. -
isEven(
int n) → bool - Checks if a number is even.
-
isFibonacci(
int n) → bool - Checks if a number is in the Fibonacci sequence.
-
isOdd(
int n) → bool - Checks if a number is odd.
-
isPalindrome(
int n) → bool -
Checks if a number
n
is a palindrome. -
isPandigital(
int n) → bool - Checks if a number is pandigital.
-
isPerfectCube(
int n) → bool - Checks if a number is a perfect cube.
-
isPerfectNumber(
int n) → bool - Checks if a number is a perfect number. A perfect number is a positive integer that is equal to the sum of its positive divisors, excluding the number itself.
-
isPerfectSquare(
int n) → bool - Checks if a number is a perfect square.
-
isPrime(
dynamic number, [int certainty = 12]) → bool - Checks if a number is prime using trial division for small numbers and Rabin-Miller for large numbers.
-
lcm(
List< num> numbers) → num - Returns the least common multiple of two numbers.
-
lerp(
num a, num b, num t) → num - Linear interpolation between a and b by t.
-
log(
dynamic x, [dynamic b]) → dynamic -
Returns the logarithm (base
b
) ofx
. -
log10(
dynamic x) → dynamic - Returns the base-10 logarithm of a number.
-
logBase(
dynamic base, dynamic x) → dynamic - Returns the logarithm of a number to a given base. The logarithm to base b of x is equal to the value y such that b to the power of y is equal to x.
-
main(
) → void -
max<
T extends num> (T a, T b) → T - Returns the maximum of two or more numbers.
-
mean(
List< num> list) → num - Returns the mean (average) of a list of numbers.
-
median(
List< num> list) → num - Returns the median of a list of numbers.
-
min<
T extends num> (T a, T b) → T - Returns the minimum of two or more numbers.
-
minutes2Degrees(
num minutes) → double - Converts minutes to degrees.
-
mod(
num a, num b) → num -
Returns the remainder of the division of
a
byb
. -
mode(
List< num> list) → List<num> - Returns the mode (most common element(s)) of a list of numbers.
-
modF(
double x) → ({double fraction, int integer}) -
Splits the passed
x
into its integer and fractional parts. -
modInv(
num a, num m) → dynamic - Returns the modular inverse of 'a' mod 'm' if it exists.
-
nChooseRModPrime(
int N, int R, int P) → num - Computes the value of C(N, R) % P using Fermat's Little Theorem.
-
nthHarmonicNumber(
int n) → double -
Returns the nth harmonic number
n
. -
nthHexagonalNumber(
int n) → int - Returns the nth hexagonal number.
-
nthPentagonalNumber(
int n) → int - Returns the nth pentagonal number.
-
nthPrime(
int n) → int - Returns the nth prime number. The nth prime number is the number that holds the nth position in the list of prime numbers.
-
nthRoot(
dynamic x, double nth) → dynamic - Returns the nth root of a number.
-
nthTetrahedralNumber(
int n) → int - Returns the nth tetrahedral number.
-
nthTriangleNumber(
int n) → int - Returns the nth triangle number.
-
numberToNum(
Number number) → num - Converts a Number to the equivalent num.
-
numIntegrate(
Function f, double a, double b, [double tol = 1e-9, int maxDepth = 45]) → double - Approximates the definite integral of a function using adaptive Simpson's method.
-
numToNumber(
num value) → Number -
Converts a num
value
to associated Number object (Integer forint
s anddouble
s that have an integer value, Double for otherdouble
s). -
objToNumber(
Object object) → Number -
Converts an
object
to a Number. Theobject
must be either a num or Number, otherwise an Exception is thrown. -
parallelogram(
) → void -
percentage2Degrees(
num percent) → double -
Converts
percentage
todegrees
. -
percentage2radians(
num percent) → double -
Converts
percentage
toradians
. -
permutations(
dynamic n, int r, {Function? func, bool simplify = true, Random? random, int? seed}) → dynamic -
Generates all permutations of elements from
n
takenr
at a time. -
pol(
num x, num y, {bool isDegrees = false}) → ({double r, double theta}) - Converts rectangular coordinates (x, y) to polar coordinates (r, theta).
-
pow(
dynamic x, dynamic exponent) → dynamic - Raises a number to the power of another number.
-
primeFactors(
int n) → List< int> -
Returns the prime factors of the given integer
n
. -
printLine(
[String s = '']) → void -
quartiles(
List< num> list) → List<num> - Returns the 1st, 2nd, and 3rd quartiles of a list of numbers.
-
radians2Percentage(
num radians) → double -
Converts
radians
topercentage
. -
radiansToGrads(
double radians) → double -
Converts
radians
to grads. -
radToDeg(
num rad) → double - Convert radians to degrees.
-
rec(
num r, num theta, {bool isDegrees = false}) → ({double x, double y}) - Converts polar coordinates (r, theta) to rectangular coordinates (x, y).
-
rect(
double x) → double - Rectangle function.
-
rectangle(
) → void -
regression(
List< num> x, List<num> y) → List<num> - Returns slope and intercept of two datasets
-
round(
num x, [int decimalPlaces = 0]) → num -
Rounds the number
x
to the specified number ofdecimalPlaces
. -
sawtooth(
num x) → double - Sawtooth wave function
-
sec(
dynamic x) → dynamic - Returns the secant of a number in radians.
-
sech(
dynamic x) → dynamic - Returns the hyperbolic secant of a number.
-
seconds2Degrees(
num seconds) → double - Converts seconds to degrees.
-
secondsInUtcDay(
double utc) → double -
Calculates and returns the number of seconds (including any
leap seconds) that are in the UTC day containing the specified
second,
utc
. -
siBaseQuantity(
Quantity q) → bool -
Returns whether or not
q
is one of the seven SI base quantities. -
siDerivedQuantity(
Quantity q) → bool -
Returns whether or not
q
is a derived quantity (as opposed to one of the seven base SI quantities). -
sieve(
int n) → List< num> - Generates all primes up to n.
-
sign(
num x) → int - Returns the sign of a number.
-
simpson(
Function f, double a, double b, [double step = 0.0001]) → double - Approximates the definite integral of a function using Simpson's Rule.
-
sin(
dynamic x) → dynamic - Returns the sine of a number in radians.
-
sinc(
double x) → double - Sinc function also called the "sampling function"
-
sinh(
dynamic x) → dynamic - Returns the hyperbolic sine of a number.
-
sqrt(
dynamic x) → dynamic - Returns the square root of a number.
-
square(
) → void -
squareWave(
double x) → int - Square wave function
-
standardDeviation(
List< num> list) → double - Returns the standard deviation of a list of numbers.
-
stdDev(
List< num> list) → double - Returns the standard deviation of a list of numbers.
-
stdErrEst(
List< num> x, List<num> y) → double - Standard error of estimate
-
stdErrMean(
List< num> list) → double - Returns the standard error of the sample mean
-
step(
double x) → double - Heaviside step function.
-
sumTo(
int n) → int -
Returns the sum of all numbers up to
n
. -
tan(
dynamic x) → dynamic - Returns the tangent of a number in radians.
-
tanh(
dynamic x) → dynamic - Returns the hyperbolic tangent of a number.
-
toDegrees(
num rad) → double -
Converts
radians
todegrees
. -
toMutable(
Quantity q) → MutableQuantity -
Create a MutableQuantity with the same value, dimensions and uncertainty as
q
. -
toRadians(
num deg) → double -
Converts
degrees
toradians
. -
trapezoid(
) → void -
triangle(
) → void -
triangleWave(
double x) → double - Triangle wave function
-
trunc(
double x) → double - Returns the integer part of a number by removing any fractional digits.
-
tValue(
List< num> list) → double - Returns the t-Value of the list Example:
-
uncertaintyRangeForQuantity(
Quantity q, {double k = 1.0}) → QuantityRange< Quantity> -
Creates a QuantityRange that represents the standard uncertainty of
q
. -
unicodeExponent(
num exp) → String - Returns the unicode symbols that represent an exponent.
-
variance(
List< num> list) → double - Returns the variance of a list of numbers.
-
vers(
num x) → double - Versine function
-
yr4(
int year) → int -
Returns a four digit year from
year
which may be only 2 digits, assuming that anything 70 or more means 19xx and under 70 means 20xx.
Typedefs
- Base20Converter = String Function(int value)
- FromMksOverride = Number Function(dynamic mks)
- ToMksOverride = Number Function(dynamic val)
Exceptions / Errors
- DimensionsException
- This Exception is thrown when an attempt is made to perform an operation on a Quantity having unexpected or illegal dimensions.
- ImmutableQuantityException
- This Exception is thrown when an attempt is made to modify an immutable Quantity object (for example through its setMKS method).
- InvalidRomanNumeralException
- NumberException
- The base class for all exceptions thrown in relation to numbers.
- QuantityException
- The base class for all exceptions thrown in relation to quantities.