Skip to content
Merged
Show file tree
Hide file tree
Changes from 25 commits
Commits
File filter

Filter by extension

Filter by extension


Conversations
Failed to load comments.
Loading
Jump to
Jump to file
Failed to load files.
Loading
Diff view
Diff view
14 changes: 14 additions & 0 deletions .github/workflows/IntegrationTestRequest.yml
Original file line number Diff line number Diff line change
@@ -0,0 +1,14 @@
name: "Integration Test Request"

on:
issue_comment:
types: [created]

jobs:
integrationrequest:
if: |
github.event.issue.pull_request &&
contains(fromJSON('["OWNER", "COLLABORATOR", "MEMBER"]'), github.event.comment.author_association)
uses: ITensor/ITensorActions/.github/workflows/IntegrationTestRequest.yml@main
with:
localregistry: https://github.com/ITensor/ITensorRegistry.git
4 changes: 3 additions & 1 deletion Project.toml
Original file line number Diff line number Diff line change
@@ -1,13 +1,14 @@
name = "TensorAlgebra"
uuid = "68bd88dc-f39d-4e12-b2ca-f046b68fcc6a"
authors = ["ITensor developers <[email protected]> and contributors"]
version = "0.2.2"
version = "0.2.3"

[deps]
ArrayLayouts = "4c555306-a7a7-4459-81d9-ec55ddd5c99a"
BlockArrays = "8e7c35d0-a365-5155-bbbb-fb81a777f24e"
EllipsisNotation = "da5c29d0-fa7d-589e-88eb-ea29b0a81949"
LinearAlgebra = "37e2e46d-f89d-539d-b4ee-838fcccc9c8e"
MatrixAlgebraKit = "6c742aac-3347-4629-af66-fc926824e5e4"
TupleTools = "9d95972d-f1c8-5527-a6e0-b4b365fa01f6"
TypeParameterAccessors = "7e5a90cf-f82e-492e-a09b-e3e26432c138"

Expand All @@ -23,6 +24,7 @@ BlockArrays = "1.2.0"
EllipsisNotation = "1.8.0"
GradedUnitRanges = "0.1.0"
LinearAlgebra = "1.10"
MatrixAlgebraKit = "0.1.1"
TupleTools = "1.6.0"
TypeParameterAccessors = "0.2.1, 0.3"
julia = "1.10"
2 changes: 1 addition & 1 deletion docs/make.jl
Original file line number Diff line number Diff line change
Expand Up @@ -14,7 +14,7 @@ makedocs(;
edit_link="main",
assets=String[],
),
pages=["Home" => "index.md"],
pages=["Home" => "index.md", "Reference" => "reference.md"],
)

