Uses of Class
com.opengamma.strata.collect.array.DoubleMatrix
-
-
Uses of DoubleMatrix in com.opengamma.strata.basics.currency
Methods in com.opengamma.strata.basics.currency that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
FxMatrix. getRates()
Gets the matrix with all the exchange rates.Methods in com.opengamma.strata.basics.currency that return types with arguments of type DoubleMatrix Modifier and Type Method Description org.joda.beans.MetaProperty<DoubleMatrix>
FxMatrix.Meta. rates()
The meta-property for therates
property. -
Uses of DoubleMatrix in com.opengamma.strata.collect.array
Fields in com.opengamma.strata.collect.array declared as DoubleMatrix Modifier and Type Field Description static DoubleMatrix
DoubleMatrix. EMPTY
An empty array.Methods in com.opengamma.strata.collect.array that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
DoubleMatrix. combine(DoubleMatrix other, DoubleBinaryOperator operator)
Returns an instance where each element is formed by some combination of the matching values in this matrix and the other matrix.static DoubleMatrix
DoubleMatrix. copyOf(double[][] array)
Obtains an instance from adouble[][]
.static DoubleMatrix
DoubleMatrix. diagonal(DoubleArray array)
Obtains a diagonal matrix from the specified array.static DoubleMatrix
DoubleMatrix. filled(int rows, int columns)
Obtains an instance with all entries equal to the zero.static DoubleMatrix
DoubleMatrix. filled(int rows, int columns, double value)
Obtains an instance with all entries equal to the same value.static DoubleMatrix
DoubleMatrix. identity(int size)
Obtains an identity matrix.DoubleMatrix
DoubleMatrix. map(DoubleUnaryOperator operator)
Returns an instance with an operation applied to each value in the matrix.DoubleMatrix
DoubleMatrix. mapWithIndex(IntIntDoubleToDoubleFunction function)
Returns an instance with an operation applied to each indexed value in the matrix.DoubleMatrix
DoubleMatrix. minus(DoubleMatrix other)
Returns an instance where each element is equal to the difference between the matching values in this matrix and the other matrix.DoubleMatrix
DoubleMatrix. multipliedBy(double factor)
Returns an instance with each value multiplied by the specified factor.static DoubleMatrix
DoubleMatrix. of()
Obtains an empty instance.static DoubleMatrix
DoubleMatrix. of(int rows, int columns, double... values)
Obtains an immutable array with the specified size and values.static DoubleMatrix
DoubleMatrix. of(int rows, int columns, IntIntToDoubleFunction valueFunction)
Obtains an instance with entries filled using a function.static DoubleMatrix
DoubleMatrix. ofArrayObjects(int rows, int columns, IntFunction<DoubleArray> valuesFunction)
Obtains an instance with entries filled using a function.static DoubleMatrix
DoubleMatrix. ofArrays(int rows, int columns, IntFunction<double[]> valuesFunction)
Obtains an instance with entries filled using a function.static DoubleMatrix
DoubleMatrix. ofUnsafe(double[][] array)
Obtains an instance by wrapping adouble[][]
.DoubleMatrix
DoubleMatrix. plus(DoubleMatrix other)
Returns an instance where each element is the sum of the matching values in this array and the other matrix.DoubleMatrix
DoubleMatrix. transpose()
Transposes the matrix.DoubleMatrix
DoubleMatrix. with(int row, int column, double newValue)
Returns an instance with the value at the specified index changed.Methods in com.opengamma.strata.collect.array that return types with arguments of type DoubleMatrix Modifier and Type Method Description Class<? extends DoubleMatrix>
DoubleMatrix.Meta. beanType()
org.joda.beans.BeanBuilder<? extends DoubleMatrix>
DoubleMatrix.Meta. builder()
Methods in com.opengamma.strata.collect.array with parameters of type DoubleMatrix Modifier and Type Method Description DoubleMatrix
DoubleMatrix. combine(DoubleMatrix other, DoubleBinaryOperator operator)
Returns an instance where each element is formed by some combination of the matching values in this matrix and the other matrix.DoubleMatrix
DoubleMatrix. minus(DoubleMatrix other)
Returns an instance where each element is equal to the difference between the matching values in this matrix and the other matrix.DoubleMatrix
DoubleMatrix. plus(DoubleMatrix other)
Returns an instance where each element is the sum of the matching values in this array and the other matrix. -
Uses of DoubleMatrix in com.opengamma.strata.market.curve
Methods in com.opengamma.strata.market.curve that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
JacobianCalibrationMatrix. getJacobianMatrix()
Gets the inverse Jacobian matrix produced during curve calibration.Methods in com.opengamma.strata.market.curve that return types with arguments of type DoubleMatrix Modifier and Type Method Description org.joda.beans.MetaProperty<DoubleMatrix>
JacobianCalibrationMatrix.Meta. jacobianMatrix()
The meta-property for thejacobianMatrix
property.Methods in com.opengamma.strata.market.curve with parameters of type DoubleMatrix Modifier and Type Method Description static JacobianCalibrationMatrix
JacobianCalibrationMatrix. of(List<CurveParameterSize> order, DoubleMatrix jacobianMatrix)
Obtains an instance from the curve order and Jacobian matrix. -
Uses of DoubleMatrix in com.opengamma.strata.market.param
Methods in com.opengamma.strata.market.param that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
CrossGammaParameterSensitivity. getSensitivity()
Gets the parameter sensitivity values.DoubleMatrix
PointShifts. getShifts()
Gets the shift to apply to the rates.Methods in com.opengamma.strata.market.param that return types with arguments of type DoubleMatrix Modifier and Type Method Description org.joda.beans.MetaProperty<DoubleMatrix>
CrossGammaParameterSensitivity.Meta. sensitivity()
The meta-property for thesensitivity
property.org.joda.beans.MetaProperty<DoubleMatrix>
PointShifts.Meta. shifts()
The meta-property for theshifts
property.Methods in com.opengamma.strata.market.param with parameters of type DoubleMatrix Modifier and Type Method Description static CrossGammaParameterSensitivity
CrossGammaParameterSensitivity. of(MarketDataName<?> marketDataName, List<? extends ParameterMetadata> parameterMetadata, Currency currency, DoubleMatrix sensitivity)
Obtains an instance from the market data name, metadata, currency and sensitivity.static CrossGammaParameterSensitivity
CrossGammaParameterSensitivity. of(MarketDataName<?> marketDataName, List<? extends ParameterMetadata> parameterMetadata, MarketDataName<?> marketDataNameOther, List<? extends ParameterMetadata> parameterMetadataOther, Currency currency, DoubleMatrix sensitivity)
Obtains an instance from the market data names, metadatas, currency and sensitivity.static CrossGammaParameterSensitivity
CrossGammaParameterSensitivity. of(MarketDataName<?> marketDataName, List<? extends ParameterMetadata> parameterMetadata, List<Pair<MarketDataName<?>,List<? extends ParameterMetadata>>> order, Currency currency, DoubleMatrix sensitivity)
Obtains an instance from the market data names, metadatas, currency and sensitivity.CrossGammaParameterSensitivity
CrossGammaParameterSensitivity. withSensitivity(DoubleMatrix sensitivity)
Returns an instance with new parameter sensitivity values. -
Uses of DoubleMatrix in com.opengamma.strata.math.impl.differentiation
Methods in com.opengamma.strata.math.impl.differentiation that return types with arguments of type DoubleMatrix Modifier and Type Method Description Function<DoubleArray,DoubleMatrix>
VectorFieldFirstOrderDifferentiator. differentiate(Function<DoubleArray,DoubleArray> function)
Function<DoubleArray,DoubleMatrix>
VectorFieldFirstOrderDifferentiator. differentiate(Function<DoubleArray,DoubleArray> function, Function<DoubleArray,Boolean> domain)
Function<DoubleArray,DoubleMatrix>
VectorFieldSecondOrderDifferentiator. differentiateNoCross(Function<DoubleArray,DoubleArray> function)
Computes the second derivative of a vector field, without cross derivatives.Method parameters in com.opengamma.strata.math.impl.differentiation with type arguments of type DoubleMatrix Modifier and Type Method Description Function<DoubleArray,DoubleMatrix[]>
MatrixFieldFirstOrderDifferentiator. differentiate(Function<DoubleArray,DoubleMatrix> function)
Function<DoubleArray,DoubleMatrix[]>
MatrixFieldFirstOrderDifferentiator. differentiate(Function<DoubleArray,DoubleMatrix> function, Function<DoubleArray,Boolean> domain)
-
Uses of DoubleMatrix in com.opengamma.strata.math.impl.function
Methods in com.opengamma.strata.math.impl.function that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
ConcatenatedVectorFunction. calculateJacobian(DoubleArray x)
DoubleMatrix
ParameterizedCurveVectorFunction. calculateJacobian(DoubleArray x)
abstract DoubleMatrix
VectorFunction. calculateJacobian(DoubleArray x)
Calculate the Jacobian at a point $\mathbf{x}$.DoubleMatrix
PiecewisePolynomialFunction1D. differentiate(PiecewisePolynomialResult pp, double[] xKeys)
Finds the first derivatives.DoubleMatrix
PiecewisePolynomialFunction2D. differentiateCross(PiecewisePolynomialResult2D pp, double[] x0Keys, double[] x1Keys)
Finds the cross derivative.DoubleMatrix
PiecewisePolynomialFunction1D. differentiateTwice(PiecewisePolynomialResult pp, double[] xKeys)
Finds the second derivatives.DoubleMatrix
PiecewisePolynomialFunction2D. differentiateTwiceX0(PiecewisePolynomialResult2D pp, double[] x0Keys, double[] x1Keys)
Finds the second derivative.DoubleMatrix
PiecewisePolynomialFunction2D. differentiateTwiceX1(PiecewisePolynomialResult2D pp, double[] x0Keys, double[] x1Keys)
Finds the second derivative.DoubleMatrix
PiecewisePolynomialFunction2D. differentiateX0(PiecewisePolynomialResult2D pp, double[] x0Keys, double[] x1Keys)
Finds the first derivative.DoubleMatrix
PiecewisePolynomialFunction2D. differentiateX1(PiecewisePolynomialResult2D pp, double[] x0Keys, double[] x1Keys)
Finds the first derivative.DoubleMatrix
PiecewisePolynomialFunction1D. evaluate(PiecewisePolynomialResult pp, double[] xKeys)
Evaluates the function.DoubleMatrix[]
PiecewisePolynomialFunction1D. evaluate(PiecewisePolynomialResult pp, double[][] xKeys)
Evaluates the function.DoubleMatrix
PiecewisePolynomialFunction2D. evaluate(PiecewisePolynomialResult2D pp, double[] x0Keys, double[] x1Keys)
Evaluates the function. -
Uses of DoubleMatrix in com.opengamma.strata.math.impl.interpolation
Methods in com.opengamma.strata.math.impl.interpolation that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
PiecewisePolynomialResultsWithSensitivity. getCoefficientSensitivity(int interval)
Access _coeffSense for the i-th interval.DoubleMatrix[]
PiecewisePolynomialResultsWithSensitivity. getCoefficientSensitivityAll()
Access _coeffSense.DoubleMatrix
PiecewisePolynomialResult. getCoefMatrix()
Access _coefMatrix.DoubleMatrix[][]
PiecewisePolynomialResult2D. getCoefs()
Access _coefMatrix.static DoubleMatrix
PenaltyMatrixGenerator. getDerivativeMatrix(double[] x, int k, boolean includeEnds)
Get the kth order finite difference derivative matrix, D_k(x), for a non-uniform set of points.static DoubleMatrix
PenaltyMatrixGenerator. getDifferenceMatrix(int m, int k)
get the k^th order difference matrix, D, which acts on a vector, x, of length m to produce the k^th order difference vector.static DoubleMatrix
PenaltyMatrixGenerator. getMatrixForFlattened(int[] numElements, DoubleMatrix m, int index)
Assume a tensor has been flattened to a vector as {A_{0,0}, A_{0,1},...._A_{0,m}, A_{1,0}, A_{1,1},...._A_{1,m},...,A_{n,0}, A_{n,1},...._A_{n,m}} (seePenaltyMatrixGenerator.flattenMatrix(com.opengamma.strata.collect.array.DoubleMatrix)
) that is, the last index changes most rapidly.static DoubleMatrix
PenaltyMatrixGenerator. getPenaltyMatrix(double[][] x, int[] k, double[] lambda)
Get a penalty for a non-uniform grid whose values have been flattened to a vector.static DoubleMatrix
PenaltyMatrixGenerator. getPenaltyMatrix(double[][] x, int k, int index)
Get a kth order penalty matrix for a non-uniform grid whose values have been flattened to a vector.static DoubleMatrix
PenaltyMatrixGenerator. getPenaltyMatrix(double[] x, int k)
get a k^th order penalty matrix,P, for a non-uniform grid, x.static DoubleMatrix
PenaltyMatrixGenerator. getPenaltyMatrix(int[] numElements, int[] k, double[] lambda)
Assume a tensor has been flattened to a vector as {A_{0,0}, A_{0,1},...._A_{0,m}, A_{1,0}, A_{1,1},...._A_{1,m},...,A_{n,0}, A_{n,1},...._A_{n,m}} (seePenaltyMatrixGenerator.flattenMatrix(com.opengamma.strata.collect.array.DoubleMatrix)
) that is, the last index changes most rapidly.static DoubleMatrix
PenaltyMatrixGenerator. getPenaltyMatrix(int[] numElements, int k, int index)
Assume a tensor has been flattened to a vector as {A_{0,0}, A_{0,1},...._A_{0,m}, A_{1,0}, A_{1,1},...._A_{1,m},...,A_{n,0}, A_{n,1},...._A_{n,m}} (seePenaltyMatrixGenerator.flattenMatrix(com.opengamma.strata.collect.array.DoubleMatrix)
) that is, the last index changes most rapidly.static DoubleMatrix
PenaltyMatrixGenerator. getPenaltyMatrix(int m, int k)
get the k^th order penalty matrix, P.DoubleMatrix
PolynomialsLeastSquaresFitterResult. getRMat()
DoubleMatrix
PiecewisePolynomialInterpolator. interpolate(double[] xValues, double[][] yValuesMatrix, double[] x)
Interpolate.DoubleMatrix[]
PiecewisePolynomialInterpolator. interpolate(double[] xValues, double[][] yValuesMatrix, double[][] xMatrix)
Interpolate.DoubleMatrix
PiecewisePolynomialInterpolator. interpolate(double[] xValues, double[] yValues, double[][] xMatrix)
Interpolate.DoubleMatrix
PiecewisePolynomialInterpolator2D. interpolate(double[] x0Values, double[] x1Values, double[][] yValues, double[] x0Keys, double[] x1Keys)
DoubleMatrix
CubicSplineClampedSolver. solve(double[] xValues, double[] yValues)
DoubleMatrix
CubicSplineNakSolver. solve(double[] xValues, double[] yValues)
DoubleMatrix
CubicSplineNaturalSolver. solve(double[] xValues, double[] yValues)
DoubleMatrix
LogCubicSplineNaturalSolver. solve(double[] xValues, double[] yValues)
DoubleMatrix[]
CubicSplineClampedSolver. solveMultiDim(double[] xValues, DoubleMatrix yValuesMatrix)
DoubleMatrix[]
CubicSplineNakSolver. solveMultiDim(double[] xValues, DoubleMatrix yValuesMatrix)
DoubleMatrix[]
CubicSplineNaturalSolver. solveMultiDim(double[] xValues, DoubleMatrix yValuesMatrix)
DoubleMatrix[]
LogCubicSplineNaturalSolver. solveMultiDim(double[] xValues, DoubleMatrix yValuesMatrix)
DoubleMatrix[]
CubicSplineClampedSolver. solveWithSensitivity(double[] xValues, double[] yValues)
DoubleMatrix[]
CubicSplineNakSolver. solveWithSensitivity(double[] xValues, double[] yValues)
DoubleMatrix[]
CubicSplineNaturalSolver. solveWithSensitivity(double[] xValues, double[] yValues)
DoubleMatrix[]
HermiteCoefficientsProvider. solveWithSensitivity(double[] values, double[] intervals, double[] slopes, double[][] slopeSensitivity, DoubleArray[] firstWithSensitivity)
DoubleMatrix[]
HermiteCoefficientsProvider. solveWithSensitivity(double[] values, double[] intervals, double[] slopes, double[][] slopeSensitivity, DoubleArray[] firstWithSensitivity, DoubleArray[] secondWithSensitivity)
DoubleMatrix[]
LogCubicSplineNaturalSolver. solveWithSensitivity(double[] xValues, double[] yValues)
Methods in com.opengamma.strata.math.impl.interpolation with parameters of type DoubleMatrix Modifier and Type Method Description static DoubleArray
PenaltyMatrixGenerator. flattenMatrix(DoubleMatrix aMatrix)
for a matrix {{A_{0,0}, A_{0,1},...._A_{0,m},{A_{1,0}, A_{1,1},...._A_{1,m},...,{A_{n,0}, A_{n,1},...._A_{n,m}} flattened to a vector {A_{0,0}, A_{0,1},...._A_{0,m}, A_{1,0}, A_{1,1},...._A_{1,m},...,A_{n,0}, A_{n,1},...._A_{n,m}}.static DoubleMatrix
PenaltyMatrixGenerator. getMatrixForFlattened(int[] numElements, DoubleMatrix m, int index)
Assume a tensor has been flattened to a vector as {A_{0,0}, A_{0,1},...._A_{0,m}, A_{1,0}, A_{1,1},...._A_{1,m},...,A_{n,0}, A_{n,1},...._A_{n,m}} (seePenaltyMatrixGenerator.flattenMatrix(com.opengamma.strata.collect.array.DoubleMatrix)
) that is, the last index changes most rapidly.protected double
PiecewisePolynomialInterpolator2D. getValue(DoubleMatrix coefMat, double x0, double x1, double leftKnot0, double leftKnot1)
DoubleMatrix[]
CubicSplineClampedSolver. solveMultiDim(double[] xValues, DoubleMatrix yValuesMatrix)
DoubleMatrix[]
CubicSplineNakSolver. solveMultiDim(double[] xValues, DoubleMatrix yValuesMatrix)
DoubleMatrix[]
CubicSplineNaturalSolver. solveMultiDim(double[] xValues, DoubleMatrix yValuesMatrix)
DoubleMatrix[]
LogCubicSplineNaturalSolver. solveMultiDim(double[] xValues, DoubleMatrix yValuesMatrix)
Constructors in com.opengamma.strata.math.impl.interpolation with parameters of type DoubleMatrix Constructor Description PiecewisePolynomialResult(DoubleArray knots, DoubleMatrix coefMatrix, int order, int dim)
Creates an instance.PiecewisePolynomialResult2D(DoubleArray knots0, DoubleArray knots1, DoubleMatrix[][] coefMatrix, int[] order)
Creates an instance.PiecewisePolynomialResultsWithSensitivity(DoubleArray knots, DoubleMatrix coefMatrix, int order, int dim, DoubleMatrix[] coeffSense)
PolynomialsLeastSquaresFitterResult(double[] coefficients, DoubleMatrix rMatrix, int dof, double diffNorm)
PolynomialsLeastSquaresFitterResult(double[] coefficients, DoubleMatrix rMatrix, int dof, double diffNorm, double[] meanAndStd)
-
Uses of DoubleMatrix in com.opengamma.strata.math.impl.linearalgebra
Methods in com.opengamma.strata.math.impl.linearalgebra that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
InverseTridiagonalMatrixCalculator. apply(TridiagonalMatrix x)
DoubleMatrix
CholeskyDecompositionCommonsResult. getL()
DoubleMatrix
CholeskyDecompositionOpenGammaResult. getL()
DoubleMatrix
CholeskyDecompositionResult. getL()
Returns the $\mathbf{L}$ matrix of the decomposition.DoubleMatrix
LUDecompositionCommonsResult. getL()
Returns the $\mathbf{L}$ matrix of the decomposition.DoubleMatrix
LUDecompositionResult. getL()
Returns the $\mathbf{L}$ matrix of the decomposition.DoubleMatrix
CholeskyDecompositionCommonsResult. getLT()
DoubleMatrix
CholeskyDecompositionOpenGammaResult. getLT()
DoubleMatrix
CholeskyDecompositionResult. getLT()
Returns the transpose of the matrix $\mathbf{L}$ of the decomposition.DoubleMatrix
LUDecompositionCommonsResult. getP()
Returns the rows permutation matrix, $\mathbf{P}$.DoubleMatrix
LUDecompositionResult. getP()
Returns the rows permutation matrix, $\mathbf{P}$.DoubleMatrix
QRDecompositionCommonsResult. getQ()
Returns the matrix $\mathbf{Q}$ of the decomposition.DoubleMatrix
QRDecompositionResult. getQ()
Returns the matrix $\mathbf{Q}$ of the decomposition.DoubleMatrix
QRDecompositionCommonsResult. getQT()
Returns the transpose of the matrix $\mathbf{Q}$ of the decomposition.DoubleMatrix
QRDecompositionResult. getQT()
Returns the transpose of the matrix $\mathbf{Q}$ of the decomposition.DoubleMatrix
QRDecompositionCommonsResult. getR()
Returns the matrix $\mathbf{R}$ of the decomposition.DoubleMatrix
QRDecompositionResult. getR()
Returns the matrix $\mathbf{R}$ of the decomposition.DoubleMatrix
SVDecompositionCommonsResult. getS()
Returns the diagonal matrix $\mathbf{\Sigma}$ of the decomposition.DoubleMatrix
SVDecompositionResult. getS()
Returns the diagonal matrix $\mathbf{\Sigma}$ of the decomposition.DoubleMatrix
LUDecompositionCommonsResult. getU()
Returns the $\mathbf{U}$ matrix of the decomposition.DoubleMatrix
LUDecompositionResult. getU()
Returns the $\mathbf{U}$ matrix of the decomposition.DoubleMatrix
SVDecompositionCommonsResult. getU()
Returns the matrix $\mathbf{U}$ of the decomposition.DoubleMatrix
SVDecompositionResult. getU()
Returns the matrix $\mathbf{U}$ of the decomposition.DoubleMatrix
SVDecompositionCommonsResult. getUT()
Returns the transpose of the matrix $\mathbf{U}$ of the decomposition.DoubleMatrix
SVDecompositionResult. getUT()
Returns the transpose of the matrix $\mathbf{U}$ of the decomposition.DoubleMatrix
SVDecompositionCommonsResult. getV()
Returns the matrix $\mathbf{V}$ of the decomposition.DoubleMatrix
SVDecompositionResult. getV()
Returns the matrix $\mathbf{V}$ of the decomposition.DoubleMatrix
SVDecompositionCommonsResult. getVT()
Returns the transpose of the matrix $\mathbf{V}$ of the decomposition.DoubleMatrix
SVDecompositionResult. getVT()
Returns the transpose of the matrix $\mathbf{V}$ of the decomposition.DoubleMatrix
CholeskyDecompositionCommonsResult. solve(DoubleMatrix b)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix.DoubleMatrix
CholeskyDecompositionOpenGammaResult. solve(DoubleMatrix b)
DoubleMatrix
LUDecompositionCommonsResult. solve(DoubleMatrix b)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix.DoubleMatrix
QRDecompositionCommonsResult. solve(DoubleMatrix b)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix.DoubleMatrix
SVDecompositionCommonsResult. solve(DoubleMatrix b)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix.DoubleMatrix
TridiagonalMatrix. toDoubleMatrix()
Methods in com.opengamma.strata.math.impl.linearalgebra with parameters of type DoubleMatrix Modifier and Type Method Description CholeskyDecompositionResult
CholeskyDecompositionCommons. apply(DoubleMatrix x)
Applies this function to the given argument.CholeskyDecompositionResult
CholeskyDecompositionOpenGamma. apply(DoubleMatrix x)
Applies this function to the given argument.LUDecompositionResult
LUDecompositionCommons. apply(DoubleMatrix x)
QRDecompositionResult
QRDecompositionCommons. apply(DoubleMatrix x)
SVDecompositionResult
SVDecompositionCommons. apply(DoubleMatrix x)
CholeskyDecompositionResult
CholeskyDecompositionOpenGamma. evaluate(DoubleMatrix matrix, double symmetryThreshold, double positivityThreshold)
Perform the decomposition with a given symmetry and positivity threshold.static void
MatrixValidate. notNaNOrInfinite(DoubleMatrix x)
DoubleMatrix
CholeskyDecompositionCommonsResult. solve(DoubleMatrix b)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix.DoubleMatrix
CholeskyDecompositionOpenGammaResult. solve(DoubleMatrix b)
DoubleMatrix
LUDecompositionCommonsResult. solve(DoubleMatrix b)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix.DoubleMatrix
QRDecompositionCommonsResult. solve(DoubleMatrix b)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix.DoubleMatrix
SVDecompositionCommonsResult. solve(DoubleMatrix b)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix. -
Uses of DoubleMatrix in com.opengamma.strata.math.impl.matrix
Methods in com.opengamma.strata.math.impl.matrix that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
CommonsMatrixAlgebra. getInverse(Matrix m)
abstract DoubleMatrix
MatrixAlgebra. getInverse(Matrix m)
Returns the inverse (or pseudo-inverse) of the matrix.DoubleMatrix
OGMatrixAlgebra. getInverse(Matrix m)
Returns the inverse (or pseudo-inverse) of the matrix.DoubleMatrix
CommonsMatrixAlgebra. getOuterProduct(Matrix m1, Matrix m2)
abstract DoubleMatrix
MatrixAlgebra. getOuterProduct(Matrix m1, Matrix m2)
Returns the outer product.DoubleMatrix
OGMatrixAlgebra. getOuterProduct(Matrix m1, Matrix m2)
Returns the outer product.DoubleMatrix
CommonsMatrixAlgebra. getPower(Matrix m, double p)
Returns a real matrix raised to some real power Currently this method is limited to symmetric matrices only as Commons Math does not support the diagonalization of asymmetric matrices.DoubleMatrix
CommonsMatrixAlgebra. getPower(Matrix m, int p)
abstract DoubleMatrix
MatrixAlgebra. getPower(Matrix m, double p)
Returns a matrix raised to a power, $\mathbf{A}^3 = \mathbf{A}\mathbf{A}\mathbf{A}$.abstract DoubleMatrix
MatrixAlgebra. getPower(Matrix m, int p)
Returns a matrix raised to an integer power, e.g.DoubleMatrix
OGMatrixAlgebra. getPower(Matrix m, double p)
Returns a matrix raised to a power, $\mathbf{A}^3 = \mathbf{A}\mathbf{A}\mathbf{A}$.DoubleMatrix
OGMatrixAlgebra. getPower(Matrix m, int p)
Returns a matrix raised to an integer power, e.g.DoubleMatrix
CommonsMatrixAlgebra. getTranspose(Matrix m)
abstract DoubleMatrix
MatrixAlgebra. getTranspose(Matrix m)
Returns the transpose of a matrix.DoubleMatrix
OGMatrixAlgebra. getTranspose(Matrix m)
Returns the transpose of a matrix.DoubleMatrix
MatrixAlgebra. matrixTransposeMultiplyMatrix(DoubleMatrix a)
Compute $A^T A$, where A is a matrix.Methods in com.opengamma.strata.math.impl.matrix with parameters of type DoubleMatrix Modifier and Type Method Description DoubleMatrix
MatrixAlgebra. matrixTransposeMultiplyMatrix(DoubleMatrix a)
Compute $A^T A$, where A is a matrix. -
Uses of DoubleMatrix in com.opengamma.strata.math.impl.minimization
Methods in com.opengamma.strata.math.impl.minimization that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
NonLinearParameterTransforms. inverseJacobian(DoubleArray fittingParameters)
Calculates the inverse Jacobian - the rate of change of the model parameters WRT the fitting parameters.DoubleMatrix
UncoupledParameterTransforms. inverseJacobian(DoubleArray fittingParameters)
Calculates the Jacobian of the transform from fitting parameters to function parameters - the i,j element will be the partial derivative of i^th function parameter with respect.DoubleMatrix
NonLinearParameterTransforms. jacobian(DoubleArray modelParameters)
Calculates the Jacobian - the rate of change of the fitting parameters WRT the model parameters.DoubleMatrix
SumToOne. jacobian(DoubleArray fitParms)
The N by N-1 Jacobian matrix between the N "model" parameters (that sum to one) and the N-1 "fit" parameters.DoubleMatrix
UncoupledParameterTransforms. jacobian(DoubleArray functionParameters)
Calculates the Jacobian of the transform from function parameters to fitting parameters - the i,j element will be the partial derivative of i^th fitting parameter with respect.Methods in com.opengamma.strata.math.impl.minimization that return types with arguments of type DoubleMatrix Modifier and Type Method Description Function<DoubleArray,DoubleMatrix>
NonLinearTransformFunction. getFittingJacobian()
-
Uses of DoubleMatrix in com.opengamma.strata.math.impl.rootfinding.newton
-
Uses of DoubleMatrix in com.opengamma.strata.math.impl.statistics.leastsquare
Methods in com.opengamma.strata.math.impl.statistics.leastsquare that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
NonLinearLeastSquare. calInverseJacobian(DoubleArray sigma, Function<DoubleArray,DoubleArray> func, Function<DoubleArray,DoubleMatrix> jac, DoubleArray originalSolution)
the inverse-Jacobian where the i-j entry is the sensitivity of the ith (fitted) parameter (a_i) to the jth data point (y_j).DoubleMatrix
LeastSquareResults. getCovariance()
Gets the estimated covariance matrix of the standard errors in the fitting parameters.DoubleMatrix
LeastSquareResults. getFittingParameterSensitivityToData()
This a matrix where the i,jth element is the (infinitesimal) sensitivity of the ith fitting parameter to the jth data point (NOT the model point), when the fitting parameter are such that the chi-squared is minimised.DoubleMatrix
LeastSquareResultsWithTransform. getModelParameterSensitivityToData()
This a matrix where the i,j-th element is the (infinitesimal) sensitivity of the i-th model parameter to the j-th data point, when the fitting parameter are such that the chi-squared is minimised.Methods in com.opengamma.strata.math.impl.statistics.leastsquare with parameters of type DoubleMatrix Modifier and Type Method Description LeastSquareWithPenaltyResults
NonLinearLeastSquareWithPenalty. solve(DoubleArray observedValues, DoubleArray sigma, Function<DoubleArray,DoubleArray> func, DoubleArray startPos, DoubleMatrix penalty)
Use this when the model is given as a function of its parameters only (i.e.LeastSquareWithPenaltyResults
NonLinearLeastSquareWithPenalty. solve(DoubleArray observedValues, DoubleArray sigma, Function<DoubleArray,DoubleArray> func, DoubleArray startPos, DoubleMatrix penalty, Function<DoubleArray,Boolean> allowedValue)
Use this when the model is given as a function of its parameters only (i.e.LeastSquareWithPenaltyResults
NonLinearLeastSquareWithPenalty. solve(DoubleArray observedValues, DoubleArray sigma, Function<DoubleArray,DoubleArray> func, Function<DoubleArray,DoubleMatrix> jac, DoubleArray startPos, DoubleMatrix penalty)
Use this when the model is given as a function of its parameters only (i.e.LeastSquareWithPenaltyResults
NonLinearLeastSquareWithPenalty. solve(DoubleArray observedValues, DoubleArray sigma, Function<DoubleArray,DoubleArray> func, Function<DoubleArray,DoubleMatrix> jac, DoubleArray startPos, DoubleMatrix penalty, Function<DoubleArray,Boolean> allowedValue)
Use this when the model is given as a function of its parameters only (i.e.LeastSquareWithPenaltyResults
NonLinearLeastSquareWithPenalty. solve(DoubleArray observedValues, Function<DoubleArray,DoubleArray> func, DoubleArray startPos, DoubleMatrix penalty)
Use this when the model is given as a function of its parameters only (i.e.Constructors in com.opengamma.strata.math.impl.statistics.leastsquare with parameters of type DoubleMatrix Constructor Description GeneralizedLeastSquareResults(List<Function<T,Double>> basisFunctions, double chiSq, DoubleArray parameters, DoubleMatrix covariance)
Creates an instance.LeastSquareResults(double chiSq, DoubleArray parameters, DoubleMatrix covariance)
LeastSquareResults(double chiSq, DoubleArray parameters, DoubleMatrix covariance, DoubleMatrix inverseJacobian)
LeastSquareWithPenaltyResults(double chiSqr, double penalty, DoubleArray parameters, DoubleMatrix covariance)
Holder for the results of minimising $\sum_{i=1}^N (y_i - f_i(\mathbf{x}))^2 + \mathbf{x}^T\mathbf{P}\mathbf{x}$ WRT $\mathbf{x}$ (the vector of model parameters).LeastSquareWithPenaltyResults(double chiSqr, double penalty, DoubleArray parameters, DoubleMatrix covariance, DoubleMatrix inverseJacobian)
Holder for the results of minimising $\sum_{i=1}^N (y_i - f_i(\mathbf{x}))^2 + \mathbf{x}^T\mathbf{P}\mathbf{x}$ WRT $\mathbf{x}$ (the vector of model parameters). -
Uses of DoubleMatrix in com.opengamma.strata.math.impl.util
Methods in com.opengamma.strata.math.impl.util that return DoubleMatrix Modifier and Type Method Description static DoubleMatrix
CommonsMathWrapper. unwrap(org.apache.commons.math3.linear.RealMatrix x)
Unwraps a matrix.Methods in com.opengamma.strata.math.impl.util with parameters of type DoubleMatrix Modifier and Type Method Description static org.apache.commons.math3.linear.RealMatrix
CommonsMathWrapper. wrap(DoubleMatrix x)
Wraps a matrix. -
Uses of DoubleMatrix in com.opengamma.strata.math.linearalgebra
Methods in com.opengamma.strata.math.linearalgebra that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
DecompositionResult. solve(DoubleMatrix input)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix.Methods in com.opengamma.strata.math.linearalgebra with parameters of type DoubleMatrix Modifier and Type Method Description R
Decomposition. apply(DoubleMatrix input)
Applies this function to the given argument.DoubleMatrix
DecompositionResult. solve(DoubleMatrix input)
Solves $\mathbf{A}x = \mathbf{B}$ where $\mathbf{A}$ is a (decomposed) matrix and $\mathbf{B}$ is a matrix. -
Uses of DoubleMatrix in com.opengamma.strata.pricer.capfloor
Methods in com.opengamma.strata.pricer.capfloor that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
DirectIborCapletFloorletFlatVolatilityDefinition. computePenaltyMatrix(DoubleArray expiries)
Computes penalty matrix.DoubleMatrix
DirectIborCapletFloorletVolatilityDefinition. computePenaltyMatrix(DoubleArray strikes, DoubleArray expiries)
Computes penalty matrix. -
Uses of DoubleMatrix in com.opengamma.strata.pricer.fxopt
Methods in com.opengamma.strata.pricer.fxopt that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
RecombiningTrinomialTreeData. getProbabilityAtLayer(int i)
Obtains the transition probability values at thei
-th time layer.DoubleMatrix
SmileAndBucketedSensitivities. getSensitivities()
Gets the sensitivities.DoubleMatrix
VolatilityAndBucketedSensitivities. getSensitivities()
Gets the sensitivities.DoubleMatrix
RecombiningTrinomialTreeData. getStateValue()
Gets the state value.Methods in com.opengamma.strata.pricer.fxopt that return types with arguments of type DoubleMatrix Modifier and Type Method Description ImmutableList<DoubleMatrix>
RecombiningTrinomialTreeData. getTransitionProbability()
Gets the transition probability.org.joda.beans.MetaProperty<DoubleMatrix>
VolatilityAndBucketedSensitivities.Meta. sensitivities()
The meta-property for thesensitivities
property.org.joda.beans.MetaProperty<DoubleMatrix>
RecombiningTrinomialTreeData.Meta. stateValue()
The meta-property for thestateValue
property.org.joda.beans.MetaProperty<ImmutableList<DoubleMatrix>>
RecombiningTrinomialTreeData.Meta. transitionProbability()
The meta-property for thetransitionProbability
property.Methods in com.opengamma.strata.pricer.fxopt with parameters of type DoubleMatrix Modifier and Type Method Description static InterpolatedStrikeSmileDeltaTermStructure
InterpolatedStrikeSmileDeltaTermStructure. of(DoubleArray expiries, DoubleArray delta, DoubleArray atm, DoubleMatrix riskReversal, DoubleMatrix strangle, DayCount dayCount)
Obtains volatility term structure from expiry times, delta values, ATM volatilities, risk reversal figures and strangle figures.static InterpolatedStrikeSmileDeltaTermStructure
InterpolatedStrikeSmileDeltaTermStructure. of(DoubleArray expiries, DoubleArray delta, DoubleArray atm, DoubleMatrix riskReversal, DoubleMatrix strangle, DayCount dayCount, CurveInterpolator strikeInterpolator, CurveExtrapolator strikeExtrapolatorLeft, CurveExtrapolator strikeExtrapolatorRight)
Obtains volatility term structure from expiry times, delta values, ATM volatilities, risk reversal figures and strangle figures with strike interpolator and extrapolators specified.static InterpolatedStrikeSmileDeltaTermStructure
InterpolatedStrikeSmileDeltaTermStructure. of(DoubleArray expiries, DoubleArray delta, DoubleArray atm, DoubleMatrix riskReversal, DoubleMatrix strangle, DayCount dayCount, CurveInterpolator timeInterpolator, CurveExtrapolator timeExtrapolatorLeft, CurveExtrapolator timeExtrapolatorRight, CurveInterpolator strikeInterpolator, CurveExtrapolator strikeExtrapolatorLeft, CurveExtrapolator strikeExtrapolatorRight)
Obtains volatility term structure from expiry times, delta values, ATM volatilities, risk reversal figures and strangle figures with interpolator and extrapolators fully specified.static InterpolatedStrikeSmileDeltaTermStructure
InterpolatedStrikeSmileDeltaTermStructure. of(DoubleArray expiries, DoubleArray delta, DoubleMatrix volatility, DayCount dayCount)
Obtains volatility term structure from expiry times, delta values and volatilities.static InterpolatedStrikeSmileDeltaTermStructure
InterpolatedStrikeSmileDeltaTermStructure. of(DoubleArray expiries, DoubleArray delta, DoubleMatrix volatility, DayCount dayCount, CurveInterpolator strikeInterpolator, CurveExtrapolator strikeExtrapolatorLeft, CurveExtrapolator strikeExtrapolatorRight)
Obtains volatility term structure from expiry times, delta values and volatilities with strike interpolator and extrapolators specified.static InterpolatedStrikeSmileDeltaTermStructure
InterpolatedStrikeSmileDeltaTermStructure. of(DoubleArray expiries, DoubleArray delta, DoubleMatrix volatility, DayCount dayCount, CurveInterpolator timeInterpolator, CurveExtrapolator timeExtrapolatorLeft, CurveExtrapolator timeExtrapolatorRight, CurveInterpolator strikeInterpolator, CurveExtrapolator strikeExtrapolatorLeft, CurveExtrapolator strikeExtrapolatorRight)
Obtains volatility term structure from expiry times, delta values and volatilities with interpolator and extrapolators fully specified.static RecombiningTrinomialTreeData
RecombiningTrinomialTreeData. of(DoubleMatrix stateValue, List<DoubleMatrix> transitionProbability, DoubleArray discountFactor, DoubleArray time)
Creates an instance.static SmileAndBucketedSensitivities
SmileAndBucketedSensitivities. of(SmileDeltaParameters smile, DoubleMatrix sensitivities)
Obtains an instance.static VolatilityAndBucketedSensitivities
VolatilityAndBucketedSensitivities. of(double volatility, DoubleMatrix sensitivities)
Obtains an instance.Method parameters in com.opengamma.strata.pricer.fxopt with type arguments of type DoubleMatrix Modifier and Type Method Description static RecombiningTrinomialTreeData
RecombiningTrinomialTreeData. of(DoubleMatrix stateValue, List<DoubleMatrix> transitionProbability, DoubleArray discountFactor, DoubleArray time)
Creates an instance. -
Uses of DoubleMatrix in com.opengamma.strata.pricer.impl.rate.model
Methods in com.opengamma.strata.pricer.impl.rate.model that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
HullWhiteOneFactorPiecewiseConstantInterestRateModel. volatilityMaturityPart(HullWhiteOneFactorPiecewiseConstantParameters hwParameters, double u, DoubleMatrix v)
Calculates the maturity dependent part of the volatility (function called H in the implementation note).Methods in com.opengamma.strata.pricer.impl.rate.model with parameters of type DoubleMatrix Modifier and Type Method Description DoubleMatrix
HullWhiteOneFactorPiecewiseConstantInterestRateModel. volatilityMaturityPart(HullWhiteOneFactorPiecewiseConstantParameters hwParameters, double u, DoubleMatrix v)
Calculates the maturity dependent part of the volatility (function called H in the implementation note). -
Uses of DoubleMatrix in com.opengamma.strata.pricer.impl.tree
Methods in com.opengamma.strata.pricer.impl.tree with parameters of type DoubleMatrix Modifier and Type Method Description default DoubleArray
OptionFunction. getNextOptionValues(double discountFactor, DoubleMatrix transitionProbability, DoubleArray stateValue, DoubleArray value, int i)
Computes the option values in the intermediate nodes. -
Uses of DoubleMatrix in com.opengamma.strata.pricer.impl.volatility.smile
Methods in com.opengamma.strata.pricer.impl.volatility.smile that return types with arguments of type DoubleMatrix Modifier and Type Method Description protected Function<DoubleArray,DoubleMatrix>
SmileModelFitter. getModelJacobianFunction()
Obtains Jacobian function of the smile model. -
Uses of DoubleMatrix in com.opengamma.strata.pricer.option
Methods in com.opengamma.strata.pricer.option that return DoubleMatrix Modifier and Type Method Description DoubleMatrix
RawOptionData. getData()
Gets the data.Methods in com.opengamma.strata.pricer.option that return types with arguments of type DoubleMatrix Modifier and Type Method Description Optional<DoubleMatrix>
RawOptionData. getError()
Gets the measurement error of the option data.Methods in com.opengamma.strata.pricer.option with parameters of type DoubleMatrix Modifier and Type Method Description static RawOptionData
RawOptionData. of(List<Period> expiries, DoubleArray strikes, ValueType strikeType, DoubleMatrix data, DoubleMatrix error, ValueType dataType)
Obtains an instance of the raw data with error.static RawOptionData
RawOptionData. of(List<Period> expiries, DoubleArray strikes, ValueType strikeType, DoubleMatrix data, ValueType dataType)
Obtains an instance of the raw volatility.static RawOptionData
RawOptionData. ofBlackVolatility(List<Period> expiries, DoubleArray strikes, ValueType strikeType, DoubleMatrix data, DoubleMatrix error, Double shift)
Obtains an instance of the raw data with error for shifted Black (log-normal) volatility.static RawOptionData
RawOptionData. ofBlackVolatility(List<Period> expiries, DoubleArray strikes, ValueType strikeType, DoubleMatrix data, Double shift)
Obtains an instance of the raw volatility for shifted Black (log-normal) volatility. -
Uses of DoubleMatrix in com.opengamma.strata.pricer.sensitivity
Methods in com.opengamma.strata.pricer.sensitivity that return DoubleMatrix Modifier and Type Method Description static DoubleMatrix
CurveSensitivityUtils. jacobianFromMarketQuoteSensitivities(List<CurveParameterSize> curveOrder, List<CurrencyParameterSensitivities> marketQuoteSensitivities)
Construct the inverse Jacobian matrix from the sensitivities of the trades market quotes to the curve parameters.static DoubleMatrix
CurveSensitivityUtils. jacobianFromMarketQuoteSensitivities(List<CurveParameterSize> curveOrder, List<ResolvedTrade> trades, Function<ResolvedTrade,CurrencyParameterSensitivities> sensitivityFunction)
Construct the inverse Jacobian matrix from the trades and a function used to compute the sensitivities of the market quotes to the curve parameters.
-