Uses of Class
com.imsl.math.Complex
Packages that use Complex
Package
Description
Utilities used by the library.
Mathematical functions and algorithms.
-
Uses of Complex in com.imsl
Modifier and TypeMethodDescriptionstatic doubleBLAS.abs1(Complex z) static doubleBLAS.asum(int n, Complex[] sx, int offset_sx, int incx) static voidBLAS.axpy(int n, Complex da, Complex[] dx, int dx_off, int incx, Complex[] dy, int dy_off, int incy) static voidstatic voidstatic Complexstatic Complexstatic Complexstatic Complexstatic voidBLAS.gemm(char transa, char transb, int m, int n, int k, Complex alpha, Complex[] a, int offset_a, int lda, Complex[] b, int offset_b, int ldb, Complex beta, Complex[] c, int offset_c, int ldc) static voidBLAS.gemv(char trans, int m, int n, Complex alpha, Complex[] a, int offset_a, int lda, Complex[] x, int offset_x, int incx, Complex beta, Complex[] y, int offset_y, int incy) static intBLAS.iamax(int n, Complex[] sx, int offset_sx, int incx) static voidstatic voidstatic voidstatic voidstatic voidBLAS.trsm(char side, char uplo, char transa, char diag, int m, int n, Complex alpha, Complex[] a, int offset_a, int lda, Complex[] b, int offset_b, int ldb) static voidBLAS.trsv(char uplo, char trans, char diag, int n, Complex[] a, int offset_a, int lda, Complex[] x, int offset_x, int incx) -
Uses of Complex in com.imsl.math
Fields in com.imsl.math declared as ComplexModifier and TypeFieldDescriptionprotected Complex[][]ComplexLU.factorThis is an n by nComplexmatrix containing the LU factorization of the matrix A.static final ComplexComplex.iThe imaginary unit.Complex[][]ComplexSparseMatrix.SparseArray.valuesJagged array containing sparse array values.Methods in com.imsl.math that return ComplexModifier and TypeMethodDescriptionstatic ComplexReturns the inverse cosine (arc cosine) of aComplex, with branch cuts outside the interval [-1,1] along the real axis.static Complex\( \DeclareMathOperator{\arccosh}{arccosh} \) Returns the inverse hyperbolic cosine (arc cosh) of aComplex, with a branch cut at values less than one along the real axis.static ComplexReturns the sum of adoubleand aComplex, x+y.static ComplexReturns the sum of aComplexand adouble, x+y.static ComplexReturns the sum of twoComplexobjects, x+y.static Complex[][]Add two rectangularComplexarrays, a + b.static Complex\( \DeclareMathOperator{\arcsinh}{arcsinh} \) Returns the inverse sine (arc sine) of aComplex, with branch cuts outside the interval [-1,1] along the real axis.static ComplexReturns the inverse hyperbolic sine (arc sinh) of aComplex, with branch cuts outside the interval [-i,i].static Complex\( \DeclareMathOperator{\arctanh}{arctanh} \) Returns the inverse tangent (arc tangent) of aComplex, with branch cuts outside the interval [-i,i] along the imaginary axis.static ComplexReturns the inverse hyperbolic tangent (arc tanh) of aComplex, with branch cuts outside the interval [-1,1] on the real axis.Complex[]Compute the complex periodic sequence from its Fourier coefficients.Complex[]ZeroPolynomial.computeRoots(double[] coef) Computes the roots of the polynomial with real coefficients.Complex[]ZeroPolynomial.computeRoots(Complex[] coef) Computes the roots of the polynomial with Complex coefficients.static ComplexReturns the complex conjugate of aComplexobject.static ComplexReturns the cosine of aComplex.static ComplexReturns the hyperbolic cosh of aComplex.ComplexLU.determinant()Return the determinant of the matrix used to construct this instance.static ComplexReturns the result of adoubledivided by aComplexobject, x/y.static ComplexReturns the result of aComplexobject divided by adouble, x/y.static ComplexReturns the result of aComplexobject divided by aComplexobject, x/y.static ComplexReturns the exponential of aComplexz, exp(z).Complex[]Compute the Fourier coefficients of a complex periodic sequence.ComplexSparseMatrix.get(int iRow, int jColumn) Returns the value of an element in the matrix.Complex[][]ComplexSVD.getInverse()Compute the Moore-Penrose generalized inverse.Complex[][]ComplexLU.getL()Returns the lower triangular portion of the LU factorization of A.Complex[][]ComplexLU.getPermutationMatrix()Returns the permutation matrix which results from the LU factorization of A.ZeroPolynomial.getRoot(int index) Returns a zero of the polynomial.Complex[]ZeroPolynomial.getRoots()Returns the zeros of the polynomial.Complex[][]ComplexLU.getU()Returns the unit upper triangular portion of the LU factorization of A.Complex[][]ComplexSVD.getU()Returns the left singular vectors.Complex[][]ComplexSVD.getV()Returns the right singular vectors.Complex[]ComplexEigen.getValues()Returns the eigenvalues of a matrix of typeComplex.Complex[]Eigen.getValues()Returns the eigenvalues of a matrix of typedouble.Complex[][]ComplexEigen.getVectors()Returns the eigenvectors of the input matrix.Complex[][]Eigen.getVectors()Returns the eigenvectors.Complex[][]ComplexLU.inverse()Returns the inverse of the matrix used to construct this instance.static ComplexReturns the logarithm of aComplexz, with a branch cut along the negative real axis.static ComplexReturns the product of adoubleand aComplexobject, x * y.static ComplexReturns the product of aComplexobject and adouble, x * y.static ComplexReturns the product of twoComplexobjects, x * y.static Complex[]Multiply the rectangular array a and the column vector x, bothComplex.static Complex[][]Multiply twoComplexrectangular arrays, a * b.static Complex[][]Multiply twoComplexrectangular arrays,a*b, using multiplejava.lang.Threads.static Complex[]ComplexMatrix.multiply(Complex[][] a, ComplexMatrix.MatrixType aType, Complex[] x) Multiply the rectangular array a and the column vector x, bothComplex.static Complex[][]ComplexMatrix.multiply(Complex[][] a, ComplexMatrix.MatrixType aType, Complex[][] b, ComplexMatrix.MatrixType bType, int numberOfThreads) Multiply twoComplexrectangular arrays of typeMatrixType,a*b, using multiplejava.lang.Threads.static Complex[]Return the product of the row vector x and the rectangular array a, bothComplex.static Complex[]ComplexMatrix.multiply(Complex[] x, Complex[][] a, ComplexMatrix.MatrixType aType) Return the product of the row vector x and the rectangular array a, bothComplex.static ComplexComplexMatrix.multiply(Complex[] x, Complex[][] a, ComplexMatrix.MatrixType aType, Complex[] y, boolean equalVectors) Compute vector-matrix-vector product trans(conj(x)) * a * y.Complex[]Multiply the matrix by a vector.static Complex[]ComplexSparseMatrix.multiply(Complex[] x, ComplexSparseMatrix A) Multiply row arrayxand sparse matrixA, \(x^TA \).static Complex[]ComplexSparseMatrix.multiply(ComplexSparseMatrix A, Complex[] x) Multiply sparse matrixAand column arrayx, \(A x\).static Complex[]ComplexSparseMatrix.multiplyHermitian(ComplexSparseMatrix A, Complex[] x) Multiply sparse Hermitian matrixAand column vectorx.static ComplexComplex.multiplyImag(double x, Complex y) Returns the product of a pure imaginarydoubleand aComplexobject, ix * y.static ComplexComplex.multiplyImag(Complex x, double y) Returns the product of aComplexobject and a pure imaginarydouble, x * iy.static ComplexReturns the negative of aComplexobject, -z.ComplexSparseMatrix.plusEquals(int iRow, int jColumn, Complex x) Adds a value to an element in the matrix.static ComplexReturns theComplexz raised to the x power, with a branch cut for the first parameter (z) along the negative real axis.static ComplexReturns theComplexx raised to theComplexy power.static ComplexReturns the sine of aComplex.static ComplexReturns the hyperbolic sine of aComplex.Complex[]Return the solution x of the linear system Ax = b using the LU factorization of A.static Complex[]Solve Ax = b for x using the LU factorization of A.Complex[]Computes the solution of a sparse Hermitian positive definite system of linear equations \(Ax=b\).Complex[]Computation of the solution vector for the system \( Ax = b\).Complex[]ComplexSuperLU.solveConjugateTranspose(Complex[] b) Computation of the solution vector for the system \( A^Hx = b\).Complex[]ComplexLU.solveTranspose(Complex[] b) Return the solution x of the linear system \(A^T x = b\).Complex[]ComplexSuperLU.solveTranspose(Complex[] b) Computation of the solution vector for the system \( A^Tx = b\).static ComplexReturns the square root of aComplex, with a branch cut along the negative real axis.static ComplexReturns the difference of adoubleand aComplexobject, x-y.static ComplexReturns the difference of aComplexobject and adouble, x-y.static ComplexReturns the difference of twoComplexobjects, x-y.static Complex[][]Subtract twoComplexrectangular arrays, a - b.static ComplexReturns the tangent of aComplex.static ComplexReturns the hyperbolic tanh of aComplex.Complex[][]ComplexSparseMatrix.toDenseMatrix()Returns the sparse matrix as a dense matrix.static Complex[][]Return the transpose of aComplexmatrix.static ComplexParses aStringinto aComplex.Methods in com.imsl.math with parameters of type ComplexModifier and TypeMethodDescriptionstatic doubleReturns the absolute value (modulus) of aComplex, |z|.static ComplexReturns the inverse cosine (arc cosine) of aComplex, with branch cuts outside the interval [-1,1] along the real axis.static Complex\( \DeclareMathOperator{\arccosh}{arccosh} \) Returns the inverse hyperbolic cosine (arc cosh) of aComplex, with a branch cut at values less than one along the real axis.static ComplexReturns the sum of adoubleand aComplex, x+y.static ComplexReturns the sum of aComplexand adouble, x+y.static ComplexReturns the sum of twoComplexobjects, x+y.static Complex[][]Add two rectangularComplexarrays, a + b.static ComplexSparseMatrixComplexSparseMatrix.add(Complex alpha, Complex beta, ComplexSparseMatrix A, ComplexSparseMatrix B) Performs element-wise addition of two complex sparse matricesA,Bof typeComplexSparseMatrix, \(C \leftarrow \alpha A + \beta B.\)static doubleReturns the argument (phase) of aComplex, in radians, with a branch cut along the negative real axis.static Complex\( \DeclareMathOperator{\arcsinh}{arcsinh} \) Returns the inverse sine (arc sine) of aComplex, with branch cuts outside the interval [-1,1] along the real axis.static ComplexReturns the inverse hyperbolic sine (arc sinh) of aComplex, with branch cuts outside the interval [-i,i].static Complex\( \DeclareMathOperator{\arctanh}{arctanh} \) Returns the inverse tangent (arc tangent) of aComplex, with branch cuts outside the interval [-i,i] along the imaginary axis.static ComplexReturns the inverse hyperbolic tangent (arc tanh) of aComplex, with branch cuts outside the interval [-1,1] on the real axis.Complex[]Compute the complex periodic sequence from its Fourier coefficients.static voidComplexMatrix.checkMatrix(Complex[][] a) Check that all of the rows in theComplexmatrix have the same length.static voidComplexMatrix.CheckMatrix(Complex[][] a) Deprecated.static voidComplexMatrix.checkSquareMatrix(Complex[][] a) Check that theComplexmatrix is square.static voidComplexMatrix.CheckSquareMatrix(Complex[][] a) Deprecated.UseComplexMatrix.checkSquareMatrix(Complex[][])instead.intCompares twoComplexobjects.Complex[]ZeroPolynomial.computeRoots(Complex[] coef) Computes the roots of the polynomial with Complex coefficients.doubleReturn an estimate of the reciprocal of the \(L_1\) condition number.static ComplexReturns the complex conjugate of aComplexobject.static ComplexReturns the cosine of aComplex.static ComplexReturns the hyperbolic cosh of aComplex.static ComplexReturns the result of adoubledivided by aComplexobject, x/y.static ComplexReturns the result of aComplexobject divided by adouble, x/y.static ComplexReturns the result of aComplexobject divided by aComplexobject, x/y.booleanCompares with anotherComplex.static ComplexReturns the exponential of aComplexz, exp(z).Complex[]Compute the Fourier coefficients of a complex periodic sequence.static doubleComplexMatrix.frobeniusNorm(Complex[][] a) Return the Frobenius norm of aComplexmatrix.static doubleReturns the imaginary part of aComplexobject.static doubleComplexMatrix.infinityNorm(Complex[][] a) Return the infinity norm of aComplexmatrix.static booleanComplexMatrix.isHermitian(Complex[][] a) Check if theComplexmatrix is Hermitian.static booleanComplexMatrix.isSymmetric(Complex[][] a) Check if theComplexmatrix is symmetric.static ComplexReturns the logarithm of aComplexz, with a branch cut along the negative real axis.static ComplexReturns the product of adoubleand aComplexobject, x * y.static ComplexReturns the product of aComplexobject and adouble, x * y.static ComplexReturns the product of twoComplexobjects, x * y.static Complex[]Multiply the rectangular array a and the column vector x, bothComplex.static Complex[][]Multiply twoComplexrectangular arrays, a * b.static Complex[][]Multiply twoComplexrectangular arrays,a*b, using multiplejava.lang.Threads.static Complex[]ComplexMatrix.multiply(Complex[][] a, ComplexMatrix.MatrixType aType, Complex[] x) Multiply the rectangular array a and the column vector x, bothComplex.static Complex[][]ComplexMatrix.multiply(Complex[][] a, ComplexMatrix.MatrixType aType, Complex[][] b, ComplexMatrix.MatrixType bType, int numberOfThreads) Multiply twoComplexrectangular arrays of typeMatrixType,a*b, using multiplejava.lang.Threads.static Complex[]Return the product of the row vector x and the rectangular array a, bothComplex.static Complex[]ComplexMatrix.multiply(Complex[] x, Complex[][] a, ComplexMatrix.MatrixType aType) Return the product of the row vector x and the rectangular array a, bothComplex.static ComplexComplexMatrix.multiply(Complex[] x, Complex[][] a, ComplexMatrix.MatrixType aType, Complex[] y, boolean equalVectors) Compute vector-matrix-vector product trans(conj(x)) * a * y.Complex[]Multiply the matrix by a vector.static Complex[]ComplexSparseMatrix.multiply(Complex[] x, ComplexSparseMatrix A) Multiply row arrayxand sparse matrixA, \(x^TA \).static Complex[]ComplexSparseMatrix.multiply(ComplexSparseMatrix A, Complex[] x) Multiply sparse matrixAand column arrayx, \(A x\).static Complex[]ComplexSparseMatrix.multiplyHermitian(ComplexSparseMatrix A, Complex[] x) Multiply sparse Hermitian matrixAand column vectorx.static ComplexComplex.multiplyImag(double x, Complex y) Returns the product of a pure imaginarydoubleand aComplexobject, ix * y.static ComplexComplex.multiplyImag(Complex x, double y) Returns the product of aComplexobject and a pure imaginarydouble, x * iy.static ComplexReturns the negative of aComplexobject, -z.static doubleReturn theComplexmatrix one norm.ComplexSparseMatrix.plusEquals(int iRow, int jColumn, Complex x) Adds a value to an element in the matrix.static ComplexReturns theComplexz raised to the x power, with a branch cut for the first parameter (z) along the negative real axis.static ComplexReturns theComplexx raised to theComplexy power.static doubleReturns the real part of aComplexobject.voidSets the value of an element in the matrix.static ComplexReturns the sine of aComplex.static ComplexReturns the hyperbolic sine of aComplex.Complex[]Return the solution x of the linear system Ax = b using the LU factorization of A.static Complex[]Solve Ax = b for x using the LU factorization of A.Complex[]Computes the solution of a sparse Hermitian positive definite system of linear equations \(Ax=b\).Complex[]Computation of the solution vector for the system \( Ax = b\).Complex[]ComplexSuperLU.solveConjugateTranspose(Complex[] b) Computation of the solution vector for the system \( A^Hx = b\).Complex[]ComplexLU.solveTranspose(Complex[] b) Return the solution x of the linear system \(A^T x = b\).Complex[]ComplexSuperLU.solveTranspose(Complex[] b) Computation of the solution vector for the system \( A^Tx = b\).static ComplexReturns the square root of aComplex, with a branch cut along the negative real axis.static ComplexReturns the difference of adoubleand aComplexobject, x-y.static ComplexReturns the difference of aComplexobject and adouble, x-y.static ComplexReturns the difference of twoComplexobjects, x-y.static Complex[][]Subtract twoComplexrectangular arrays, a - b.static ComplexReturns the tangent of aComplex.static ComplexReturns the hyperbolic tanh of aComplex.static Complex[][]Return the transpose of aComplexmatrix.Constructors in com.imsl.math with parameters of type ComplexModifierConstructorDescriptionConstructs aComplexequal to the argument.ComplexEigen(Complex[][] a) Constructor for the computation of the eigenvalues and eigenvectors of a complex square matrix.Creates the LU factorization of a square matrix of typeComplex.ComplexSparseMatrix(int nRows, int nColumns, int[][] index, Complex[][] values) Constructs a sparse matrix from SparseArray (Java Sparse Array) data.ComplexSVD(Complex[][] a) Construct the singular value decomposition of a rectangular matrix with default tolerance.ComplexSVD(Complex[][] a, double tol) Construct the singular value decomposition of a rectangular matrix with a given tolerance.
ComplexMatrix.checkMatrix(Complex[][])instead.