Skip to content

Commit 0c8b5e7

Browse files
committed
deprecate convert-to-construct fallback
1 parent 6b7c895 commit 0c8b5e7

34 files changed

+341
-370
lines changed

NEWS.md

+4
Original file line numberDiff line numberDiff line change
@@ -17,6 +17,10 @@ Language changes
1717
* The syntax for parametric methods, `function f{T}(x::T)`, has been
1818
changed to `function f(x::T) where {T}` ([#11310]).
1919

20+
* The fallback constructor that calls `convert` is deprecated. Instead, new types should
21+
prefer to define constructors, and add `convert` methods that call those constructors
22+
only as necessary ([#15120]).
23+
2024
* The syntax `1.+2` is deprecated, since it is ambiguous: it could mean either
2125
`1 .+ 2` (the current meaning) or `1. + 2` ([#19089]).
2226

base/abstractarray.jl

+3-8
Original file line numberDiff line numberDiff line change
@@ -11,6 +11,9 @@ Supertype for `N`-dimensional arrays (or array-like types) with elements of type
1111
"""
1212
AbstractArray
1313

14+
convert(::Type{T}, a::T) where {T<:AbstractArray} = a
15+
convert(::Type{T}, a::AbstractArray) where {T<:AbstractArray} = T(a)
16+
1417
"""
1518
size(A::AbstractArray, [dim...])
1619
@@ -839,14 +842,6 @@ isempty(a::AbstractArray) = (_length(a) == 0)
839842
# keys with an IndexStyle
840843
keys(s::IndexStyle, A::AbstractArray, B::AbstractArray...) = eachindex(s, A, B...)
841844

842-
## Conversions ##
843-
844-
convert(::Type{AbstractArray{T,N}}, A::AbstractArray{T,N}) where {T,N } = A
845-
convert(::Type{AbstractArray{T,N}}, A::AbstractArray{S,N}) where {T,S,N} = copy!(similar(A,T), A)
846-
convert(::Type{AbstractArray{T}}, A::AbstractArray{S,N}) where {T,S,N} = convert(AbstractArray{T,N}, A)
847-
848-
convert(::Type{Array}, A::AbstractArray{T,N}) where {T,N} = convert(Array{T,N}, A)
849-
850845
"""
851846
of_indices(x, y)
852847

base/array.jl

+5-12
Original file line numberDiff line numberDiff line change
@@ -549,22 +549,15 @@ end
549549
one(x::AbstractMatrix{T}) where {T} = _one(one(T), x)
550550
oneunit(x::AbstractMatrix{T}) where {T} = _one(oneunit(T), x)
551551

552-
## Conversions ##
553-
554-
convert(::Type{Vector}, x::AbstractVector{T}) where {T} = convert(Vector{T}, x)
555-
convert(::Type{Matrix}, x::AbstractMatrix{T}) where {T} = convert(Matrix{T}, x)
556-
557-
convert(::Type{Array{T}}, x::Array{T,n}) where {T,n} = x
558-
convert(::Type{Array{T,n}}, x::Array{T,n}) where {T,n} = x
559-
560-
convert(::Type{Array{T}}, x::AbstractArray{S,n}) where {T,n,S} = convert(Array{T,n}, x)
561-
convert(::Type{Array{T,n}}, x::AbstractArray{S,n}) where {T,n,S} = copy!(Array{T,n}(size(x)), x)
562-
563552
promote_rule(a::Type{Array{T,n}}, b::Type{Array{S,n}}) where {T,n,S} = el_same(promote_type(T,S), a, b)
564553

565-
# constructors should make copies
554+
## Constructors ##
566555

567556
if module_name(@__MODULE__) === :Base # avoid method overwrite
557+
Array{T,N}(x::AbstractArray{S,N}) where {T,N,S} = copy!(Array{T,N}(size(x)), x)
558+
AbstractArray{T,N}(A::AbstractArray{S,N}) where {T,N,S} = copy!(similar(A,T), A)
559+
560+
# constructors should make copies
568561
(::Type{T})(x::T) where {T<:Array} = copy(x)
569562
end
570563

base/bitarray.jl

+8-15
Original file line numberDiff line numberDiff line change
@@ -497,21 +497,21 @@ function _bitreshape(B::BitArray, dims::NTuple{N,Int}) where N
497497
return Br
498498
end
499499

500-
## Conversions ##
500+
## Constructors ##
501501

502-
convert(::Type{Array{T}}, B::BitArray{N}) where {T,N} = convert(Array{T,N}, B)
503-
convert(::Type{Array{T,N}}, B::BitArray{N}) where {T,N} = _convert(Array{T,N}, B) # see #15801
504-
function _convert(::Type{Array{T,N}}, B::BitArray{N}) where {T,N}
505-
A = Array{T}(size(B))
502+
#convert(::Type{Array{T}}, B::BitArray{N}) where {T,N} = convert(Array{T,N}, B)
503+
#convert(::Type{Array{T,N}}, B::BitArray{N}) where {T,N} = _convert(Array{T,N}, B) # see #15801
504+
function Array{T,N}(B::BitArray{N}) where {T,N}
505+
A = Array{T,N}(size(B))
506506
Bc = B.chunks
507507
@inbounds for i = 1:length(A)
508508
A[i] = unsafe_bitgetindex(Bc, i)
509509
end
510510
return A
511511
end
512512

513-
convert(::Type{BitArray}, A::AbstractArray{T,N}) where {T,N} = convert(BitArray{N}, A)
514-
function convert(::Type{BitArray{N}}, A::AbstractArray{T,N}) where N where T
513+
BitArray(A::AbstractArray{<:Any,N}) where {N} = BitArray{N}(A)
514+
function BitArray{N}(A::AbstractArray{T,N}) where N where T
515515
B = BitArray(size(A))
516516
Bc = B.chunks
517517
l = length(B)
@@ -536,7 +536,7 @@ function convert(::Type{BitArray{N}}, A::AbstractArray{T,N}) where N where T
536536
return B
537537
end
538538

539-
function convert(::Type{BitArray{N}}, A::Array{Bool,N}) where N
539+
function BitArray{N}(A::Array{Bool,N}) where N
540540
B = BitArray(size(A))
541541
Bc = B.chunks
542542
l = length(B)
@@ -545,16 +545,9 @@ function convert(::Type{BitArray{N}}, A::Array{Bool,N}) where N
545545
return B
546546
end
547547

548-
convert(::Type{BitArray{N}}, B::BitArray{N}) where {N} = B
549-
convert(::Type{AbstractArray{T,N}}, B::BitArray{N}) where {T,N} = convert(Array{T,N}, B)
550-
551548
reinterpret(::Type{Bool}, B::BitArray, dims::NTuple{N,Int}) where {N} = reinterpret(B, dims)
552549
reinterpret(B::BitArray, dims::NTuple{N,Int}) where {N} = reshape(B, dims)
553550

554-
## Constructors from generic iterables ##
555-
556-
BitArray(A::AbstractArray{<:Any,N}) where {N} = convert(BitArray{N}, A)
557-
558551
if module_name(@__MODULE__) === :Base # avoid method overwrite
559552
(::Type{T})(x::T) where {T<:BitArray} = copy(x)
560553
end

base/boot.jl

+7
Original file line numberDiff line numberDiff line change
@@ -382,6 +382,13 @@ Array{T}(m::Int, n::Int, o::Int) where {T} = Array{T,3}(m, n, o)
382382

383383
Array{T,1}() where {T} = Array{T,1}(0)
384384

385+
(::Type{Array{T,N} where T})(x::AbstractArray{S,N}) where {S,N} = Array{S,N}(x)
386+
387+
Array(A::AbstractArray{T,N}) where {T,N} = Array{T,N}(A)
388+
Array{T}(A::AbstractArray{S,N}) where {T,N,S} = Array{T,N}(A)
389+
390+
AbstractArray{T}(A::AbstractArray{S,N}) where {T,S,N} = AbstractArray{T,N}(A)
391+
385392
# primitive Symbol constructors
386393
function Symbol(s::String)
387394
return ccall(:jl_symbol_n, Ref{Symbol}, (Ptr{UInt8}, Int),

base/dates/periods.jl

+9-6
Original file line numberDiff line numberDiff line change
@@ -403,6 +403,9 @@ function divexact(x, y)
403403
return q
404404
end
405405

406+
convert(::Type{T}, p::T) where {T<:Period} = p
407+
convert(::Type{T}, p::Period) where {T<:Period} = T(p)
408+
406409
# FixedPeriod conversions and promotion rules
407410
const fixedperiod_conversions = [(Week, 7), (Day, 24), (Hour, 60), (Minute, 60), (Second, 1000), (Millisecond, 1000), (Microsecond, 1000), (Nanosecond, 1)]
408411
for i = 1:length(fixedperiod_conversions)
@@ -413,15 +416,15 @@ for i = 1:length(fixedperiod_conversions)
413416
N *= nc
414417
vmax = typemax(Int64) ÷ N
415418
vmin = typemin(Int64) ÷ N
416-
@eval function Base.convert(::Type{$T}, x::$Tc)
417-
$vmin value(x) $vmax || throw(InexactError(:convert, $T, x))
419+
@eval function $T(x::$Tc)
420+
$vmin value(x) $vmax || throw(InexactError(($T).name.name, x))
418421
return $T(value(x) * $N)
419422
end
420423
end
421424
N = n
422425
for j = (i + 1):length(fixedperiod_conversions) # more-precise periods
423426
Tc, nc = fixedperiod_conversions[j]
424-
@eval Base.convert(::Type{$T}, x::$Tc) = $T(divexact(value(x), $N))
427+
@eval $T(x::$Tc) = $T(divexact(value(x), $N))
425428
@eval Base.promote_rule(::Type{$T}, ::Type{$Tc}) = $Tc
426429
N *= nc
427430
end
@@ -430,12 +433,12 @@ end
430433
# other periods with fixed conversions but which aren't fixed time periods
431434
const OtherPeriod = Union{Month, Year}
432435
let vmax = typemax(Int64) ÷ 12, vmin = typemin(Int64) ÷ 12
433-
@eval function Base.convert(::Type{Month}, x::Year)
434-
$vmin value(x) $vmax || throw(InexactError(:convert, Month, x))
436+
@eval function Month(x::Year)
437+
$vmin value(x) $vmax || throw(InexactError(:Month, x))
435438
Month(value(x) * 12)
436439
end
437440
end
438-
Base.convert(::Type{Year}, x::Month) = Year(divexact(value(x), 12))
441+
Year(x::Month) = Year(divexact(value(x), 12))
439442
Base.promote_rule(::Type{Year}, ::Type{Month}) = Month
440443

441444
# disallow comparing fixed to other periods

base/deprecated.jl

+5
Original file line numberDiff line numberDiff line change
@@ -1751,6 +1751,11 @@ import .Iterators.enumerate
17511751
@deprecate enumerate(i::IndexLinear, A::AbstractArray) pairs(i, A)
17521752
@deprecate enumerate(i::IndexCartesian, A::AbstractArray) pairs(i, A)
17531753

1754+
function (::Type{T})(arg) where {T}
1755+
depwarn("Constructors no longer fall back to `convert`. A constructor for `$T` should be defined instead.", :Type)
1756+
convert(T, arg)::T
1757+
end
1758+
17541759
# END 0.7 deprecations
17551760

17561761
# BEGIN 1.0 deprecations

base/linalg/bidiag.jl

+9-9
Original file line numberDiff line numberDiff line change
@@ -131,7 +131,7 @@ function Base.replace_in_print_matrix(A::Bidiagonal,i::Integer,j::Integer,s::Abs
131131
end
132132

133133
#Converting from Bidiagonal to dense Matrix
134-
function convert(::Type{Matrix{T}}, A::Bidiagonal) where T
134+
function Matrix{T}(A::Bidiagonal) where T
135135
n = size(A, 1)
136136
B = zeros(T, n, n)
137137
for i = 1:n - 1
@@ -145,14 +145,14 @@ function convert(::Type{Matrix{T}}, A::Bidiagonal) where T
145145
B[n,n] = A.dv[n]
146146
return B
147147
end
148-
convert(::Type{Matrix}, A::Bidiagonal{T}) where {T} = convert(Matrix{T}, A)
149-
convert(::Type{Array}, A::Bidiagonal) = convert(Matrix, A)
150-
full(A::Bidiagonal) = convert(Array, A)
148+
Matrix(A::Bidiagonal{T}) where {T} = Matrix{T}(A)
149+
Array(A::Bidiagonal) = Matrix(A)
150+
full(A::Bidiagonal) = Array(A)
151151
promote_rule(::Type{Matrix{T}}, ::Type{<:Bidiagonal{S}}) where {T,S} = Matrix{promote_type(T,S)}
152152

153153
#Converting from Bidiagonal to Tridiagonal
154-
Tridiagonal(M::Bidiagonal{T}) where {T} = convert(Tridiagonal{T}, M)
155-
function convert(::Type{Tridiagonal{T}}, A::Bidiagonal) where T
154+
Tridiagonal(M::Bidiagonal{T}) where {T} = Tridiagonal{T}(M)
155+
function Tridiagonal{T}(A::Bidiagonal) where T
156156
dv = convert(AbstractVector{T}, A.dv)
157157
ev = convert(AbstractVector{T}, A.ev)
158158
z = fill!(similar(ev), zero(T))
@@ -161,12 +161,12 @@ end
161161
promote_rule(::Type{<:Tridiagonal{T}}, ::Type{<:Bidiagonal{S}}) where {T,S} = Tridiagonal{promote_type(T,S)}
162162

163163
# No-op for trivial conversion Bidiagonal{T} -> Bidiagonal{T}
164-
convert(::Type{Bidiagonal{T}}, A::Bidiagonal{T}) where {T} = A
164+
Bidiagonal{T}(A::Bidiagonal{T}) where {T} = A
165165
# Convert Bidiagonal to Bidiagonal{T} by constructing a new instance with converted elements
166-
convert(::Type{Bidiagonal{T}}, A::Bidiagonal) where {T} =
166+
Bidiagonal{T}(A::Bidiagonal) where {T} =
167167
Bidiagonal(convert(AbstractVector{T}, A.dv), convert(AbstractVector{T}, A.ev), A.uplo)
168168
# When asked to convert Bidiagonal to AbstractMatrix{T}, preserve structure by converting to Bidiagonal{T} <: AbstractMatrix{T}
169-
convert(::Type{AbstractMatrix{T}}, A::Bidiagonal) where {T} = convert(Bidiagonal{T}, A)
169+
AbstractMatrix{T}(A::Bidiagonal) where {T} = convert(Bidiagonal{T}, A)
170170

171171
broadcast(::typeof(big), B::Bidiagonal) = Bidiagonal(big.(B.dv), big.(B.ev), B.uplo)
172172

base/linalg/cholesky.jl

+17-17
Original file line numberDiff line numberDiff line change
@@ -345,32 +345,32 @@ function cholfact(x::Number, uplo::Symbol=:U)
345345
end
346346

347347

348-
function convert(::Type{Cholesky{T}}, C::Cholesky) where T
348+
function Cholesky{T}(C::Cholesky) where T
349349
Cnew = convert(AbstractMatrix{T}, C.factors)
350350
Cholesky{T, typeof(Cnew)}(Cnew, C.uplo, C.info)
351351
end
352-
convert(::Type{Factorization{T}}, C::Cholesky{T}) where {T} = C
353-
convert(::Type{Factorization{T}}, C::Cholesky) where {T} = convert(Cholesky{T}, C)
354-
convert(::Type{CholeskyPivoted{T}},C::CholeskyPivoted{T}) where {T} = C
355-
convert(::Type{CholeskyPivoted{T}},C::CholeskyPivoted) where {T} =
352+
Factorization{T}(C::Cholesky{T}) where {T} = C
353+
Factorization{T}(C::Cholesky) where {T} = Cholesky{T}(C)
354+
CholeskyPivoted{T}(C::CholeskyPivoted{T}) where {T} = C
355+
CholeskyPivoted{T}(C::CholeskyPivoted) where {T} =
356356
CholeskyPivoted(AbstractMatrix{T}(C.factors),C.uplo,C.piv,C.rank,C.tol,C.info)
357-
convert(::Type{Factorization{T}}, C::CholeskyPivoted{T}) where {T} = C
358-
convert(::Type{Factorization{T}}, C::CholeskyPivoted) where {T} = convert(CholeskyPivoted{T}, C)
357+
Factorization{T}(C::CholeskyPivoted{T}) where {T} = C
358+
Factorization{T}(C::CholeskyPivoted) where {T} = CholeskyPivoted{T}(C)
359359

360-
convert(::Type{AbstractMatrix}, C::Cholesky) = C.uplo == 'U' ? C[:U]'C[:U] : C[:L]*C[:L]'
361-
convert(::Type{AbstractArray}, C::Cholesky) = convert(AbstractMatrix, C)
362-
convert(::Type{Matrix}, C::Cholesky) = convert(Array, convert(AbstractArray, C))
363-
convert(::Type{Array}, C::Cholesky) = convert(Matrix, C)
364-
full(C::Cholesky) = convert(AbstractArray, C)
360+
AbstractMatrix(C::Cholesky) = C.uplo == 'U' ? C[:U]'C[:U] : C[:L]*C[:L]'
361+
AbstractArray(C::Cholesky) = AbstractMatrix(C)
362+
Matrix(C::Cholesky) = Array(AbstractArray(C))
363+
Array(C::Cholesky) = Matrix(C)
364+
full(C::Cholesky) = AbstractArray(C)
365365

366-
function convert(::Type{AbstractMatrix}, F::CholeskyPivoted)
366+
function AbstractMatrix(F::CholeskyPivoted)
367367
ip = invperm(F[:p])
368368
(F[:L] * F[:U])[ip,ip]
369369
end
370-
convert(::Type{AbstractArray}, F::CholeskyPivoted) = convert(AbstractMatrix, F)
371-
convert(::Type{Matrix}, F::CholeskyPivoted) = convert(Array, convert(AbstractArray, F))
372-
convert(::Type{Array}, F::CholeskyPivoted) = convert(Matrix, F)
373-
full(F::CholeskyPivoted) = convert(AbstractArray, F)
370+
AbstractArray(F::CholeskyPivoted) = AbstractMatrix(F)
371+
Matrix(F::CholeskyPivoted) = Array(AbstractArray(F))
372+
Array(F::CholeskyPivoted) = Matrix(F)
373+
full(F::CholeskyPivoted) = AbstractArray(F)
374374

375375
copy(C::Cholesky) = Cholesky(copy(C.factors), C.uplo, C.info)
376376
copy(C::CholeskyPivoted) = CholeskyPivoted(copy(C.factors), C.uplo, C.piv, C.rank, C.tol, C.info)

base/linalg/diagonal.jl

+6-6
Original file line numberDiff line numberDiff line change
@@ -49,12 +49,12 @@ Diagonal(V::AbstractVector{T}) where {T} = Diagonal{T,typeof(V)}(V)
4949
Diagonal{T}(V::AbstractVector{T}) where {T} = Diagonal{T,typeof(V)}(V)
5050
Diagonal{T}(V::AbstractVector) where {T} = Diagonal{T}(convert(AbstractVector{T}, V))
5151

52-
convert(::Type{Diagonal{T}}, D::Diagonal{T}) where {T} = D
53-
convert(::Type{Diagonal{T}}, D::Diagonal) where {T} = Diagonal{T}(convert(AbstractVector{T}, D.diag))
54-
convert(::Type{AbstractMatrix{T}}, D::Diagonal) where {T} = convert(Diagonal{T}, D)
55-
convert(::Type{Matrix}, D::Diagonal) = diagm(D.diag)
56-
convert(::Type{Array}, D::Diagonal) = convert(Matrix, D)
57-
full(D::Diagonal) = convert(Array, D)
52+
Diagonal{T}(D::Diagonal{T}) where {T} = D
53+
Diagonal{T}(D::Diagonal) where {T} = Diagonal{T}(convert(AbstractVector{T}, D.diag))
54+
AbstractMatrix{T}(D::Diagonal) where {T} = Diagonal{T}(D)
55+
Matrix(D::Diagonal) = diagm(D.diag)
56+
Array(D::Diagonal) = Matrix(D)
57+
full(D::Diagonal) = Array(D)
5858

5959
function similar(D::Diagonal, ::Type{T}) where T
6060
return Diagonal{T}(similar(D.diag, T))

base/linalg/eigen.jl

+5-5
Original file line numberDiff line numberDiff line change
@@ -433,8 +433,8 @@ eigvecs(A::AbstractMatrix, B::AbstractMatrix) = eigvecs(eigfact(A, B))
433433
# Conversion methods
434434

435435
## Can we determine the source/result is Real? This is not stored in the type Eigen
436-
convert(::Type{AbstractMatrix}, F::Eigen) = F.vectors * Diagonal(F.values) / F.vectors
437-
convert(::Type{AbstractArray}, F::Eigen) = convert(AbstractMatrix, F)
438-
convert(::Type{Matrix}, F::Eigen) = convert(Array, convert(AbstractArray, F))
439-
convert(::Type{Array}, F::Eigen) = convert(Matrix, F)
440-
full(F::Eigen) = convert(AbstractArray, F)
436+
AbstractMatrix(F::Eigen) = F.vectors * Diagonal(F.values) / F.vectors
437+
AbstractArray(F::Eigen) = AbstractMatrix(F)
438+
Matrix(F::Eigen) = Array(AbstractArray(F))
439+
Array(F::Eigen) = Matrix(F)
440+
full(F::Eigen) = AbstractArray(F)

base/linalg/factorization.jl

+4-1
Original file line numberDiff line numberDiff line change
@@ -45,8 +45,11 @@ function det(F::Factorization)
4545
return exp(d)*s
4646
end
4747

48+
convert(::Type{T}, f::T) where {T<:Factorization} = f
49+
convert(::Type{T}, f::Factorization) where {T<:Factorization} = T(f)
50+
4851
### General promotion rules
49-
convert(::Type{Factorization{T}}, F::Factorization{T}) where {T} = F
52+
Factorization{T}(F::Factorization{T}) where {T} = F
5053
inv(F::Factorization{T}) where {T} = A_ldiv_B!(F, eye(T, size(F,1)))
5154

5255
Base.hash(F::Factorization, h::UInt) = mapreduce(f -> hash(getfield(F, f)), hash, h, 1:nfields(F))

base/linalg/givens.jl

+6-6
Original file line numberDiff line numberDiff line change
@@ -34,12 +34,12 @@ mutable struct Rotation{T} <: AbstractRotation{T}
3434
rotations::Vector{Givens{T}}
3535
end
3636

37-
convert(::Type{Givens{T}}, G::Givens{T}) where {T} = G
38-
convert(::Type{Givens{T}}, G::Givens) where {T} = Givens(G.i1, G.i2, convert(T, G.c), convert(T, G.s))
39-
convert(::Type{Rotation{T}}, R::Rotation{T}) where {T} = R
40-
convert(::Type{Rotation{T}}, R::Rotation) where {T} = Rotation{T}([convert(Givens{T}, g) for g in R.rotations])
41-
convert(::Type{AbstractRotation{T}}, G::Givens) where {T} = convert(Givens{T}, G)
42-
convert(::Type{AbstractRotation{T}}, R::Rotation) where {T} = convert(Rotation{T}, R)
37+
Givens{T}(G::Givens{T}) where {T} = G
38+
Givens{T}(G::Givens) where {T} = Givens(G.i1, G.i2, convert(T, G.c), convert(T, G.s))
39+
Rotation{T}(R::Rotation{T}) where {T} = R
40+
Rotation{T}(R::Rotation) where {T} = Rotation{T}([Givens{T}(g) for g in R.rotations])
41+
AbstractRotation{T}(G::Givens) where {T} = Givens{T}(G)
42+
AbstractRotation{T}(R::Rotation) where {T} = Rotation{T}(R)
4343

4444
adjoint(G::Givens) = Givens(G.i1, G.i2, conj(G.c), -G.s)
4545
adjoint(R::Rotation{T}) where {T} = Rotation{T}(reverse!([adjoint(r) for r in R.rotations]))

base/linalg/hessenberg.jl

+8-8
Original file line numberDiff line numberDiff line change
@@ -77,14 +77,14 @@ function getindex(A::HessenbergQ, i::Integer, j::Integer)
7777
end
7878

7979
## reconstruct the original matrix
80-
convert(::Type{Matrix}, A::HessenbergQ{<:BlasFloat}) = LAPACK.orghr!(1, size(A.factors, 1), copy(A.factors), A.τ)
81-
convert(::Type{Array}, A::HessenbergQ) = convert(Matrix, A)
82-
full(A::HessenbergQ) = convert(Array, A)
83-
convert(::Type{AbstractMatrix}, F::Hessenberg) = (fq = Array(F[:Q]); (fq * F[:H]) * fq')
84-
convert(::Type{AbstractArray}, F::Hessenberg) = convert(AbstractMatrix, F)
85-
convert(::Type{Matrix}, F::Hessenberg) = convert(Array, convert(AbstractArray, F))
86-
convert(::Type{Array}, F::Hessenberg) = convert(Matrix, F)
87-
full(F::Hessenberg) = convert(AbstractArray, F)
80+
Matrix(A::HessenbergQ{<:BlasFloat}) = LAPACK.orghr!(1, size(A.factors, 1), copy(A.factors), A.τ)
81+
Array(A::HessenbergQ) = Matrix(A)
82+
full(A::HessenbergQ) = Array(A)
83+
AbstractMatrix(F::Hessenberg) = (fq = Array(F[:Q]); (fq * F[:H]) * fq')
84+
AbstractArray(F::Hessenberg) = AbstractMatrix(F)
85+
Matrix(F::Hessenberg) = Array(AbstractArray(F))
86+
Array(F::Hessenberg) = Matrix(F)
87+
full(F::Hessenberg) = AbstractArray(F)
8888

8989
A_mul_B!(Q::HessenbergQ{T}, X::StridedVecOrMat{T}) where {T<:BlasFloat} =
9090
LAPACK.ormhr!('L', 'N', 1, size(Q.factors, 1), Q.factors, Q.τ, X)

0 commit comments

Comments
 (0)