Skip to content

Commit 66debc4

Browse files
committed
Replace Adjoint/Transpose with adjoint/transpose in SuiteSparse.
1 parent 8bca56a commit 66debc4

File tree

8 files changed

+67
-69
lines changed

8 files changed

+67
-69
lines changed

stdlib/SuiteSparse/src/cholmod.jl

Lines changed: 8 additions & 8 deletions
Original file line numberDiff line numberDiff line change
@@ -7,8 +7,7 @@ import Base: (*), convert, copy, eltype, getindex, getproperty, show, size,
77

88
import Base.LinAlg: (\),
99
cholfact, cholfact!, det, diag, ishermitian, isposdef,
10-
issuccess, issymmetric, ldltfact, ldltfact!, logdet,
11-
Adjoint, Transpose
10+
issuccess, issymmetric, ldltfact, ldltfact!, logdet
1211

1312
using ..SparseArrays
1413
using Base.Printf.@printf
@@ -348,6 +347,7 @@ Factor(ptr::Ptr{C_Factor{Tv}}) where {Tv<:VTypes} = Factor{Tv}(ptr)
348347
Factor(x::Factor) = x
349348

350349
Base.LinAlg.adjoint(F::Factor) = Adjoint(F)
350+
Base.LinAlg.transpose(F::Factor) = Transpose(F)
351351

352352
# All pointer loads should be checked to make sure that SuiteSparse is not called with
353353
# a C_NULL pointer which could cause a segfault. Pointers are set to null
@@ -1321,7 +1321,7 @@ function *(adjA::Adjoint{<:Any,<:Sparse}, B::Sparse)
13211321
A = adjA.parent
13221322
aa1 = transpose_(A, 2)
13231323
if A === B
1324-
return *(aa1, Adjoint(aa1))
1324+
return *(aa1, adjoint(aa1))
13251325
end
13261326
## result of ssmult will have stype==0, contain numerical values and be sorted
13271327
return ssmult(aa1, B, 0, true, true)
@@ -1330,7 +1330,7 @@ end
13301330
*(adjA::Adjoint{<:Any,<:Sparse}, B::Dense) =
13311331
(A = adjA.parent; sdmult!(A, true, 1., 0., B, zeros(size(A, 2), size(B, 2))))
13321332
*(adjA::Adjoint{<:Any,<:Sparse}, B::VecOrMat) =
1333-
(A = adjA.parent; *(Adjoint(A), Dense(B)))
1333+
(A = adjA.parent; *(adjoint(A), Dense(B)))
13341334

13351335

13361336
## Factorization methods
@@ -1697,7 +1697,7 @@ end
16971697
\(adjL::Adjoint{<:Any,<:Factor}, B::Dense) = (L = adjL.parent; solve(CHOLMOD_A, L, B))
16981698
\(adjL::Adjoint{<:Any,<:Factor}, B::VecOrMat) = (L = adjL.parent; Matrix(solve(CHOLMOD_A, L, Dense(B))))
16991699
\(adjL::Adjoint{<:Any,<:Factor}, B::Sparse) = (L = adjL.parent; spsolve(CHOLMOD_A, L, B))
1700-
\(adjL::Adjoint{<:Any,<:Factor}, B::SparseVecOrMat) = (L = adjL.parent; \(Adjoint(L), Sparse(B)))
1700+
\(adjL::Adjoint{<:Any,<:Factor}, B::SparseVecOrMat) = (L = adjL.parent; \(adjoint(L), Sparse(B)))
17011701

