Uses of Class
org.flag4j.numbers.Complex128
Packages that use Complex128
Package
Description
Provides implementations of "smart" array objects, the tensor shape object, and tuples.
Provides implementations for dense tensors, matrices, and vectors.
Contains implementations for sparse tensors, matrices, and vectors.
General purpose linear algebra operations including condition number evaluations, eigenvalue/eigenvector computations, matrix
inversion, and subspace analysis.
Provides implementations of the Schur decomposition for real and complex matrices.
Provides abstract classes useful for implementing real or complex matrix decompositions which proceed by unitary transformations.
General linear algebra operations.
Implementations of operations on two complex array objects.
Implementations of operations on complex dense array objects.
Implementations of operations on
Field dense array objects.Implementations of operations between real and complex sparse COO (coordinate) array objects.
Contains solvers which solve well determined triangular linear matrix equations in an exact sense.
Utility classes for computing and applying matrix and vector transformations.
Provides algebraic structures such as semirings, rings, and fields,
along with their concrete implementations.
Pseudo-random generation of real/complex numbers, and arrays, vectors, matrices, and tensors.
Statistical distributions useful for repeated random sampling.
General utilities for arrays, strings, data validation, and generating error messages.
-
Uses of Complex128 in org.flag4j.arrays
Constructors in org.flag4j.arrays with parameters of type Complex128ModifierConstructorDescriptionSmartMatrix(Complex128[][] matrix) Constructs aSmartMatrixfrom a 2DComplex128array. -
Uses of Complex128 in org.flag4j.arrays.dense
Subclasses with type arguments of type Complex128 in org.flag4j.arrays.denseModifier and TypeClassDescriptionclassInstances of this class represents a complex dense matrix backed by aComplex128array.classA dense complex tensor backed by an array ofComplex128's.classMethods in org.flag4j.arrays.dense that return Complex128Modifier and TypeMethodDescriptionCVector.mag()Computes the magnitude of this vector.CMatrix.makeEmptyDataArray(int length) CTensor.makeEmptyDataArray(int length) CVector.makeEmptyDataArray(int length) Methods in org.flag4j.arrays.dense with parameters of type Complex128Modifier and TypeMethodDescriptionMatrix.add(Complex128 b) Adds a complex-valued scalar to each entry of this matrix.Tensor.add(Complex128 b) Adds a complex-valued scalar value to each entry of this tensor.Vector.add(Complex128 b) Adds a complex-valued scalar value to each entry of this tensor.static CMatrixCMatrix.diag(Complex128... data) Constructs a diagonal matrix from an array specifying the diagonal elements of the matrix.Matrix.div(Complex128 b) Computes the scalar division of this matrix with a complex number.Tensor.div(Complex128 b) Divides each entry of this tensor by a complex scalar value.Vector.div(Complex128 b) Divides this vector by a complex-valued scalar.protected CooCMatrixCMatrix.makeLikeCooMatrix(Shape shape, Complex128[] entries, int[] rowIndices, int[] colIndices) Constructs a sparse COO matrix which is of a similar type as this dense matrix.protected CooCMatrixCMatrix.makeLikeCooTensor(Shape shape, Complex128[] entries, int[][] indices) Constructs a sparse COO tensor which is of a similar type as this dense tensor.protected CooCTensorCTensor.makeLikeCooTensor(Shape shape, Complex128[] entries, int[][] indices) Constructs a sparse COO tensor which is of a similar type as this dense tensor.protected CooCVectorCVector.makeLikeCooTensor(Shape shape, Complex128[] entries, int[][] indices) Constructs a sparse COO tensor which is of a similar type as this dense tensor.CMatrix.makeLikeCsrMatrix(Shape shape, Complex128[] entries, int[] rowPointers, int[] colIndices) Constructs a sparse CSR matrix which is of a similar type as this dense matrix.CVector.makeLikeMatrix(Shape shape, Complex128[] entries) Constructs a matrix of similar type to this vector with the specifiedshapeanddata.CMatrix.makeLikeTensor(Shape shape, Complex128[] entries) Constructs a tensor of the same type as this tensor with the given theshapeanddata.CTensor.makeLikeTensor(Shape shape, Complex128[] entries) Constructs a tensor of the same type as this tensor with the given the shape and data.CVector.makeLikeTensor(Shape shape, Complex128[] entries) Constructs a tensor of the same type as this tensor with the given theshapeanddata.CVector.makeLikeTensor(Complex128[] entries) Constructs a dense vector with the specifieddataof the same type as the vector.protected CVectorCMatrix.makeLikeVector(Shape shape, Complex128[] entries) Constructs a vector of a similar type as this matrix.protected CVectorCMatrix.makeLikeVector(Complex128[] entries) Constructs a vector of a similar type as this matrix.Matrix.mult(Complex128 b) Computes the scalar multiplication of this matrix with a complex number.Tensor.mult(Complex128 b) Multiplies a complex scalar value to each entry of this tensor.Vector.mult(Complex128 b) Multiplies this vector by a complex-valued scalar.Matrix.sub(Complex128 b) Subtracts a complex-valued scalar from each entry of this matrix.Tensor.sub(Complex128 b) Subtracts a complex-valued scalar from each element of this tensor.Vector.sub(Complex128 b) Subtracts a complex-valued scalar from each entry of this vector.Constructors in org.flag4j.arrays.dense with parameters of type Complex128ModifierConstructorDescriptionCMatrix(int rows, int cols, Complex128 fillValue) Creates a complex matrix with the specified shape and filled withfillValue.CMatrix(int rows, int cols, Complex128[] entries) Creates a complex matrix with the specifieddata, and shape.CMatrix(int size, Complex128 fillValue) Creates a square matrix with the specifiedsizefilled withfillValue.CMatrix(Shape shape, Complex128 fillValue) Creates a complex matrix with the specifiedshapefilled withfillValue.CMatrix(Shape shape, Complex128[] entries) Creates a complex matrix with the specifieddataandshape.CMatrix(Complex128[][] entries) Constructs a complex matrix from a 2D array.CTensor(Shape shape, Complex128 fillValue) Creates a tensor with the specified shape and filled withfillValue.CTensor(Shape shape, Complex128[] entries) Creates a tensor with the specified data and shape.CVector(int size, Complex128 fillValue) Creates a complex vector with the specifiedsizeand filled withfillValue.CVector(Shape shape, Complex128[] data) Constructs a dense complex vector with the given shape and entries.CVector(Complex128... entries) Creates a complex vector with the specifieddata. -
Uses of Complex128 in org.flag4j.arrays.sparse
Subclasses with type arguments of type Complex128 in org.flag4j.arrays.sparseModifier and TypeClassDescriptionclassA complex sparse matrix stored in coordinate list (COO) format.classSparse complex tensor stored in coordinate list (COO) format.classA complex sparse vector stored in coordinate list (COO) format.classInstances of this class represent a complex sparse matrix using the compressed sparse row (CSR) format.Methods in org.flag4j.arrays.sparse that return Complex128Modifier and TypeMethodDescriptionCooCVector.mag()Computes the magnitude of this vector.CooCMatrix.makeEmptyDataArray(int length) CooCTensor.makeEmptyDataArray(int length) CooCVector.makeEmptyDataArray(int length) CsrCMatrix.makeEmptyDataArray(int length) Methods in org.flag4j.arrays.sparse that return types with arguments of type Complex128Modifier and TypeMethodDescriptionCooCMatrix.tensorDot(CooCMatrix src2, int[] aAxes, int[] bAxes) Computes the tensor contraction of this tensor with a specified tensor over the specified set of axes.Methods in org.flag4j.arrays.sparse with parameters of type Complex128Modifier and TypeMethodDescriptionCooMatrix.add(Complex128 b) Adds a scalar value to each non-zero element of this tensor.CooVector.add(Complex128 b) Adds a scalar field value to each non-zero entry of this tensor.CsrMatrix.add(Complex128 b) Adds a complex-valued scalar to all non-zero data of this sparse matrix.CooVector.div(Complex128 divisor) Divides each element of this sparse COO vector by a complex-valued scalar.CsrCMatrix.makeLikeCooMatrix(Shape shape, Complex128[] entries, int[] rowIndices, int[] colIndices) Constructs a sparse COO matrix of a similar type to this sparse CSR matrix.CooCMatrix.makeLikeCsrMatrix(Shape shape, Complex128[] entries, int[] rowPointers, int[] colIndices) Constructs a sparse CSR matrix of a similar type to this sparse COO matrix.CooCVector.makeLikeDenseMatrix(Shape shape, Complex128... entries) Constructs a dense matrix of a similar type as this vector with the specified shape and data.CooCMatrix.makeLikeDenseTensor(Shape shape, Complex128[] entries) Constructs a dense tensor with the specifiedshapeanddatawhich is a similar type to this sparse tensor.CooCTensor.makeLikeDenseTensor(Shape shape, Complex128[] entries) Constructs a dense tensor that is a similar type as this sparse COO tensor.CooCVector.makeLikeDenseTensor(Shape shape, Complex128... entries) Constructs a dense vector of a similar type as this vector with the specified shape and data.CsrCMatrix.makeLikeDenseTensor(Shape shape, Complex128[] entries) Constructs a dense matrix which is of a similar type to this sparse CSR matrix.CooCVector.makeLikeMatrix(Shape shape, Complex128[] entries, int[] rowIndices, int[] colIndices) Constructs a COO matrix with the specified shape, non-zero data, and row and column indices.CooCMatrix.makeLikeTensor(Shape shape, Complex128[] entries) Constructs a tensor of the same type as this tensor with the given theshapeanddata.CooCMatrix.makeLikeTensor(Shape shape, Complex128[] entries, int[] rowIndices, int[] colIndices) Constructs a sparse COO tensor of the same type as this tensor with the specified non-zero data and indices.CooCTensor.makeLikeTensor(Shape shape, Complex128[] entries) Constructs a tensor of the same type as this tensor with the given theshapeanddata.CooCTensor.makeLikeTensor(Shape shape, Complex128[] entries, int[][] indices) Constructs a tensor of the same type as this tensor with the specified shape and non-zero data.CooCVector.makeLikeTensor(Shape shape, Complex128[] entries) Constructs a tensor of the same type as this tensor with the given theshapeanddata.CooCVector.makeLikeTensor(Shape shape, Complex128[] entries, int[] indices) Constructs a sparse COO vector of the same type as this vector with the specified non-zero data and indices.CsrCMatrix.makeLikeTensor(Shape shape, Complex128[] entries) Constructs a tensor of the same type as this tensor with the given theshapeanddata.CsrCMatrix.makeLikeTensor(Shape shape, Complex128[] entries, int[] rowPointers, int[] colIndices) Constructs a sparse CSR tensor of the same type as this tensor with the specified non-zero data and indices.CooCMatrix.makeLikeVector(Shape shape, Complex128[] entries, int[] indices) Constructs a sparse COO vector of a similar type to this COO matrix.CooVector.mult(Complex128 factor) Multiplies this vector by a complex scalar value.CooMatrix.sub(Complex128 b) Subtracts a scalar value from each non-zero element of this tensor.CooVector.sub(Complex128 b) Subtracts a scalar value from each non-zero entry of this tensor.CsrMatrix.sub(Complex128 b) Subtracts a complex-valued scalar from all non-zero data of this sparse matrix.static CooCMatrixCooCMatrix.unsafeMake(Shape shape, Complex128[] data, int[] rowIndices, int[] colIndices) Factory to construct a COO matrix which bypasses any validation checks on the data and indices.static CooCTensorCooCTensor.unsafeMake(Shape shape, Complex128[] data, int[][] indices) Factory to construct a COO tensor which bypasses any validation checks on the data and indices.static CooCVectorCooCVector.unsafeMake(int size, Complex128[] data, int[] indices) Factory to construct a COO vector which bypasses any validation checks on the data and indices.static CooCVectorCooCVector.unsafeMake(Shape shape, Complex128[] data, int[] indices) Factory to construct a COO vector which bypasses any validation checks on the data and indices.static CsrCMatrixCsrCMatrix.unsafeMake(Shape shape, Complex128[] data, int[] rowPointers, int[] colIndices) Factory to construct a CSR matrix which bypasses any validation checks on the data and indices.static <T extends Field<T>>
CsrFieldMatrix<T> CsrFieldMatrix.unsafeMake(Shape shape, Complex128[] data, int[] rowPointers, int[] colIndices) Factory to construct a CSR matrix which bypasses any validation checks on the data and indices.static <T extends Ring<T>>
CsrRingMatrix<T> CsrRingMatrix.unsafeMake(Shape shape, Complex128[] data, int[] rowPointers, int[] colIndices) Factory to construct a CSR matrix which bypasses any validation checks on the data and indices.static <T extends Semiring<T>>
CsrSemiringMatrix<T> CsrSemiringMatrix.unsafeMake(Shape shape, Complex128[] data, int[] rowPointers, int[] colIndices) Factory to construct a CSR matrix which bypasses any validation checks on the data and indices.Method parameters in org.flag4j.arrays.sparse with type arguments of type Complex128Modifier and TypeMethodDescriptionCooCMatrix.makeLikeTensor(Shape shape, List<Complex128> entries, List<Integer> rowIndices, List<Integer> colIndices) Constructs a COO matrix with the specified shape, non-zero data, and non-zero indices.CooCTensor.makeLikeTensor(Shape shape, List<Complex128> entries, List<int[]> indices) Constructs a tensor of the same type as this tensor with the specified shape and non-zero data.CooCVector.makeLikeTensor(Shape shape, List<Complex128> entries, List<Integer> indices) Constructs a COO vector with the specified shape, non-zero data, and non-zero indices.CsrCMatrix.makeLikeTensor(Shape shape, List<Complex128> entries, List<Integer> rowPointers, List<Integer> colIndices) Constructs a CSR matrix with the specified shape, non-zero data, and non-zero indices.Constructors in org.flag4j.arrays.sparse with parameters of type Complex128ModifierConstructorDescriptionCooCMatrix(int rows, int cols, Complex128[] entries, int[] rowIndices, int[] colIndices) Creates a sparse coo matrix with the specified non-zero data, non-zero indices, and shape.CooCMatrix(int size, Complex128[] entries, int[] rowIndices, int[] colIndices) Constructs a square complex sparse COO matrix with the specifiedsize, non-zero values, and non-zero indices.CooCMatrix(Shape shape, Complex128[] entries, int[] rowIndices, int[] colIndices) Creates a sparse coo matrix with the specified non-zero data, non-zero indices, and shape.CooCTensor(Shape shape, Complex128[] entries, int[][] indices) Creates a tensor with the specified data and shape.CooCVector(int size, Complex128[] entries, int[] indices) Creates a tensor with the specified data and shape.CooCVector(Shape shape, Complex128[] entries, int[] indices) Creates a tensor with the specified data and shape.CsrCMatrix(int rows, int cols, Complex128[] entries, int[] rowPointers, int[] colIndices) Creates a complex sparse CSR matrix with the specified shape, non-zero data, row pointers, and non-zero column indices.CsrCMatrix(Shape shape, Complex128[] entries, int[] rowPointers, int[] colIndices) Creates a complex sparse CSR matrix with the specifiedshape, non-zero data, row pointers, and non-zero column indices.Constructor parameters in org.flag4j.arrays.sparse with type arguments of type Complex128ModifierConstructorDescriptionCooCMatrix(int rows, int cols, List<Complex128> entries, List<Integer> rowIndices, List<Integer> colIndices) Creates a sparse coo matrix with the specified non-zero data, non-zero indices, and shape.CooCMatrix(Shape shape, List<Complex128> entries, List<Integer> rowIndices, List<Integer> colIndices) Creates a sparse coo matrix with the specified non-zero data, non-zero indices, and shape.CooCTensor(Shape shape, List<Complex128> entries, List<int[]> indices) Creates a tensor with the specified data and shape.CooCVector(int size, List<Complex128> entries, List<Integer> indices) Constructs a complex COO vector with the specified size, non-zero data, and non-zero indices.CooCVector(Shape shape, List<Complex128> entries, List<Integer> indices) Constructs a complex COO vector with the specified size, non-zero data, and non-zero indices.CsrCMatrix(int rows, int cols, List<Complex128> entries, List<Integer> rowPointers, List<Integer> colIndices) Creates a complex sparse CSR matrix with the specifiedshape, non-zero data, row pointers, and non-zero column indices.CsrCMatrix(Shape shape, List<Complex128> entries, List<Integer> rowPointers, List<Integer> colIndices) Creates a complex sparse CSR matrix with the specifiedshape, non-zero data, row pointers, and non-zero column indices. -
Uses of Complex128 in org.flag4j.io.parsing
Methods in org.flag4j.io.parsing that return Complex128Modifier and TypeMethodDescriptionstatic Complex128ComplexNumberParser.parseNumberToComplex128(String num) Parses a complex number in the form of a string into its real and imaginary parts. -
Uses of Complex128 in org.flag4j.linalg
Methods in org.flag4j.linalg that return Complex128Modifier and TypeMethodDescriptionstatic Complex128[]Eigen.get2x2EigenValues(double a11, double a12, double a21, double a22) Computes the eigenvalues of a 2×2 matrix explicitly.static Complex128[]Eigen.get2x2EigenValues(Complex128 a11, Complex128 a12, Complex128 a21, Complex128 a22) Computes the eigenvalues of a 2×2 complex matrix (assumed to be row major).Methods in org.flag4j.linalg with parameters of type Complex128Modifier and TypeMethodDescriptionstatic Complex128[]Eigen.get2x2EigenValues(Complex128 a11, Complex128 a12, Complex128 a21, Complex128 a22) Computes the eigenvalues of a 2×2 complex matrix (assumed to be row major). -
Uses of Complex128 in org.flag4j.linalg.decompositions.schur
Fields in org.flag4j.linalg.decompositions.schur declared as Complex128Modifier and TypeFieldDescriptionprotected Complex128ComplexSchur.currentFactorStores the scalar factor \( \alpha \) for use in computation of the Householder reflector \( P = I - \alpha vv^{T} \).protected Complex128ComplexSchur.normFor computing the norm of a column for use when computing Householder reflectors.Methods in org.flag4j.linalg.decompositions.schur that return Complex128Modifier and TypeMethodDescriptionprotected Complex128ComplexSchur.computeExceptionalShift(int k) Computes a random shift to help the QR algorithm converge if it gets stuck.Methods in org.flag4j.linalg.decompositions.schur with parameters of type Complex128Modifier and TypeMethodDescriptionprotected voidComplexSchur.computeImplicitSingleShift(int k, Complex128 shift) Computes the non-zero data of the first column for the single shifted QR algorithm.protected booleanComplexSchur.makeReflector(int i, Complex128 p1, Complex128 p2) Constructs a householder reflector given specified values for a column to apply the reflector to.protected booleanComplexSchur.makeReflector(int i, Complex128 p1, Complex128 p2, Complex128 p3) Constructs a householder reflector given specified values for a column to apply the reflector to.protected voidComplexSchur.performSingleShift(int workEnd, Complex128 shift) Performs a full iteration of the implicit single shifted QR algorithm (this includes the bulge chase). -
Uses of Complex128 in org.flag4j.linalg.decompositions.unitary
Fields in org.flag4j.linalg.decompositions.unitary declared as Complex128Modifier and TypeFieldDescriptionprotected Complex128ComplexUnitaryDecomposition.currentFactorScalar factor of the currently computed Householder reflector.protected Complex128ComplexUnitaryDecomposition.normFor storing the scaled, phase-adjusted norm. -
Uses of Complex128 in org.flag4j.linalg.ops
Methods in org.flag4j.linalg.ops that return Complex128Modifier and TypeMethodDescriptionstatic Complex128[]Dispatches a matrix multiplication problem to the appropriate algorithm based on the size.static Complex128[]Dispatches a matrix multiplication problem to the appropriate algorithm based on the size.static Complex128[]Dynamically chooses the appropriate matrix-vector multiplication algorithm based on the shapes of the matrix and vector. -
Uses of Complex128 in org.flag4j.linalg.ops.common.complex
Methods in org.flag4j.linalg.ops.common.complex that return Complex128Modifier and TypeMethodDescriptionstatic Complex128[]Complex128Ops.round(Complex128[] src, int precision) Rounds the values of a tensor with specified precision.static Complex128[]Complex128Ops.roundToZero(Complex128[] src, double threshold) Rounds values which are close to zero in absolute value to zero.static Complex128[]Complex128Ops.scalDiv(double[] entries, Complex128 divisor) Computes the scalar division of a tensor.static Complex128[]Complex128Ops.sqrt(double[] src) Computes the element-wise square root of a tensor as complex values.Methods in org.flag4j.linalg.ops.common.complex with parameters of type Complex128Modifier and TypeMethodDescriptionstatic booleanComplex128Ops.isComplex(Complex128[] entries) Checks whether a tensor contains at least one non-real value.static booleanComplex128Ops.isReal(Complex128[] entries) Checks whether a tensor contains only real values.static Complex128[]Complex128Ops.round(Complex128[] src, int precision) Rounds the values of a tensor with specified precision.static Complex128[]Complex128Ops.roundToZero(Complex128[] src, double threshold) Rounds values which are close to zero in absolute value to zero.static Complex128[]Complex128Ops.scalDiv(double[] entries, Complex128 divisor) Computes the scalar division of a tensor.static double[]Complex128Ops.toReal(Complex128[] src) Converts a complex tensor to a real tensor by copying the real component and discarding the imaginary component. -
Uses of Complex128 in org.flag4j.linalg.ops.dense_sparse.coo.real_complex
Methods in org.flag4j.linalg.ops.dense_sparse.coo.real_complex with parameters of type Complex128Modifier and TypeMethodDescriptionstatic voidRealComplexDenseCooOps.add(Shape shape1, double[] src1, Shape shape2, Complex128[] src2, int[][] indices, Complex128[] dest) Computes element-wise sum between a real dense tensor to a sparse COO complex tensor.static CTensorRealComplexDenseCooOps.add(CooTensor src1, Complex128 b) Adds a scalar to a real sparse COO tensor.static CTensorRealComplexDenseCooOps.sub(CooTensor src1, Complex128 b) Subtracts a scalar from a real sparse COO tensor.static booleanRealComplexDenseSparseEquals.vectorEquals(double[] src1, Complex128[] src2, int[] indices, int sparseSize) Checks if a real dense vector is equal to a complex sparse vector equals.static booleanRealComplexDenseSparseEquals.vectorEquals(Complex128[] src1, double[] src2, int[] indices, int sparseSize) Checks if a complex dense vector is equal to a real sparse vector. -
Uses of Complex128 in org.flag4j.linalg.ops.dense_sparse.csr.real_complex
Methods in org.flag4j.linalg.ops.dense_sparse.csr.real_complex with parameters of type Complex128Modifier and TypeMethodDescriptionstatic CMatrixRealComplexCsrDenseOps.applyBinOpp(CsrMatrix src1, Complex128 b, BiFunction<Double, Complex128, Complex128> opp, UnaryOperator<Complex128> uOpp) Applies the specified binary operator element-wise to a matrix and a scalar.Method parameters in org.flag4j.linalg.ops.dense_sparse.csr.real_complex with type arguments of type Complex128Modifier and TypeMethodDescriptionstatic CMatrixRealComplexCsrDenseOps.applyBinOpp(Matrix src1, CsrCMatrix src2, BiFunction<Double, Complex128, Complex128> opp) Applies the specified binary operator element-wise to the two matrices.static CMatrixRealComplexCsrDenseOps.applyBinOpp(Matrix src1, CsrCMatrix src2, BiFunction<Double, Complex128, Complex128> opp) Applies the specified binary operator element-wise to the two matrices.static CMatrixRealComplexCsrDenseOps.applyBinOpp(CsrCMatrix src1, Matrix src2, BiFunction<Complex128, Double, Complex128> opp, UnaryOperator<Double> uOpp) Applies the specified binary operator element-wise to the two matrices.static CMatrixRealComplexCsrDenseOps.applyBinOpp(CsrCMatrix src1, Matrix src2, BiFunction<Complex128, Double, Complex128> opp, UnaryOperator<Double> uOpp) Applies the specified binary operator element-wise to the two matrices.static CMatrixRealComplexCsrDenseOps.applyBinOpp(CsrMatrix src1, Complex128 b, BiFunction<Double, Complex128, Complex128> opp, UnaryOperator<Complex128> uOpp) Applies the specified binary operator element-wise to a matrix and a scalar.static CMatrixRealComplexCsrDenseOps.applyBinOpp(CsrMatrix src1, Complex128 b, BiFunction<Double, Complex128, Complex128> opp, UnaryOperator<Complex128> uOpp) Applies the specified binary operator element-wise to a matrix and a scalar.static CMatrixRealComplexCsrDenseOps.applyBinOpp(CsrMatrix src1, Complex128 b, BiFunction<Double, Complex128, Complex128> opp, UnaryOperator<Complex128> uOpp) Applies the specified binary operator element-wise to a matrix and a scalar. -
Uses of Complex128 in org.flag4j.linalg.ops.dense.complex
Methods in org.flag4j.linalg.ops.dense.complex that return Complex128Modifier and TypeMethodDescriptionstatic Complex128Computes the determinant of a square matrix using the LU factorization.static Complex128Computes the determinant of a square matrix using the LU factorization. -
Uses of Complex128 in org.flag4j.linalg.ops.dense.field_ops
Methods in org.flag4j.linalg.ops.dense.field_ops with parameters of type Complex128Modifier and TypeMethodDescriptionstatic doubleDenseFieldVectorOps.innerSelfProduct(Complex128[] src1) Computes the inner product (dot product) of a vector with itself. -
Uses of Complex128 in org.flag4j.linalg.ops.sparse.coo.real_complex
Methods in org.flag4j.linalg.ops.sparse.coo.real_complex that return Complex128Modifier and TypeMethodDescriptionstatic Complex128[]RealComplexSparseMatrixMultiplication.concurrentStandard(double[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, Complex128[] src2, int[] rowIndices2, int[] colIndices2, Shape shape2) Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.concurrentStandard(Complex128[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, double[] src2, int[] rowIndices2, int[] colIndices2, Shape shape2) Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.concurrentStandardVector(double[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, Complex128[] src2, int[] indices, Shape shape2) Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.concurrentStandardVector(Complex128[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, double[] src2, int[] indices, Shape shape2) Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.static Complex128RealComplexSparseVectorOps.inner(CooCVector src1, CooVector src2) Computes the inner product of a real and complex sparse vector.static Complex128RealComplexSparseVectorOps.inner(CooVector src1, CooCVector src2) Computes the inner product of a real and complex sparse vector.static Complex128[]RealComplexSparseMatrixMultiplication.standard(double[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, Complex128[] src2, int[] rowIndices2, int[] colIndices2, Shape shape2) Computes the matrix multiplication between two sparse matrices using a standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.standard(Complex128[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, double[] src2, int[] rowIndices2, int[] colIndices2, Shape shape2) Computes the matrix multiplication between two sparse matrices using a standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.standardVector(double[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, Complex128[] src2, int[] indices, Shape shape2) Computes the multiplication between a sparse matrix and a sparse vector using a standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.standardVector(Complex128[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, double[] src2, int[] indices, Shape shape2) Computes the multiplication between a sparse matrix and a sparse vector using a standard algorithm.Methods in org.flag4j.linalg.ops.sparse.coo.real_complex with parameters of type Complex128Modifier and TypeMethodDescriptionstatic CMatrixRealComplexSparseMatOps.add(CooMatrix src, Complex128 a) Adds a complex number to all data (including zero values) of a real sparse matrix.static CVectorRealComplexSparseVectorOps.add(CooVector src, Complex128 a) Adds a real number to each entry of a sparse vector, including the zero data.static Complex128[]RealComplexSparseMatrixMultiplication.concurrentStandard(double[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, Complex128[] src2, int[] rowIndices2, int[] colIndices2, Shape shape2) Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.concurrentStandard(Complex128[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, double[] src2, int[] rowIndices2, int[] colIndices2, Shape shape2) Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.concurrentStandardVector(double[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, Complex128[] src2, int[] indices, Shape shape2) Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.concurrentStandardVector(Complex128[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, double[] src2, int[] indices, Shape shape2) Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.standard(double[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, Complex128[] src2, int[] rowIndices2, int[] colIndices2, Shape shape2) Computes the matrix multiplication between two sparse matrices using a standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.standard(Complex128[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, double[] src2, int[] rowIndices2, int[] colIndices2, Shape shape2) Computes the matrix multiplication between two sparse matrices using a standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.standardVector(double[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, Complex128[] src2, int[] indices, Shape shape2) Computes the multiplication between a sparse matrix and a sparse vector using a standard algorithm.static Complex128[]RealComplexSparseMatrixMultiplication.standardVector(Complex128[] src1, int[] rowIndices1, int[] colIndices1, Shape shape1, double[] src2, int[] indices, Shape shape2) Computes the multiplication between a sparse matrix and a sparse vector using a standard algorithm.static CMatrixRealComplexSparseMatOps.sub(CooMatrix src, Complex128 a) Adds a complex number to all data (including zero values) of a real sparse matrix.static CVectorRealComplexSparseVectorOps.sub(CooVector src, Complex128 a) Subtracts a real number from each entry of a sparse vector, including the zero data. -
Uses of Complex128 in org.flag4j.linalg.ops.sparse.csr.real_complex
Method parameters in org.flag4j.linalg.ops.sparse.csr.real_complex with type arguments of type Complex128Modifier and TypeMethodDescriptionstatic CsrCMatrixRealComplexCsrOps.applyBinOpp(CsrCMatrix src1, CsrMatrix src2, BiFunction<Complex128, Double, Complex128> opp, UnaryOperator<Double> uOpp) Applies an element-wise binary operation to twoCSR Matrices.static CsrCMatrixRealComplexCsrOps.applyBinOpp(CsrCMatrix src1, CsrMatrix src2, BiFunction<Complex128, Double, Complex128> opp, UnaryOperator<Double> uOpp) Applies an element-wise binary operation to twoCSR Matrices.static CsrCMatrixRealComplexCsrOps.applyBinOpp(CsrMatrix src1, CsrCMatrix src2, BiFunction<Double, Complex128, Complex128> opp, UnaryOperator<Complex128> uOpp) Applies an element-wise binary operation to twoCSR Matrices.static CsrCMatrixRealComplexCsrOps.applyBinOpp(CsrMatrix src1, CsrCMatrix src2, BiFunction<Double, Complex128, Complex128> opp, UnaryOperator<Complex128> uOpp) Applies an element-wise binary operation to twoCSR Matrices.static CsrCMatrixRealComplexCsrOps.applyBinOpp(CsrMatrix src1, CsrCMatrix src2, BiFunction<Double, Complex128, Complex128> opp, UnaryOperator<Complex128> uOpp) Applies an element-wise binary operation to twoCSR Matrices. -
Uses of Complex128 in org.flag4j.linalg.solvers.exact.triangular
Fields in org.flag4j.linalg.solvers.exact.triangular declared as Complex128Modifier and TypeFieldDescriptionprotected Complex128ComplexBackSolver.detFor computing determinant of coefficient matrix during solve.Methods in org.flag4j.linalg.solvers.exact.triangular that return Complex128 -
Uses of Complex128 in org.flag4j.linalg.transformations
Methods in org.flag4j.linalg.transformations with parameters of type Complex128Modifier and TypeMethodDescriptionstatic CMatrixGivens.get2x2Rotator(Complex128 v0, Complex128 v1) Constructs a Givens rotator \( G \) of size 2 such that for a vector \( \mathbf{v} = \begin{bmatrix}a & b\end{bmatrix} \) we have \( G\mathbf{v} = \begin{bmatrix}r & 0\end{bmatrix} \).static voidHouseholder.hermLeftRightMultReflector(CMatrix src, Complex128[] householderVector, Complex128 alpha, int startCol, Complex128[] workArray) Applies a Householder matrix \( H = I-\alpha vv^{H} \), represented by the vector \( v \) to a Hermitian matrix \( A \) on both the left and right side.static voidGivens.leftMult2x2Rotator(CMatrix src, CMatrix G, int i, Complex128[] workArray) Left multiplies a \( 2\times2 \) Givens rotator to a matrix at the specified i.static voidHouseholder.leftMultReflector(CMatrix src, CVector householderVector, Complex128 alpha, int startCol, int startRow, int endRow) Left multiplies a Householder matrix \( H = I-\alpha vv^{H} \), represented by the vector \( v \), to another matrix \( A \).static voidHouseholder.leftMultReflector(CMatrix src, Complex128[] householderVector, Complex128 alpha, int startCol, int startRow, int endRow, Complex128[] workArray) Left multiplies a Householder matrix \( H = I-\alpha vv^{H} \), represented by the vector \( v \), to another matrix \( A \).static voidGivens.rightMult2x2Rotator(CMatrix src, CMatrix G, int i, Complex128[] workArray) Right multiplies a \( 2\times2 \) Givens rotator to a matrix at the specified i.static voidHouseholder.rightMultReflector(CMatrix src, CVector householderVector, Complex128 alpha, int startCol, int startRow, int endRow) Right multiplies a Householder matrix \( H = I-\alpha vv^{H} \), represented by the vector \( v \), to another matrix \( A \).static voidHouseholder.rightMultReflector(CMatrix src, Complex128[] householderVector, Complex128 alpha, int startCol, int startRow, int endRow) Right multiplies a Householder matrix \( H = I-\alpha vv^{H} \), represented by the vector \( v \), to another matrix \( A \). -
Uses of Complex128 in org.flag4j.numbers
Classes in org.flag4j.numbers that implement interfaces with type arguments of type Complex128Modifier and TypeClassDescriptionclassRepresents an immutable complex number with double-precision floating point components.Fields in org.flag4j.numbers declared as Complex128Modifier and TypeFieldDescriptionstatic final Complex128Complex128.IMAGINARY_UNITThe imaginary unit i.static final Complex128Complex128.INV_IMAGINARY_UNITThe additive inverse of the imaginary unit, -i.static final Complex128Complex128.NaNComplex number with real and imaginary parts equal toDouble.NaN.static final Complex128Complex128.NEGATIVE_INFINITYComplex number with real part equal toDouble.NEGATIVE_INFINITY.static final Complex128Complex128.ONEThe complex number with zero imaginary part and one real part.static final Complex128Complex128.POSITIVE_INFINITYComplex number with real part equal toDouble.POSITIVE_INFINITY.static final Complex128Complex128.ROOT_THREEThe double value closer than any other to the square root of 3,static final Complex128Complex128.ROOT_TWOThe double value closer than any other to the square root of 2.static final Complex128Complex128.THREEThe complex number with zero imaginary part and three real part.static final Complex128Complex128.TWOThe complex number with zero imaginary part and two real part.static final Complex128Complex128.ZEROThe complex number with zero imaginary and real parts.Methods in org.flag4j.numbers that return Complex128Modifier and TypeMethodDescriptionstatic Complex128Complex128.acos(Complex128 num) Computes the inverse cosine of a complex value.Complex128.add(double b) Sums an elements of this field with a real number.Complex128.add(Complex128 b) Sums two elements of this field (associative and commutative).Complex128.addInv()Computes the additive inverse for an element of this field.static Complex128Complex128.asin(Complex128 num) Computes the inverse sine of a complex value.static Complex128Complex128.atan(Complex128 num) Computes the inverse tangent of a complex value.Complex128.conj()Computes the conjugate of this field element.static Complex128Complex128.cos(Complex128 num) Computes the trigonometric cosine value of a complex value.static Complex128Complex128.cosh(Complex128 num) Computes the hyperbolic cosine of a complex value.Complex128.div(double b) Computes the quotient of an elements of this field and a real number.Complex128.div(Complex128 b) Computes the quotient of two elements of this field.static Complex128Complex128.exp(Complex128 exponent) Computes the exponential function with the given input.static Complex128Complex128.fromPolar(double r, double theta) Converts a complex number expressed in polar from to the rectangular form.Complex128.getOne()Gets the multiplicative identity for this semiring.Complex128.getZero()Gets the additive identity for this semiring.static Complex128Complex128.ln(double num) Computes the natural logarithm of a double.static Complex128Complex128.ln(Complex128 num) Computes the complex natural logarithm of a complex number.static Complex128Complex128.log(double num) Computes the complex logarithm base 10 of a complex number.static Complex128Complex128.log(double base, double num) Computes the complex logarithm, with specified base, of a complex number.static Complex128Complex128.log(double base, Complex128 num) Computes the complex logarithm, with specified base, of a complex number.static Complex128Complex128.log(Complex128 num) Computes the complex logarithm base 10 of a complex number.static Complex128Complex128.log(Complex128 base, Complex128 num) Computes the complex logarithm, with specified base, of a complex number.static Complex128Complex128.max(Complex128... values) Computes the maximum magnitude from an array of complex numbers.static Complex128Complex128.maxRe(Complex128... values) Computes the minimum real component from an array of complex numbers.static Complex128Complex128.min(Complex128... values) Computes the minimum magnitude from an array of complex numbers.static Complex128Complex128.minRe(Complex128... values) Computes the minimum real component from an array of complex numbers.Complex128.mult(double b) Multiplies an element of this field with a real number.Complex128.mult(Complex128 b) Multiplies two elements of this field (associative and commutative).Complex128.multInv()Computes the multiplicative inverse of this complex number.static Complex128Complex128.pow(double a, Complex128 b) Compute a raised to the power ofb.static Complex128Complex128.pow(Complex128 a, double b) Computesaraised to the power ofb.static Complex128Complex128.pow(Complex128 a, Complex128 b) Compute a raised to the power of b.static Complex128Complex128.round(Complex128 n) Rounds both components of a complex number to the nearest respective integer.static Complex128Complex128.round(Complex128 n, int decimals) Rounds number to specified number of decimal places.static Complex128Complex128.roundToZero(Complex128 n, double tol) Rounds a complex numbers to zero if its magnitude within the specified tolerance from zero.static Complex128Complex128.sgn(Complex128 value) The complex signum function.static Complex128Complex128.sin(Complex128 num) Computes the trigonometric sine of a complex value.static Complex128Complex128.sinh(Complex128 num) Computes the hyperbolic sine of a complex value.Complex128.sqrt()Computes the square root of this field element.static Complex128Complex128.sqrt(double num) Computes the principle square root of a number.Complex128.sub(double b) Computes difference of an element of this field and a real number.Complex128.sub(Complex128 b) Computes difference of two elements of this field.static Complex128Complex128.sum(Complex128... numbers) Computes the sum of all data of specified array.static Complex128Complex128.tan(Complex128 num) Computes the trigonometric tangent value of a complex value.static Complex128Complex128.tanh(Complex128 num) Computes the hyperbolic tangent of a complex value.Methods in org.flag4j.numbers with parameters of type Complex128Modifier and TypeMethodDescriptionstatic Complex128Complex128.acos(Complex128 num) Computes the inverse cosine of a complex value.Complex128.add(Complex128 b) Sums two elements of this field (associative and commutative).static doubleComplex128.arg(Complex128 num) Computes the complex argument function for a complex number.static intComplex128.argmax(Complex128... values) Computes the index of the maximum magnitude from an array of complex numbers.static intComplex128.argmaxReal(Complex128... values) Computes the index of the minimum real component from an array of complex numbers.static intComplex128.argmin(Complex128... values) Computes the index of the minimum magnitude from an array of complex numbers.static intComplex128.argminReal(Complex128... values) Computes the index of the minimum real component from an array of complex numbers.static Complex128Complex128.asin(Complex128 num) Computes the inverse sine of a complex value.static Complex128Complex128.atan(Complex128 num) Computes the inverse tangent of a complex value.static doubleComplex128.atan2(Complex128 num) Computes the 2 argument arc-tangent function for a complex number.intComplex128.compareTo(Complex128 b) Compares this element of the field withb.static Complex128Complex128.cos(Complex128 num) Computes the trigonometric cosine value of a complex value.static Complex128Complex128.cosh(Complex128 num) Computes the hyperbolic cosine of a complex value.Complex128.div(Complex128 b) Computes the quotient of two elements of this field.static Complex128Complex128.exp(Complex128 exponent) Computes the exponential function with the given input.static intComplex128.length(Complex128 a) Gets the length of the string representation of this complex number.static Complex128Complex128.ln(Complex128 num) Computes the complex natural logarithm of a complex number.static Complex128Complex128.log(double base, Complex128 num) Computes the complex logarithm, with specified base, of a complex number.static Complex128Complex128.log(Complex128 num) Computes the complex logarithm base 10 of a complex number.static Complex128Complex128.log(Complex128 base, Complex128 num) Computes the complex logarithm, with specified base, of a complex number.static Complex128Complex128.max(Complex128... values) Computes the maximum magnitude from an array of complex numbers.static Complex128Complex128.maxRe(Complex128... values) Computes the minimum real component from an array of complex numbers.static Complex128Complex128.min(Complex128... values) Computes the minimum magnitude from an array of complex numbers.static Complex128Complex128.minRe(Complex128... values) Computes the minimum real component from an array of complex numbers.Complex128.mult(Complex128 b) Multiplies two elements of this field (associative and commutative).static booleanComplex128.nearZero(Complex128 n, double tol) Checks if a number is near zero in magnitude.static Complex128Complex128.pow(double a, Complex128 b) Compute a raised to the power ofb.static Complex128Complex128.pow(Complex128 a, double b) Computesaraised to the power ofb.static Complex128Complex128.pow(Complex128 a, Complex128 b) Compute a raised to the power of b.static Complex128Complex128.round(Complex128 n) Rounds both components of a complex number to the nearest respective integer.static Complex128Complex128.round(Complex128 n, int decimals) Rounds number to specified number of decimal places.static Complex128Complex128.roundToZero(Complex128 n, double tol) Rounds a complex numbers to zero if its magnitude within the specified tolerance from zero.static Complex128Complex128.sgn(Complex128 value) The complex signum function.static Complex128Complex128.sin(Complex128 num) Computes the trigonometric sine of a complex value.static Complex128Complex128.sinh(Complex128 num) Computes the hyperbolic sine of a complex value.Complex128.sub(Complex128 b) Computes difference of two elements of this field.static Complex128Complex128.sum(Complex128... numbers) Computes the sum of all data of specified array.static Complex128Complex128.tan(Complex128 num) Computes the trigonometric tangent value of a complex value.static Complex128Complex128.tanh(Complex128 num) Computes the hyperbolic tangent of a complex value. -
Uses of Complex128 in org.flag4j.rng
Methods in org.flag4j.rng that return Complex128Modifier and TypeMethodDescriptionRandomComplex.randnComplex128()Generates a pseudorandom complex number sampled from a 2D circular standard Gaussian (normal) distribution on the complex plain.RandomComplex.randnComplex128(double mean, double std) Generates a pseudorandom complex number sampled from a 2D circular Gaussian (normal) distribution on the complex plain.RandomComplex.randnComplex128(double meanRe, double stdRe, double meanIm, double stdIm) Generates a pseudorandom complex number sampled from a 2D elliptical Gaussian (normal) distribution on the complex plain.RandomComplex.randnComplex128(double meanRe, double stdRe, double meanIm, double stdIm, double corrCoeff) Generates a pseudorandom complex number sampled from a bivariate Gaussian (normal) distribution on the complex plain.RandomComplex.randomComplex128()Generates a pseudorandom complex number which is uniformly distributed on the unit disk within the complex plane.RandomComplex.randomComplex128(double mag) Generates pseudorandom complex number with specified magnitude which is uniformly distributed around the origin.RandomComplex.randomComplex128(double min, double max) Generates a pseudorandom complex number with magnitude in[min, max)which is uniformly distributed in the annulus (i.e. washer) with minimum and maximum radii equal tominandmaxrespectively.RandomComplex.randomRectComplex128()Generates a pseudorandom complex number distributed uniformly in the unit square on the complex plane centered at \( \left(0, 0\right) \).RandomComplex.randomRectComplex128(double minRe, double maxRe, double minIm, double maxIm) Generates a pseudorandom complex number distributed uniformly in a rectangle on the complex plane.Methods in org.flag4j.rng with parameters of type Complex128Modifier and TypeMethodDescriptionstatic voidRandomArray.randomFill(Complex128[] arr, Distribution<Complex128, RandomComplex> distribution) Fills an array with pseudorandom values sampled from the specifieddistribution.Method parameters in org.flag4j.rng with type arguments of type Complex128Modifier and TypeMethodDescriptionstatic voidRandomArray.randomFill(Complex128[] arr, Distribution<Complex128, RandomComplex> distribution) Fills an array with pseudorandom values sampled from the specifieddistribution. -
Uses of Complex128 in org.flag4j.rng.distributions
Subclasses with type arguments of type Complex128 in org.flag4j.rng.distributionsModifier and TypeClassDescriptionclassA 2D bivariate Gaussian distribution on the complex plane.classA uniform distribution over an annulus (i.e. washer) on the complex plane.classA rectangular uniform distribution on the complex plane.Methods in org.flag4j.rng.distributions that return Complex128Modifier and TypeMethodDescriptionComplex128BiGaussian.sample()Randomly samples this distribution.Complex128UniformDisk.sample()Randomly samples this complex annular uniform distribution centered at (Complex128UniformDisk.centerRe,Complex128UniformDisk.centerIm) with inner and outer radiusComplex128UniformDisk.minandComplex128UniformDisk.maxrespectively.Complex128UniformRect.sample()Randomly samples this complex rectangular uniform distribution. -
Uses of Complex128 in org.flag4j.util
Methods in org.flag4j.util that return Complex128Modifier and TypeMethodDescriptionstatic Complex128[]ArrayUtils.applyTransform(double[] src, Function<Double, Complex128> opp) Applies a transform to an array.static Complex128[]ArrayUtils.flatten(Complex128[][] src) Flattens a two-dimensional array.static Complex128[]ArrayConversions.toComplex128(double[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(int[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(Double[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(Integer[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(String[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(Complex64[] src, Complex128[] dest) Converts an array to an array ofcomplex numbers.Methods in org.flag4j.util that return types with arguments of type Complex128Modifier and TypeMethodDescriptionstatic ArrayList<Complex128> ArrayConversions.toArrayList(Complex128[] src) Converts an array of complex numbers to anarray list.static ArrayList<Complex128> ArrayConversions.toComplexArrayList(double[] src) Converts an array of doubles to a complexarray list.Methods in org.flag4j.util with parameters of type Complex128Modifier and TypeMethodDescriptionstatic double[]ArrayUtils.applyTransform(Complex128[] src, Function<Complex128, Double> opp) Applies a transform to an array.static voidArrayUtils.arraycopy(double[] src, int srcPos, Complex128[] dest, int destPos, int length) Performs an array copy similar toSystem.arraycopy(Object, int, Object, int, int)but wraps doubles as complex numbers.static booleanArrayUtils.equals(double[] src1, Complex128[] src2) Checks if a double array is numerically equal to acomplex numberarray.static voidArrayBuilder.fill(Complex128[] dest, double fillValue) Fills an array with specified value.static voidArrayBuilder.fill(Complex128[] dest, double fillValue, int from, int to) Fills range of an array with specified value.static voidArrayBuilder.fillZeros(Complex128[][] dest) Fills an array of complex numbers with zeros.static Complex128[]ArrayUtils.flatten(Complex128[][] src) Flattens a two-dimensional array.static voidArrayBuilder.stridedFillZeros(Complex128[] dest, int start, int stride) Fills an array with zeros separated by the given stride.static voidArrayBuilder.stridedFillZeros(Complex128[] dest, int start, int n, int stride) Fills an array with a range of zeros, each separated by the given stride.static ArrayList<Complex128> ArrayConversions.toArrayList(Complex128[] src) Converts an array of complex numbers to anarray list.static Complex128[]ArrayConversions.toComplex128(double[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(int[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(Double[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(Integer[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(String[] src, Complex128[] dest) Converts array to an array ofcomplex numbers.static Complex128[]ArrayConversions.toComplex128(Complex64[] src, Complex128[] dest) Converts an array to an array ofcomplex numbers.Method parameters in org.flag4j.util with type arguments of type Complex128Modifier and TypeMethodDescriptionstatic Complex128[]ArrayUtils.applyTransform(double[] src, Function<Double, Complex128> opp) Applies a transform to an array.static double[]ArrayUtils.applyTransform(Complex128[] src, Function<Complex128, Double> opp) Applies a transform to an array.