Skip to content

Commit c4e0e30

Browse files
committed
Some fixes after rebase
1 parent 2a84077 commit c4e0e30

File tree

5 files changed

+7
-7
lines changed

5 files changed

+7
-7
lines changed

base/linalg/tridiag.jl

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -214,7 +214,7 @@ eigmax(A::SymTridiagonal) = eigvals(A, size(A, 1):size(A, 1))[1]
214214
eigmin(A::SymTridiagonal) = eigvals(A, 1:1)[1]
215215

216216
#Compute selected eigenvectors only corresponding to particular eigenvalues
217-
eigvecs(A::SymTridiagonal) = eigfact(A)[:vectors]
217+
eigvecs(A::SymTridiagonal) = eigfact(A).vectors
218218

219219
"""
220220
eigvecs(A::SymTridiagonal[, eigvals]) -> Matrix

test/linalg/cholesky.jl

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -223,7 +223,7 @@ end
223223
F = cholfact(Hermitian(AcA, uplo))
224224
G = cholfact(Hermitian(BcB, uplo))
225225
@test Base.getproperty(LinAlg.lowrankupdate(F, v), uplo) Base.getproperty(G, uplo)
226-
@test_throws DimensionMismatch LinAlg.lowrankupdate(F, ones(eltype($v), length($v)+1))
226+
@test_throws DimensionMismatch LinAlg.lowrankupdate(F, ones(eltype(v), length(v)+1))
227227
@test Base.getproperty(LinAlg.lowrankdowndate(G, v), uplo) Base.getproperty(F, uplo)
228228
@test_throws DimensionMismatch LinAlg.lowrankdowndate(G, ones(eltype(v), length(v)+1))
229229
end

test/linalg/lq.jl

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -53,7 +53,7 @@ rectangularQ(Q::LinAlg.LQPackedQ) = convert(Array, Q)
5353
@test size(lqa,3) == 1
5454
@test size(lqa.Q,3) == 1
5555
@test_throws ErrorException lqa.Z
56-
@test Array(lqa') a'
56+
@test Array(adjoint(lqa)) a'
5757
@test lqa * lqa' a * a'
5858
@test lqa' * lqa a' * a
5959
@test q*squareQ(q)' Matrix(I, n, n)

test/linalg/qr.jl

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -135,7 +135,7 @@ rectangularQ(Q::LinAlg.AbstractQ) = convert(Array, Q)
135135
a = raw_a
136136
qrpa = factorize(a[:,1:n1])
137137
q, r = qrpa.Q, qrpa.R
138-
@test mul!(squareQ(q)', q) Matrix(I, n, n)
138+
@test mul!(adjoint(squareQ(q)), q) Matrix(I, n, n)
139139
@test_throws DimensionMismatch mul!(Matrix{eltya}(I, n+1, n+1),q)
140140
@test mul!(squareQ(q), Adjoint(q)) Matrix(I, n, n)
141141
@test_throws DimensionMismatch mul!(Matrix{eltya}(I, n+1, n+1), Adjoint(q))
@@ -145,7 +145,7 @@ rectangularQ(Q::LinAlg.AbstractQ) = convert(Array, Q)
145145

146146
qra = qrfact(a[:,1:n1], Val(false))
147147
q, r = qra.Q, qra.R
148-
@test mul!(squareQ(q)', q) Matrix(I, n, n)
148+
@test mul!(adjoint(squareQ(q)), q) Matrix(I, n, n)
149149
@test_throws DimensionMismatch mul!(Matrix{eltya}(I, n+1, n+1),q)
150150
@test mul!(squareQ(q), Adjoint(q)) Matrix(I, n, n)
151151
@test_throws DimensionMismatch mul!(Matrix{eltya}(I, n+1, n+1),Adjoint(q))

test/linalg/triangular.jl

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -421,7 +421,7 @@ for eltya in (Float32, Float64, ComplexF32, ComplexF64, BigFloat, Int)
421421
debug && println("\ntype of A: ", eltya, " type of b: ", eltyb, "\n")
422422

423423
debug && println("Solve upper triangular system")
424-
Atri = UpperTriangular(lufact(A)[:U]) |> t -> eltya <: Complex && eltyb <: Real ? real(t) : t # Here the triangular matrix can't be too badly conditioned
424+
Atri = UpperTriangular(lufact(A).U) |> t -> eltya <: Complex && eltyb <: Real ? real(t) : t # Here the triangular matrix can't be too badly conditioned
425425
b = convert(Matrix{eltyb}, eltya <: Complex ? Matrix(Atri)*ones(n, 2) : Matrix(Atri)*ones(n, 2))
426426
x = Matrix(Atri) \ b
427427

@@ -449,7 +449,7 @@ for eltya in (Float32, Float64, ComplexF32, ComplexF64, BigFloat, Int)
449449
end
450450

451451
debug && println("Solve lower triangular system")
452-
Atri = UpperTriangular(lufact(A)[:U]) |> t -> eltya <: Complex && eltyb <: Real ? real(t) : t # Here the triangular matrix can't be too badly conditioned
452+
Atri = UpperTriangular(lufact(A).U) |> t -> eltya <: Complex && eltyb <: Real ? real(t) : t # Here the triangular matrix can't be too badly conditioned
453453
b = convert(Matrix{eltyb}, eltya <: Complex ? Matrix(Atri)*ones(n, 2) : Matrix(Atri)*ones(n, 2))
454454
x = Matrix(Atri)\b
455455

0 commit comments

Comments
 (0)