deploydocs(;
Expand Down
5 changes: 5 additions & 0 deletions docs/src/reference.md
Original file line number Diff line number Diff line change
@@ -0,0 +1,5 @@
# Reference

```@autodocs
Modules = [TensorAlgebra]
```
2 changes: 1 addition & 1 deletion src/TensorAlgebra.jl
Original file line number Diff line number Diff line change
@@ -1,6 +1,6 @@
module TensorAlgebra

export contract, contract!
export contract, contract!, eigen, eigvals, lq, left_null, qr, right_null, svd, svdvals

include("blockedtuple.jl")
include("blockedpermutation.jl")
Expand Down
330 changes: 286 additions & 44 deletions src/factorizations.jl
Original file line number Diff line number Diff line change
@@ -1,45 +1,287 @@
using ArrayLayouts: LayoutMatrix
using LinearAlgebra: LinearAlgebra, Diagonal

function qr(a::AbstractArray, biperm::BlockedPermutation{2})
a_matricized = fusedims(a, biperm)
# TODO: Make this more generic, allow choosing thin or full,
# make sure this works on GPU.
q_fact, r_matricized = LinearAlgebra.qr(a_matricized)
q_matricized = typeof(a_matricized)(q_fact)
axes_codomain, axes_domain = blockpermute(axes(a), biperm)
axes_q = (axes_codomain..., axes(q_matricized, 2))
axes_r = (axes(r_matricized, 1), axes_domain...)
q = splitdims(q_matricized, axes_q)
r = splitdims(r_matricized, axes_r)
return q, r
end

function qr(a::AbstractArray, labels_a, labels_codomain, labels_domain)
# TODO: Generalize to conversion to `Tuple` isn't needed.
return qr(
a, blockedperm_indexin(Tuple(labels_a), Tuple(labels_codomain), Tuple(labels_domain))
)
end

function svd(a::AbstractArray, biperm::BlockedPermutation{2})
a_matricized = fusedims(a, biperm)
usv_matricized = LinearAlgebra.svd(a_matricized)
u_matricized = usv_matricized.U
s_diag = usv_matricized.S
v_matricized = usv_matricized.Vt
axes_codomain, axes_domain = blockpermute(axes(a), biperm)
axes_u = (axes_codomain..., axes(u_matricized, 2))
axes_v = (axes(v_matricized, 1), axes_domain...)
u = splitdims(u_matricized, axes_u)
# TODO: Use `DiagonalArrays.diagonal` to make it more general.
s = Diagonal(s_diag)
v = splitdims(v_matricized, axes_v)
return u, s, v
end

function svd(a::AbstractArray, labels_a, labels_codomain, labels_domain)
return svd(
a, blockedperm_indexin(Tuple(labels_a), Tuple(labels_codomain), Tuple(labels_domain))
)
using MatrixAlgebraKit:
eig_full!,
eig_trunc!,
eig_vals!,
eigh_full!,
eigh_trunc!,
eigh_vals!,
left_null!,
lq_full!,
lq_compact!,
qr_full!,
qr_compact!,
right_null!,
svd_full!,
svd_compact!,
svd_trunc!,
svd_vals!
using LinearAlgebra: LinearAlgebra

"""
qr(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...) -> Q, R
qr(A::AbstractArray, biperm::BlockedPermutation{2}; kwargs...) -> Q, R
Compute the QR decomposition of a generic N-dimensional array, by interpreting it as
a linear map from the domain to the codomain indices. These can be specified either via
their labels, or directly through a `biperm`.
## Keyword arguments
- `full::Bool=false`: select between a "full" or a "compact" decomposition, where `Q` is unitary or `R` is square, respectively.
- `positive::Bool=false`: specify if the diagonal of `R` should be positive, leading to a unique decomposition.
- Other keywords are passed on directly to MatrixAlgebraKit.
See also `MatrixAlgebraKit.qr_full!` and `MatrixAlgebraKit.qr_compact!`.
"""
function qr(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...)
biperm = blockedperm_indexin(Tuple.((labels_A, labels_codomain, labels_domain))...)
return qr(A, biperm; kwargs...)
end
function qr(A::AbstractArray, biperm::BlockedPermutation{2}; full::Bool=false, kwargs...)
# tensor to matrix
A_mat = fusedims(A, biperm)

# factorization
Q, R = full ? qr_full!(A_mat; kwargs...) : qr_compact!(A_mat; kwargs...)

# matrix to tensor
axes_codomain, axes_domain = blockpermute(axes(A), biperm)
axes_Q = (axes_codomain..., axes(Q, 2))
axes_R = (axes(R, 1), axes_domain...)
return splitdims(Q, axes_Q), splitdims(R, axes_R)
end

"""
lq(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...) -> L, Q
lq(A::AbstractArray, biperm::BlockedPermutation{2}; kwargs...) -> L, Q
Compute the LQ decomposition of a generic N-dimensional array, by interpreting it as
a linear map from the domain to the codomain indices. These can be specified either via
their labels, or directly through a `biperm`.
## Keyword arguments
- `full::Bool=false`: select between a "full" or a "compact" decomposition, where `Q` is unitary or `L` is square, respectively.
- `positive::Bool=false`: specify if the diagonal of `L` should be positive, leading to a unique decomposition.
- Other keywords are passed on directly to MatrixAlgebraKit.
See also `MatrixAlgebraKit.lq_full!` and `MatrixAlgebraKit.lq_compact!`.
"""
function lq(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...)
biperm = blockedperm_indexin(Tuple.((labels_A, labels_codomain, labels_domain))...)
return lq(A, biperm; kwargs...)
end
function lq(A::AbstractArray, biperm::BlockedPermutation{2}; full::Bool=false, kwargs...)
# tensor to matrix
A_mat = fusedims(A, biperm)

# factorization
L, Q = full ? lq_full!(A_mat; kwargs...) : lq_compact!(A_mat; kwargs...)

# matrix to tensor
axes_codomain, axes_domain = blockpermute(axes(A), biperm)
axes_L = (axes_codomain..., axes(L, ndims(L)))
axes_Q = (axes(Q, 1), axes_domain...)
return splitdims(L, axes_L), splitdims(Q, axes_Q)
end

# TODO: what name do we want?
"""
eigen(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...) -> D, V
eigen(A::AbstractArray, biperm::BlockedPermutation{2}; kwargs...) -> D, V
Compute the eigenvalue decomposition of a generic N-dimensional array, by interpreting it as
a linear map from the domain to the codomain indices. These can be specified either via
their labels, or directly through a `biperm`.
## Keyword arguments
- `ishermitian::Bool`: specify if the matrix is Hermitian, which can be used to speed up the
computation. If `false`, the output `eltype` will always be `<:Complex`.
- `trunc`: Truncation keywords for `eig(h)_trunc`.
- Other keywords are passed on directly to MatrixAlgebraKit.
See also `MatrixAlgebraKit.eig_full!`, `MatrixAlgebraKit.eig_trunc!`, `MatrixAlgebraKit.eig_vals!`,
`MatrixAlgebraKit.eigh_full!`, `MatrixAlgebraKit.eigh_trunc!`, and `MatrixAlgebraKit.eigh_vals!`.
"""
function eigen(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...)
biperm = blockedperm_indexin(Tuple.((labels_A, labels_codomain, labels_domain))...)
return eigen(A, biperm; kwargs...)
end
function eigen(
A::AbstractArray,
biperm::BlockedPermutation{2};
trunc=nothing,
ishermitian=nothing,
kwargs...,
)
# tensor to matrix
A_mat = fusedims(A, biperm)

ishermitian = @something ishermitian LinearAlgebra.ishermitian(A_mat)

# factorization
if !isnothing(trunc)
D, V = (ishermitian ? eigh_trunc! : eig_trunc!)(A_mat; trunc, kwargs...)

Check warning on line 125 in src/factorizations.jl

View check run for this annotation

Codecov / codecov/patch

src/factorizations.jl#L125

Added line #L125 was not covered by tests
else
D, V = (ishermitian ? eigh_full! : eig_full!)(A_mat; kwargs...)
end

# matrix to tensor
axes_codomain, = blockpermute(axes(A), biperm)
axes_V = (axes_codomain..., axes(V, ndims(V)))
return D, splitdims(V, axes_V)
end

"""
eigvals(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...) -> D
eigvals(A::AbstractArray, biperm::BlockedPermutation{2}; kwargs...) -> D
Compute the eigenvalues of a generic N-dimensional array, by interpreting it as
a linear map from the domain to the codomain indices. These can be specified either via
their labels, or directly through a `biperm`. The output is a vector of eigenvalues.
## Keyword arguments
- `ishermitian::Bool`: specify if the matrix is Hermitian, which can be used to speed up the
computation. If `false`, the output `eltype` will always be `<:Complex`.
- Other keywords are passed on directly to MatrixAlgebraKit.
See also `MatrixAlgebraKit.eig_vals!` and `MatrixAlgebraKit.eigh_vals!`.
"""
function eigvals(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...)
biperm = blockedperm_indexin(Tuple.((labels_A, labels_codomain, labels_domain))...)
return eigvals(A, biperm; kwargs...)
end
function eigvals(
A::AbstractArray, biperm::BlockedPermutation{2}; ishermitian=nothing, kwargs...
)
A_mat = fusedims(A, biperm)
ishermitian = @something ishermitian LinearAlgebra.ishermitian(A_mat)
return (ishermitian ? eigh_vals! : eig_vals!)(A_mat; kwargs...)
end

# TODO: separate out the algorithm selection step from the implementation
"""
svd(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...) -> U, S, Vᴴ
svd(A::AbstractArray, biperm::BlockedPermutation{2}; kwargs...) -> U, S, Vᴴ
Compute the SVD decomposition of a generic N-dimensional array, by interpreting it as
a linear map from the domain to the codomain indices. These can be specified either via
their labels, or directly through a `biperm`.
## Keyword arguments
- `full::Bool=false`: select between a "thick" or a "thin" decomposition, where both `U` and `Vᴴ`
are unitary or isometric.
- `trunc`: Truncation keywords for `svd_trunc`. Not compatible with `full=true`.
- Other keywords are passed on directly to MatrixAlgebraKit.
See also `MatrixAlgebraKit.svd_full!`, `MatrixAlgebraKit.svd_compact!`, and `MatrixAlgebraKit.svd_trunc!`.
"""
function svd(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...)
biperm = blockedperm_indexin(Tuple.((labels_A, labels_codomain, labels_domain))...)
return svd(A, biperm; kwargs...)
end
function svd(
A::AbstractArray,
biperm::BlockedPermutation{2};
full::Bool=false,
trunc=nothing,
kwargs...,
)
# tensor to matrix
A_mat = fusedims(A, biperm)

# factorization
if !isnothing(trunc)
@assert !full "Specified both full and truncation, currently not supported"
U, S, Vᴴ = svd_trunc!(A_mat; trunc, kwargs...)
else
U, S, Vᴴ = full ? svd_full!(A_mat; kwargs...) : svd_compact!(A_mat; kwargs...)
end

# matrix to tensor
axes_codomain, axes_domain = blockpermute(axes(A), biperm)
axes_U = (axes_codomain..., axes(U, 2))
axes_Vᴴ = (axes(Vᴴ, 1), axes_domain...)
return splitdims(U, axes_U), S, splitdims(Vᴴ, axes_Vᴴ)
end

"""
svdvals(A::AbstractArray, labels_A, labels_codomain, labels_domain) -> S
svdvals(A::AbstractArray, biperm::BlockedPermutation{2}) -> S
Compute the singular values of a generic N-dimensional array, by interpreting it as
a linear map from the domain to the codomain indices. These can be specified either via
their labels, or directly through a `biperm`. The output is a vector of singular values.
See also `MatrixAlgebraKit.svd_vals!`.
"""
function svdvals(A::AbstractArray, labels_A, labels_codomain, labels_domain)
biperm = blockedperm_indexin(Tuple.((labels_A, labels_codomain, labels_domain))...)
return svdvals(A, biperm)
end
function svdvals(A::AbstractArray, biperm::BlockedPermutation{2})
A_mat = fusedims(A, biperm)
return svd_vals!(A_mat)
end

"""
left_null(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...) -> N
left_null(A::AbstractArray, biperm::BlockedPermutation{2}; kwargs...) -> N
Compute the left nullspace of a generic N-dimensional array, by interpreting it as
a linear map from the domain to the codomain indices. These can be specified either via
their labels, or directly through a `biperm`.
The output satisfies `N' * A ≈ 0` and `N' * N ≈ I`.
## Keyword arguments
- `atol::Real=0`: absolute tolerance for the nullspace computation.
- `rtol::Real=0`: relative tolerance for the nullspace computation.
- `kind::Symbol`: specify the kind of decomposition used to compute the nullspace.
The options are `:qr`, `:qrpos` and `:svd`. The former two require `0 == atol == rtol`.
The default is `:qrpos` if `atol == rtol == 0`, and `:svd` otherwise.
"""
function left_null(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...)
biperm = blockedperm_indexin(Tuple.((labels_A, labels_codomain, labels_domain))...)
return left_null(A, biperm; kwargs...)
end
function left_null(A::AbstractArray, biperm::BlockedPermutation{2}; kwargs...)
A_mat = fusedims(A, biperm)
N = left_null!(A_mat; kwargs...)
axes_codomain, _ = blockpermute(axes(A), biperm)
axes_N = (axes_codomain..., axes(N, 2))
N_tensor = splitdims(N, axes_N)
return N_tensor
end

"""
right_null(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...) -> Nᴴ
right_null(A::AbstractArray, biperm::BlockedPermutation{2}; kwargs...) -> Nᴴ
Compute the right nullspace of a generic N-dimensional array, by interpreting it as
a linear map from the domain to the codomain indices. These can be specified either via
their labels, or directly through a `biperm`.
The output satisfies `A * Nᴴ' ≈ 0` and `Nᴴ * Nᴴ' ≈ I`.
## Keyword arguments
- `atol::Real=0`: absolute tolerance for the nullspace computation.
- `rtol::Real=0`: relative tolerance for the nullspace computation.
- `kind::Symbol`: specify the kind of decomposition used to compute the nullspace.
The options are `:lq`, `:lqpos` and `:svd`. The former two require `0 == atol == rtol`.
The default is `:lqpos` if `atol == rtol == 0`, and `:svd` otherwise.
"""
function right_null(A::AbstractArray, labels_A, labels_codomain, labels_domain; kwargs...)
biperm = blockedperm_indexin(Tuple.((labels_A, labels_codomain, labels_domain))...)
return right_null(A, biperm; kwargs...)
end
function right_null(A::AbstractArray, biperm::BlockedPermutation{2}; kwargs...)
A_mat = fusedims(A, biperm)
Nᴴ = right_null!(A_mat; kwargs...)
_, axes_domain = blockpermute(axes(A), biperm)
axes_Nᴴ = (axes(Nᴴ, 1), axes_domain...)
return splitdims(Nᴴ, axes_Nᴴ)
end
Loading
Loading