17021702
const RealHermSymComplexHermF64SSL = Union{
17031703
Symmetric{Float64,SparseMatrixCSC{Float64,SuiteSparse_long}},
@@ -1720,13 +1720,13 @@ function \(adjA::Adjoint{<:Any,<:RealHermSymComplexHermF64SSL}, B::StridedVecOrM
17201720
A = adjA.parent
17211721
F = cholfact(A)
17221722
if issuccess(F)
1723-
return \(Adjoint(F), B)
1723+
return \(adjoint(F), B)
17241724
else
17251725
ldltfact!(F, A)
17261726
if issuccess(F)
1727-
return \(Adjoint(F), B)
1727+
return \(adjoint(F), B)
17281728
else
1729-
return \(Adjoint(lufact(SparseMatrixCSC{eltype(A), SuiteSparse_long}(A))), B)
1729+
return \(adjoint(lufact(SparseMatrixCSC{eltype(A), SuiteSparse_long}(A))), B)
17301730
end
17311731
end
17321732
end

stdlib/SuiteSparse/src/deprecated.jl

Lines changed: 21 additions & 22 deletions
Original file line numberDiff line numberDiff line change
@@ -2,18 +2,17 @@
22

33
# A[ct]_(mul|ldiv|rdiv)_B[ct][!] methods from src/cholmod.jl, to deprecate
44
@eval SuiteSparse.CHOLMOD begin
5-
using Base.LinAlg: Adjoint, Transpose
6-
Base.Ac_ldiv_B(A::RealHermSymComplexHermF64SSL, B::StridedVecOrMat) = \(Adjoint(A), B)
7-
Base.Ac_ldiv_B(L::Factor, B::Dense) = \(Adjoint(L), B)
8-
Base.Ac_ldiv_B(L::Factor, B::VecOrMat) = \(Adjoint(L), B)
9-
Base.Ac_ldiv_B(L::Factor, B::Sparse) = \(Adjoint(L), B)
10-
Base.Ac_ldiv_B(L::Factor, B::SparseVecOrMat) = \(Adjoint(L), B)
11-
Base.Ac_ldiv_B(L::FactorComponent, B) = \(Adjoint(L), B)
12-
Base.Ac_ldiv_B(L::FactorComponent, B::RowVector) = \(Adjoint(L), B)
13-
Base.Ac_mul_B(A::Sparse, B::Dense) = *(Adjoint(A), B)
14-
Base.Ac_mul_B(A::Sparse, B::VecOrMat) = *(Adjoint(A), B)
15-
Base.Ac_mul_B(A::Sparse, B::Sparse) = *(Adjoint(A), B)
16-
Base.A_mul_Bc(A::Sparse{Tv}, B::Sparse{Tv}) where {Tv<:VRealTypes} = *(A, Adjoint(B))
5+
Base.Ac_ldiv_B(A::RealHermSymComplexHermF64SSL, B::StridedVecOrMat) = \(adjoint(A), B)
6+
Base.Ac_ldiv_B(L::Factor, B::Dense) = \(adjoint(L), B)
7+
Base.Ac_ldiv_B(L::Factor, B::VecOrMat) = \(adjoint(L), B)
8+
Base.Ac_ldiv_B(L::Factor, B::Sparse) = \(adjoint(L), B)
9+
Base.Ac_ldiv_B(L::Factor, B::SparseVecOrMat) = \(adjoint(L), B)
10+
Base.Ac_ldiv_B(L::FactorComponent, B) = \(adjoint(L), B)
11+
Base.Ac_ldiv_B(L::FactorComponent, B::RowVector) = \(adjoint(L), B)
12+
Base.Ac_mul_B(A::Sparse, B::Dense) = *(adjoint(A), B)
13+
Base.Ac_mul_B(A::Sparse, B::VecOrMat) = *(adjoint(A), B)
14+
Base.Ac_mul_B(A::Sparse, B::Sparse) = *(adjoint(A), B)
15+
Base.A_mul_Bc(A::Sparse{Tv}, B::Sparse{Tv}) where {Tv<:VRealTypes} = *(A, adjoint(B))
1716
end
1817

1918
# A[ct]_(mul|ldiv|rdiv)_B[ct][!] methods from src/umfpack.jl, to deprecate
@@ -22,28 +21,28 @@ end
2221
Base.A_ldiv_B!(X::StridedVecOrMat{T}, lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} =
2322
Base.LinAlg.ldiv!(X, lu, B)
2423
Base.At_ldiv_B!(X::StridedVecOrMat{T}, lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} =
25-
Base.LinAlg.ldiv!(X, Transpose(lu), B)
24+
Base.LinAlg.ldiv!(X, transpose(lu), B)
2625
Base.Ac_ldiv_B!(X::StridedVecOrMat{T}, lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} =
27-
Base.LinAlg.ldiv!(X, Adjoint(lu), B)
26+
Base.LinAlg.ldiv!(X, adjoint(lu), B)
2827
Base.A_ldiv_B!(X::StridedVecOrMat{Tb}, lu::UmfpackLU{Float64}, B::StridedVecOrMat{Tb}) where {Tb<:Complex} =
2928
Base.LinAlg.ldiv!(X, lu, B)
3029
Base.At_ldiv_B!(X::StridedVecOrMat{Tb}, lu::UmfpackLU{Float64}, B::StridedVecOrMat{Tb}) where {Tb<:Complex} =
31-
Base.LinAlg.ldiv!(X, Transpose(lu), B)
30+
Base.LinAlg.ldiv!(X, transpose(lu), B)
3231
Base.Ac_ldiv_B!(X::StridedVecOrMat{Tb}, lu::UmfpackLU{Float64}, B::StridedVecOrMat{Tb}) where {Tb<:Complex} =
33-
Base.LinAlg.ldiv!(X, Adjoint(lu), B)
32+
Base.LinAlg.ldiv!(X, adjoint(lu), B)
3433
Base.A_ldiv_B!(lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} = Base.LinAlg.ldiv!(lu, B)
35-
Base.At_ldiv_B!(lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} = Base.LinAlg.ldiv!(Transpose(lu), B)
36-
Base.Ac_ldiv_B!(lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} = Base.LinAlg.ldiv!(Adjoint(lu), B)
34+
Base.At_ldiv_B!(lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} = Base.LinAlg.ldiv!(transpose(lu), B)
35+
Base.Ac_ldiv_B!(lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} = Base.LinAlg.ldiv!(adjoint(lu), B)
3736
Base.A_ldiv_B!(lu::UmfpackLU{Float64}, B::StridedVecOrMat{<:Complex}) = Base.LinAlg.ldiv!(lu, B)
38-
Base.At_ldiv_B!(lu::UmfpackLU{Float64}, B::StridedVecOrMat{<:Complex}) = Base.LinAlg.ldiv!(Transpose(lu), B)
39-
Base.Ac_ldiv_B!(lu::UmfpackLU{Float64}, B::StridedVecOrMat{<:Complex}) = Base.LinAlg.ldiv!(Adjoint(lu), B)
37+
Base.At_ldiv_B!(lu::UmfpackLU{Float64}, B::StridedVecOrMat{<:Complex}) = Base.LinAlg.ldiv!(transpose(lu), B)
38+
Base.Ac_ldiv_B!(lu::UmfpackLU{Float64}, B::StridedVecOrMat{<:Complex}) = Base.LinAlg.ldiv!(adjoint(lu), B)
4039
end
4140

4241
# A[ct]_(mul|ldiv|rdiv)_B[ct][!] methods from src/spqr.jl, to deprecate
4342
@eval SuiteSparse.SPQR begin
4443
using Base.LinAlg: Adjoint, Transpose
45-
Base.A_mul_Bc!(A::StridedMatrix, Q::QRSparseQ) = Base.LinAlg.mul!(A, Adjoint(Q))
46-
Base.Ac_mul_B!(Q::QRSparseQ, A::StridedVecOrMat) = Base.LinAlg.mul!(Adjoint(Q), A)
44+
Base.A_mul_Bc!(A::StridedMatrix, Q::QRSparseQ) = Base.LinAlg.mul!(A, adjoint(Q))
45+
Base.Ac_mul_B!(Q::QRSparseQ, A::StridedVecOrMat) = Base.LinAlg.mul!(adjoint(Q), A)
4746
Base.A_mul_B!(A::StridedMatrix, Q::QRSparseQ) = Base.LinAlg.mul!(A, Q)
4847
Base.A_mul_B!(Q::QRSparseQ, A::StridedVecOrMat) = Base.LinAlg.mul!(Q, A)
4948
end

stdlib/SuiteSparse/src/spqr.jl

Lines changed: 3 additions & 4 deletions
Original file line numberDiff line numberDiff line change
@@ -3,7 +3,6 @@
33
module SPQR
44

55
import Base: \
6-
using Base.LinAlg: Adjoint, Transpose
76

87
# ordering options */
98
const ORDERING_FIXED = Int32(0)
@@ -340,14 +339,14 @@ function (\)(F::QRSparse{Float64}, B::VecOrMat{Complex{Float64}})
340339
# |z2|z4| -> |y1|y2|y3|y4| -> |x2|y2| -> |x2|y2|x4|y4|
341340
# |x3|y3|
342341
# |x4|y4|
343-
c2r = reshape(copy(Transpose(reinterpret(Float64, reshape(B, (1, length(B)))))), size(B, 1), 2*size(B, 2))
342+
c2r = reshape(copy(transpose(reinterpret(Float64, reshape(B, (1, length(B)))))), size(B, 1), 2*size(B, 2))
344343
x = F\c2r
345344

346345
# |z1|z3| reinterpret |x1|x2|x3|x4| transpose |x1|y1| reshape |x1|y1|x3|y3|
347346
# |z2|z4| <- |y1|y2|y3|y4| <- |x2|y2| <- |x2|y2|x4|y4|
348347
# |x3|y3|
349348
# |x4|y4|
350-
return collect(reshape(reinterpret(Complex{Float64}, copy(Transpose(reshape(x, (length(x) >> 1), 2)))), _ret_size(F, B)))
349+
return collect(reshape(reinterpret(Complex{Float64}, copy(transpose(reshape(x, (length(x) >> 1), 2)))), _ret_size(F, B)))
351350
end
352351

353352
function _ldiv_basic(F::QRSparse, B::StridedVecOrMat)
@@ -375,7 +374,7 @@ function _ldiv_basic(F::QRSparse, B::StridedVecOrMat)
375374
X0 = view(X, 1:size(B, 1), :)
376375

377376
# Apply Q' to B
378-
Base.LinAlg.mul!(Adjoint(F.Q), X0)
377+
Base.LinAlg.mul!(adjoint(F.Q), X0)
379378

380379
# Zero out to get basic solution
381380
X[rnk + 1:end, :] = 0

stdlib/SuiteSparse/src/umfpack.jl

Lines changed: 6 additions & 6 deletions
Original file line numberDiff line numberDiff line change
@@ -347,7 +347,7 @@ for itype in UmfpackIndexTypes
347347
Up,Ui,Ux,
348348
P, Q, C_NULL,
349349
0, Rs, lu.numeric)
350-
(copy(Transpose(SparseMatrixCSC(min(n_row, n_col), n_row, increment!(Lp), increment!(Lj), Lx))),
350+
(copy(transpose(SparseMatrixCSC(min(n_row, n_col), n_row, increment!(Lp), increment!(Lj), Lx))),
351351
SparseMatrixCSC(min(n_row, n_col), n_col, increment!(Up), increment!(Ui), Ux),
352352
increment!(P), increment!(Q), Rs)
353353
end
@@ -374,7 +374,7 @@ for itype in UmfpackIndexTypes
374374
Up,Ui,Ux,Uz,
375375
P, Q, C_NULL, C_NULL,
376376
0, Rs, lu.numeric)
377-
(copy(Transpose(SparseMatrixCSC(min(n_row, n_col), n_row, increment!(Lp), increment!(Lj), complex.(Lx, Lz)))),
377+
(copy(transpose(SparseMatrixCSC(min(n_row, n_col), n_row, increment!(Lp), increment!(Lj), complex.(Lx, Lz)))),
378378
SparseMatrixCSC(min(n_row, n_col), n_col, increment!(Up), increment!(Ui), complex.(Ux, Uz)),
379379
increment!(P), increment!(Q), Rs)
380380
end
@@ -390,15 +390,15 @@ end
390390
ldiv!(lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} =
391391
ldiv!(B, lu, copy(B))
392392
ldiv!(translu::Transpose{T,<:UmfpackLU{T}}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} =
393-
(lu = translu.parent; ldiv!(B, Transpose(lu), copy(B)))
393+
(lu = translu.parent; ldiv!(B, transpose(lu), copy(B)))
394394
ldiv!(adjlu::Adjoint{T,<:UmfpackLU{T}}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} =
395-
(lu = adjlu.parent; ldiv!(B, Adjoint(lu), copy(B)))
395+
(lu = adjlu.parent; ldiv!(B, adjoint(lu), copy(B)))
396396
ldiv!(lu::UmfpackLU{Float64}, B::StridedVecOrMat{<:Complex}) =
397397
ldiv!(B, lu, copy(B))
398398
ldiv!(translu::Transpose{Float64,<:UmfpackLU{Float64}}, B::StridedVecOrMat{<:Complex}) =
399-
(lu = translu.parent; ldiv!(B, Transpose(lu), copy(B)))
399+
(lu = translu.parent; ldiv!(B, transpose(lu), copy(B)))
400400
ldiv!(adjlu::Adjoint{Float64,<:UmfpackLU{Float64}}, B::StridedVecOrMat{<:Complex}) =
401-
(lu = adjlu.parent; ldiv!(B, Adjoint(lu), copy(B)))
401+
(lu = adjlu.parent; ldiv!(B, adjoint(lu), copy(B)))
402402

403403
ldiv!(X::StridedVecOrMat{T}, lu::UmfpackLU{T}, B::StridedVecOrMat{T}) where {T<:UMFVTypes} =
404404
_Aq_ldiv_B!(X, lu, B, UMFPACK_A)

stdlib/SuiteSparse/src/umfpack_h.jl

Lines changed: 12 additions & 12 deletions
Original file line numberDiff line numberDiff line change
@@ -4,20 +4,20 @@
44

55
## Type of solve
66
const UMFPACK_A = 0 # Ax=b
7-
const UMFPACK_At = 1 # Adjoint(A)x=b
8-
const UMFPACK_Aat = 2 # Transpose(A)x=b
9-
const UMFPACK_Pt_L = 3 # Adjoint(P)Lx=b
7+
const UMFPACK_At = 1 # adjoint(A)x=b
8+
const UMFPACK_Aat = 2 # transpose(A)x=b
9+
const UMFPACK_Pt_L = 3 # adjoint(P)Lx=b
1010
const UMFPACK_L = 4 # Lx=b
11-
const UMFPACK_Lt_P = 5 # Adjoint(L)Px=b
12-
const UMFPACK_Lat_P = 6 # Transpose(L)Px=b
13-
const UMFPACK_Lt = 7 # Adjoint(L)x=b
14-
const UMFPACK_Lat = 8 # Transpose(L)x=b
15-
const UMFPACK_U_Qt = 9 # U*Adjoint(Q)x=b
11+
const UMFPACK_Lt_P = 5 # adjoint(L)Px=b
12+
const UMFPACK_Lat_P = 6 # transpose(L)Px=b
13+
const UMFPACK_Lt = 7 # adjoint(L)x=b
14+
const UMFPACK_Lat = 8 # transpose(L)x=b
15+
const UMFPACK_U_Qt = 9 # U*adjoint(Q)x=b
1616
const UMFPACK_U = 10 # Ux=b
17-
const UMFPACK_Q_Ut = 11 # Q*Adjoint(U)x=b
18-
const UMFPACK_Q_Uat = 12 # Q*Transpose(U)x=b
19-
const UMFPACK_Ut = 13 # Adjoint(U)x=b
20-
const UMFPACK_Uat = 14 # Transpose(U)x=b
17+
const UMFPACK_Q_Ut = 11 # Q*adjoint(U)x=b
18+
const UMFPACK_Q_Uat = 12 # Q*transpose(U)x=b
19+
const UMFPACK_Ut = 13 # adjoint(U)x=b
20+
const UMFPACK_Uat = 14 # transpose(U)x=b
2121

2222
## Sizes of Control and Info arrays for returning information from solver
2323
const UMFPACK_INFO = 90

stdlib/SuiteSparse/test/cholmod.jl

Lines changed: 4 additions & 4 deletions
Original file line numberDiff line numberDiff line change
@@ -396,7 +396,7 @@ end
396396
bT = fill(elty(1), 5)
397397
@test F'\bT Array(A1pd)'\b
398398
@test F'\sparse(bT) Array(A1pd)'\b
399-
@test Transpose(F)\bT conj(A1pd)'\bT
399+
@test transpose(F)\bT conj(A1pd)'\bT
400400
@test F\CHOLMOD.Sparse(sparse(bT)) A1pd\b
401401
@test logdet(F) logdet(Array(A1pd))
402402
@test det(F) == exp(logdet(F))
@@ -713,8 +713,8 @@ end
713713
@test Fs\fill(1., 4) Fd\fill(1., 4)
714714
end
715715

716-
@testset "\\ '\\ and Transpose(...)\\" begin
717-
# Test that \ and '\ and Transpose(...)\ work for Symmetric and Hermitian. This is just
716+
@testset "\\ '\\ and transpose(...)\\" begin
717+
# Test that \ and '\ and transpose(...)\ work for Symmetric and Hermitian. This is just
718718
# a dispatch exercise so it doesn't matter that the complex matrix has
719719
# zero imaginary parts
720720
Apre = sprandn(10, 10, 0.2) - I
@@ -725,7 +725,7 @@ end
725725
x = fill(1., 10)
726726
b = A*x
727727
@test x A\b
728-
@test Transpose(A)\b A'\b
728+
@test transpose(A)\b A'\b
729729
end
730730
end
731731

stdlib/SuiteSparse/test/spqr.jl

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -44,9 +44,9 @@ nn = 100
4444

4545
offsizeA = Matrix{Float64}(I, m+1, m+1)
4646
@test_throws DimensionMismatch mul!(Q, offsizeA)
47-
@test_throws DimensionMismatch mul!(Adjoint(Q), offsizeA)
47+
@test_throws DimensionMismatch mul!(adjoint(Q), offsizeA)
4848
@test_throws DimensionMismatch mul!(offsizeA, Q)
49-
@test_throws DimensionMismatch mul!(offsizeA, Adjoint(Q))
49+
@test_throws DimensionMismatch mul!(offsizeA, adjoint(Q))
5050
end
5151

5252
@testset "element type of B: $eltyB" for eltyB in (Int, Float64, Complex{Float64})

stdlib/SuiteSparse/test/umfpack.jl

Lines changed: 11 additions & 11 deletions
Original file line numberDiff line numberDiff line change
@@ -47,25 +47,25 @@
4747

4848
@test A'*x b
4949
z = complex.(b)
50-
x = SuiteSparse.ldiv!(Adjoint(lua), z)
50+
x = SuiteSparse.ldiv!(adjoint(lua), z)
5151
@test x float([1:5;])
5252
@test x === z
5353
y = similar(x)
54-
SuiteSparse.ldiv!(y, Adjoint(lua), complex.(b))
54+
SuiteSparse.ldiv!(y, adjoint(lua), complex.(b))
5555
@test y x
5656

5757
@test A'*x b
58-
x = Transpose(lua) \ b
58+
x = transpose(lua) \ b
5959
@test x float([1:5;])
6060

61-
@test Transpose(A) * x b
62-
x = SuiteSparse.ldiv!(Transpose(lua), complex.(b))
61+
@test transpose(A) * x b
62+
x = SuiteSparse.ldiv!(transpose(lua), complex.(b))
6363
@test x float([1:5;])
6464
y = similar(x)
65-
SuiteSparse.ldiv!(y, Transpose(lua), complex.(b))
65+
SuiteSparse.ldiv!(y, transpose(lua), complex.(b))
6666
@test y x
6767

68-
@test Transpose(A) * x b
68+
@test transpose(A) * x b
6969

7070
# Element promotion and type inference
7171
@inferred lua\fill(1, size(A, 2))
@@ -84,8 +84,8 @@
8484
@test Ac\b x
8585
b = Ac'*x
8686
@test Ac'\b x
87-
b = Transpose(Ac)*x
88-
@test Transpose(Ac)\b x
87+
b = transpose(Ac)*x
88+
@test transpose(Ac)\b x
8989
end
9090
end
9191

@@ -163,8 +163,8 @@
163163
B = complex.(rand(N, N), rand(N, N))
164164
luA, lufA = lufact(A), lufact(Array(A))
165165
@test Base.LinAlg.ldiv!(copy(X), luA, B) Base.LinAlg.ldiv!(copy(X), lufA, B)
166-
@test Base.LinAlg.ldiv!(copy(X), Adjoint(luA), B) Base.LinAlg.ldiv!(copy(X), Adjoint(lufA), B)
167-
@test Base.LinAlg.ldiv!(copy(X), Transpose(luA), B) Base.LinAlg.ldiv!(copy(X), Transpose(lufA), B)
166+
@test Base.LinAlg.ldiv!(copy(X), adjoint(luA), B) Base.LinAlg.ldiv!(copy(X), adjoint(lufA), B)
167+
@test Base.LinAlg.ldiv!(copy(X), transpose(luA), B) Base.LinAlg.ldiv!(copy(X), transpose(lufA), B)
168168
end
169169

170170
end

0 commit comments

Comments
 (0)